diff --git a/Config b/Config new file mode 100644 index 0000000..d619a16 --- /dev/null +++ b/Config @@ -0,0 +1,181 @@ +# Configuration file for the Sedov explosion problem +# (Sedov, L. I., 1959, Similarity and Dimensional Methods +# in Mechanics [New York: Academic]) + +REQUIRES Driver +REQUIRES physics/Hydro +REQUIRES physics/Eos +REQUIRES physics/sourceTerms/PlasmaPR +#REQUIRES physics/Diffuse/DiffuseMain +#REQUIRES physics/Diffuse/DiffuseMain/Unsplit +#REQUIRES physics/materialProperties/Conductivity +#REQUIRES physics/materialProperties/Viscosity/ViscosityMain + +PPDEFINE NBOUNDARIES 18 + +IF withParticles + PARTICLETYPE active INITMETHOD lattice MAPMETHOD quadratic ADVMETHOD leapfrog + + REQUIRES Particles/ParticlesMain + REQUIRES Particles/ParticlesMain/active + REQUIRES Particles/ParticlesMain/active/massive + REQUESTS Particles/ParticlesInitialization/Lattice + REQUESTS Particles/ParticlesMapping/meshWeighting/CIC + REQUESTS Particles/ParticlesMapping/meshWeighting/MapToMesh + REQUESTS Grid/GridParticles/GridParticlesMapToMesh + REQUESTS Particles/ParticlesMain/active/massive/Leapfrog + REQUESTS IO/IOMain/ + REQUESTS IO/IOParticles +ENDIF + +LINKIF Grid_markRefineDerefine.F90 Grid/GridMain/paramesh +LINKIF gr_expandDomain.F90 Grid/GridMain/paramesh + +D sim_pAmbient Initial ambient pressure +PARAMETER sim_pAmbient REAL 1.E-5 + +D sim_rhoAmbient Initial ambient density +PARAMETER sim_rhoAmbient REAL 1. + +D sim_tempAmbient Initial ambient temperature +PARAMETER sim_tempAmbient REAL 300. + +D sim_exl Lower bound for x source +PARAMETER sim_exl REAL 0.0 + +D sim_exu Lower bound for x source +PARAMETER sim_exu REAL 0.0 + +D sim_eyl Lower bound for x source +PARAMETER sim_eyl REAL 0.0 + +D sim_eyu Lower bound for x source +PARAMETER sim_eyu REAL 0.0 + +D sim_pxl Lower bound for x source +PARAMETER sim_pxl REAL 0.0 + +D sim_pxu Lower bound for x source +PARAMETER sim_pxu REAL 0.0 + +D sim_pyl Lower bound for x source +PARAMETER sim_pyl REAL 0.0 + +D sim_pyu Lower bound for x source +PARAMETER sim_pyu REAL 0.0 + +D sim_vx Lower bound for x source +PARAMETER sim_vx REAL 0.0 + +D sim_vy Lower bound for x source +PARAMETER sim_vy REAL 0.0 + +D sim_vz Lower bound for x source +PARAMETER sim_vz REAL 0.0 + +D sim_expEnergy Explosion energy (distributed over initial explosion region) +PARAMETER sim_expEnergy REAL 1. + +D sim_minRhoInit Density floor for initial condition +PARAMETER sim_minRhoInit REAL 1.E-20 [0.0 ...] + +D sim_rInit Radius of region into which explosion energy is dumped +D & initially, used only if tinitial <= 0. +PARAMETER sim_rInit REAL 0.05 + +D sim_xctr Explosion center coordinates +PARAMETER sim_xctr REAL 0.5 + +D sim_yctr Explosion center coordinates +PARAMETER sim_yctr REAL 0.5 + +D sim_zctr Explosion center coordinates +PARAMETER sim_zctr REAL 0.5 + +D sim_nsubzones Number of `sub-zones' in cells for applying 1d profile +PARAMETER sim_nsubzones INTEGER 7 [1 ...] + +D sim_forceCenterDerefine Try to force low refinement level around explosion center? +D sim_centerRefineLevel Desired refinement level at center (if "forcing") +D sim_derefineRadius Radius of center region to force derefinement +PARAMETER sim_forceCenterDerefine BOOLEAN FALSE +PARAMETER sim_centerRefineLevel INTEGER 1 [-1, 1 ...] +PARAMETER sim_derefineRadius REAL 0.0 [0.0 ...] + +D sim_profFileName Name of file from which to read a 1D Sedov solution for the +D & initial condition. +D & The data from the file will be rescaled, and a density floor given +D & by sim_minRhoInit will be applied, to construct the initial condition. +D & This file will only be used if tinitial > 0. +PARAMETER sim_profFileName STRING "sedovSolution.dat" + +DATAFILES sedovSolution.dat +DATAFILES sedovSolutionMod*.dat + +D sim_bcSetBdryVar Whether to set the "bdry" variable in unk (if it exists) to 1 +D & in guard cells at reflecting boundaries. Doing this will entice Hydro +D & implementations to lower reconstruction order in adjacent cells, and possibly +D & lower the CFL factor applied to timestep computation as well. +PARAMETER sim_bcSetBdryVar BOOLEAN FALSE + +D sim_earliestLSTime earliest time included in Largest-{Norm,Error} summaries +D sim_latestLSTime latest time included in Largest-{Norm,Error} summaries +PARAMETER sim_earliestLSTime REAL 0.0 +PARAMETER sim_latestLSTime REAL HUGE(1.0) + +D sim_smallestNormRadius inner radius bound of region for norm computation +D sim_largestNormRadius outer radius bound of region for norm computation +PARAMETER sim_smallestNormRadius REAL 0.0 +PARAMETER sim_largestNormRadius REAL HUGE(1.0) + +D sim_oneLevelIntegralsOnly Whether to compute intgral quantities only on +D & cells at one refinement level, ignoring all finer or coarser cells +PARAMETER sim_oneLevelIntegralsOnly BOOLEAN FALSE +D sim_integralsLevel if sim_oneLevelIntegralsOnly is TRUE, this gives the +D & requested refinement level, either explicitly as a positive integer +D & or as -1 for the largest currently realized level. +PARAMETER sim_integralsLevel INTEGER -1 [-1, 1 ...] + +D nblockx num initial blocks in x dir +PARAMETER nblockx INTEGER 12 + +D nblocky num initial blocks in y dir +PARAMETER nblocky INTEGER 18 + +D nblockz num initial blocks in z dir +PARAMETER nblockz INTEGER 1 + + +# VARIABLE declarations for analytical solution from file here, +# other VARIABLES declared in Hydro etc. + +VARIABLE dena TYPE:PER_VOLUME +VARIABLE prsa +VARIABLE vlxa +VARIABLE vlya +VARIABLE vlza +VARIABLE eina +VARIABLE enra + +USESETUPVARS DoAnalytical +IF DoAnalytical + LINKIF Grid_computeUserVars.F90.analytical Simulation + LINKIF IO_writeIntegralQuantities.F90.analytical Simulation + LINKIF Simulation_computeAnalytical.F90.analytical Simulation + + #VARIABLE dend + #VARIABLE prsd + #VARIABLE vlrd + + #VARIABLE denc + #VARIABLE prsc + #VARIABLE vlrc + +ENDIF + +USESETUPVARS UseBdryVar +IF UseBdryVar + LINKIF Grid_bcApplyToRegionSpecialized.F90.bdryvar Grid + VARIABLE bdry + +ENDIF diff --git a/Driver_initSourceTerms.F90 b/Driver_initSourceTerms.F90 new file mode 100644 index 0000000..edda6b4 --- /dev/null +++ b/Driver_initSourceTerms.F90 @@ -0,0 +1,60 @@ +!!****if* source/Driver/DriverMain/Driver_initSourceTerms +!! +!! NAME +!! +!! Driver_initSourceTerms +!! +!! SYNOPSIS +!! +!! Driver_initSourceTerms(logical(in) :: restart) +!! +!! DESCRIPTION +!! +!! Initializes all source terms Units by +!! calling their respective initialization routines +!! viz. Stir_init, Burn_init, Heat_init, Cool_init, etc. +!! +!! ARGUMENTS +!! myPE - current processor number +!! restart - indicates if run is starting from scratch (.false.) +!! or restarting from checkpoint (.true.) +!! +!!*** + +subroutine Driver_initSourceTerms( restart) + + use Polytrope_interface, ONLY: Polytrope_init + use Burn_interface, ONLY: Burn_init + use Stir_interface, ONLY : Stir_init + use Heat_interface, ONLY : Heat_init + use Heatexchange_interface, ONLY : Heatexchange_init + use Cool_interface, ONLY : Cool_init + use Diffuse_interface, ONLY : Diffuse_init + use Ionize_interface, ONLY : Ionize_init + use Flame_interface, ONLY : Flame_init + use Turb_interface, ONLY : Turb_init + use RadTrans_interface, ONLY : RadTrans_init + use EnergyDeposition_interface, ONLY : EnergyDeposition_init + use Deleptonize_interface, ONLY : Deleptonize_init + use PlasmaPR_interface, ONLY : PlasmaPR_init + + implicit none + + logical, intent(in) :: restart + + call Polytrope_init() + call Stir_init( restart) + call Cool_init() + call Diffuse_init() + call Heat_init() + call Heatexchange_init( restart) + call Ionize_init() + call Burn_init() + call Turb_init() + call Flame_init() + call RadTrans_init() + call EnergyDeposition_init() + call Deleptonize_init() + call PlasmaPR_init() + +end subroutine Driver_initSourceTerms diff --git a/Driver_sourceTerms.F90 b/Driver_sourceTerms.F90 new file mode 100644 index 0000000..3745c1f --- /dev/null +++ b/Driver_sourceTerms.F90 @@ -0,0 +1,74 @@ +!!****if* source/Driver/DriverMain/Driver_sourceTerms +!! +!! NAME +!! +!! Driver_sourceTerms +!! +!! SYNOPSIS +!! +!! Driver_sourceTerms(integer(IN)::blockCount, +!! integer(IN)::blockList(blockCount), +!! real(IN) :: dt) +!! +!! DESCRIPTION +!! +!! Driver for source terms. Instead of calling all these routines +!! from Driver_evolveFlash we call Driver_sourceTerms which then +!! makes the calls to Cool, Burn, Heat and Stir. If a unit is not +!! included in the simulation, the routine will be a stub and return +!! without doing anything. +!! +!! +!! ARGUMENTS +!! blockCount : The number of blocks in the list +!! blockList : The list of blocks on which to apply the stirring operator +!! dt : the current timestep +!! +!!*** + + + +subroutine Driver_sourceTerms(blockCount, blockList, dt, pass) + + use Polytrope_interface, ONLY : Polytrope + use Driver_data, ONLY: dr_simTime + use Flame_interface, ONLY : Flame_step + use Stir_interface, ONLY : Stir + use Heat_interface, ONLY : Heat + use Heatexchange_interface, ONLY : Heatexchange + use Burn_interface, ONLY : Burn + use Cool_interface, ONLY : Cool + use Ionize_interface, ONLY : Ionize + use Flame_interface, ONLY : Flame_step + use Turb_interface, ONLY : Turb_calc + use EnergyDeposition_interface, ONLY : EnergyDeposition + use Deleptonize_interface, ONLY : Deleptonize + use PlasmaPR_interface, ONLY : PlasmaPR_calc + + implicit none + + real, intent(IN) :: dt + integer, intent(IN) :: blockCount + integer, dimension(blockCount), intent(IN):: blockList + integer, OPTIONAL, intent(IN):: pass + +#ifdef DRIVER_EDEARLY + call EnergyDeposition(blockCount, blockList, dt, dr_simTime, pass) +#endif + call Polytrope(blockCount, blockList, dt) + call Stir(blockCount, blockList, dt) + call Turb_calc(blockCount, blockList) + call Flame_step(blockCount, blockList, dt) + call Burn(blockCount, blockList, dt) + call Heat(blockCount, blockList, dt, dr_simTime) + call Heatexchange(blockCount, blockList, dt) + call Cool(blockCount, blockList, dt, dr_simTime) + call Ionize(blockCount, blockList, dt, dr_simTime) +#ifndef DRIVER_EDEARLY + call EnergyDeposition(blockCount, blockList, dt, dr_simTime, pass) +#endif + call Deleptonize(blockCount, blockList, dt, dr_simTime) + call PlasmaPR_calc(blockCount, blockList) + + return +end subroutine Driver_sourceTerms diff --git a/Grid_bcApplyToRegionSpecialized.F90.bdryvar b/Grid_bcApplyToRegionSpecialized.F90.bdryvar new file mode 100644 index 0000000..734adbb --- /dev/null +++ b/Grid_bcApplyToRegionSpecialized.F90.bdryvar @@ -0,0 +1,258 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Grid_bcApplyToRegionSpecialized +!! +!! NAME +!! Grid_bcApplyToRegionSpecialized +!! +!! SYNOPSIS +!! +!! call Grid_bcApplyToRegionSpecialized(integer(IN) :: bcType, +!! integer(IN) :: gridDataStruct, +!! integer(IN) :: guard, +!! integer(IN) :: axis, +!! integer(IN) :: face, +!! real(INOUT) :: regionData(:,:,:,:), +!! integer(IN) :: regionSize(:), +!! logical(IN) :: mask(:), +!! logical(OUT) :: applied, +!! integer(IN) :: blockHandle, +!! integer(IN) :: secondDir, +!! integer(IN) :: thirdDir, +!! integer(IN) :: endPoints(LOW:HIGH,MDIM), +!! integer(IN) :: blkLimitsGC(LOW:HIGH,MDIM), +!! OPTIONAL,integer(IN) :: idest ) +!! +!! +!! DESCRIPTION +!! +!! Applies the boundary conditions to the specified data structure. +!! The routine is handed a region that has been extracted from the +!! data structure, on which it should apply the boundary conditions. +!! The direction along which the BC are to be applied is always the first +!! dimension in the given region, and the last dimension contains the +!! the variables in the data structure. The middle two dimension contain +!! the size of the region along the two dimensions of the physical grid +!! that are not having the BC applied. +!! +!! This routine applies the boundary conditions on a given face (lowerface +!! or upperface) along a given axis, by using and setting values +!! for all variables in the gridDataStruct that are not masked out. The +!! argument "mask" has the information about the masked variables. +!! +!! Where masked(variables) +!! If (face=LOW) +!! regionData(1:guard,:,:,variables) = boundary values +!! If (face=HIGH) +!! regionData(regionSize(BC_DIR)-guard+1:regionSize(BC_DIR),:,:,variables) = boundary values +!! +!! +!! ARGUMENTS +!! +!! 1. BASIC ARGUMENTS +!! +!! bcType - the type of boundary condition being applied. +!! gridDataStruct - the Grid dataStructure, should be given as +!! one of the constants CENTER, FACEX, FACEY, FACEZ. +!! guard - number of guard cells +!! axis - the direction along which to apply boundary conditions, +!! can take values of IAXIS, JAXIS and KAXIS +!! face - can take values LOW and HIGH, defined in constants.h, +!! to indicate whether to apply boundary on lowerface or +!! upperface +!! regionData : the extracted region from a block of permanent storage of the +!! specified data structure. Its size is given by regionSize. +!! NOTE that the first three dimensions of this array do not necessarily +!! correspond to the (IAXIS, JAXIS, KAXIS) directions in this order; +!! rather, the axes are permuted such that the first index +!! of regionData always corresponds to the direction given by axis. +!! See regionSize for more information. +!! regionSize : regionSize(BC_DIR) contains the size of each row of data +!! in the regionData array. With row we mean here an array slice +!! regionData(:,I2,I3,VAR), corresponding to cells that are situated +!! along a line in the 'axis' direction. For the common case of guard=4, +!! (e.g., when gridDataStruct=CENTER) and either 8 or 9 for face- +!! centered data, depending on the direction given by axis. +!! regionSize(SECOND_DIR) contains the number of rows along the +!! second direction, and regionSize(THIRD_DIR) has the number of rows +!! along the third direction. (See also below under secondDir,thirdDir +!! for the meaning of second and third direction; and see also NOTE (1) +!! below.) +!! Finally, regionSize(GRID_DATASTRUCT) contains the +!! number of variables in the data structure. +!! mask - if present, boundary conditions are to be applied only to selected variables. +!! However, an implementation of this interface may ignore the mask argument; +!! a mask should be understood as a possible opportunity for optimization which +!! an implementation may ignore. +!! Specifying a mask does not mean that previous values of other variables in +!! guard cells will be left undisturbed. +!! applied - is set true if this routine has handled the given bcType, otherwise it is +!! set to false. +!! +!! +!! 2. ADDITIONAL ARGUMENTS +!! +!! blockHandle - Handle for the block for which guard cells are to be filled. +!! In grid implementations other than Paramesh 4, this is always +!! a local blockID. +!! +!! With Paramesh 4: +!! This may be a block actually residing on the local processor, +!! or the handle may refer to a block that belong to a remote processor +!! but for which cached information is currently available locally. +!! The two cases can be distinguished by checking whether +!! (blockHandle .LE. lnblocks): this is true only for blocks that +!! reside on the executing processor. +!! The block ID is available for passing on to some handlers for +!! boundary conditions that may need it, ignored in the default +!! implementation. +!! +!! secondDir,thirdDir - Second and third coordinate directions. +!! These are the transverse directions perpendicular to +!! the sweep direction. SecondDir and thirdDir give +!! the meaning of the second and third dimension, +!! respectively, of the regionData array. +!! This is not needed for simple boundary condition types +!! such as REFLECTING or OUTFLOW, It is provided for +!! convenience so that more complex boundary condition +!! can make use of it. +!! The values are currently fully determined by the sweep +!! direction axis as follows: +!! axis | secondDir thirdDir +!! ------------------------------------------ +!! IAXIS | JAXIS KAXIS +!! JAXIS | IAXIS KAXIS +!! KAXIS | IAXIS JAXIS +!! +!! endPoints - starting and endpoints of the region of interest. +!! See also NOTE (1) below. +!! +!! blkLimitsGC - the starting and endpoint of the whole block including +!! the guard cells, as returned by Grid_getBlkIndexLimits. +!! See also NOTE (1) below. +!! +!! idest - Only meaningful with PARAMESH 3 or later. The argument indicates which slot +!! in its one-block storage space buffers ("data_1blk.fh") PARAMESH is in the +!! process of filling. +!! The following applies when guard cells are filled as part of regular +!! Grid_fillGuardCells processing (or, in NO_PERMANENT_GUARDCELLS mode, +!! in order to satisfy a Grid_getBlkPtr request): The value is 1 if guard cells +!! are being filled in the buffer slot in UNK1 and/or FACEVAR{X,Y,Z}1 or WORK1 +!! that will end up being copied to permanent block data storage (UNK and/or +!! FACEVAR{X,Y,Z} or WORK, respectively) and/or returned to the user. +!! The value is 2 if guard cells are being filled in the alternate slot in +!! the course of assembling data to serve as input for coarse-to-fine +!! interpolation. +!! When guard cells are being filled in order to provide input data for +!! coarse-to-fine interpolation as part of amr_prolong processing (which +!! is what happens when Grid_updateRefinement is called for an AMR Grid), +!! the value is always 1. +!! +!! In other words, an implementation can nearly always ignore this optional +!! argument. As of FLASH 3.0, it is only used internally within the +!! Grid unit and is handled by the GridBoundaryConditions/Grid_bcApplyToRegion +!! implementation. It is used within the Grid unit by a Multigrid GridSolver +!! implementation which requires some special handling, but this is only +!! applied to the WORK data structure. The argument has been added to the +!! Grid_bcApplyToRegionSpecialized interface for consistency with +!! Grid_bcApplyToRegion. +!! +!! NOTES +!! +!! (1) NOTE that the second indices of the endPoints and +!! blkLimitsGC arrays count the (IAXIS, JAXIS, KAXIS) +!! directions in the usual order, not permuted as in +!! regionSize. +!! +!! (2) The preprocessor symbols appearing in this description +!! as well as in the dummy argument declarations (i.e., +!! all the all-caps token (other than IN and OUT)) are +!! defined in constants.h. +!! +!! (3) This routine is common to all the mesh packages supported. +!! The mesh packages extract the small arrays relevant to +!! boundary condition calculations from their Grid data +!! structures. +!! +!! SEE ALSO +!! +!! Grid_bcApplyToRegion +!! +!!*** + + +subroutine Grid_bcApplyToRegionSpecialized(bcType,gridDataStruct,& + guard,axis,face,regionData,regionSize,mask,applied,& + blockHandle,secondDir,thirdDir,endPoints,blkLimitsGC, idest) + +#include "constants.h" +#include "Flash.h" + + use Driver_interface, ONLY : Driver_abortFlash + use gr_bcInterface, ONLY : gr_bcMapBcType + use Grid_interface, ONLY : Grid_bcApplyToRegion + use Grid_data, ONLY : gr_geometry, gr_dirGeom, & + gr_smallrho, gr_smallE + use Simulation_data, ONLY: sim_bcSetBdryVar + + implicit none + + integer, intent(IN) :: bcType,axis,face,guard,gridDataStruct + integer,dimension(REGION_DIM),intent(IN) :: regionSize + real,dimension(regionSize(BC_DIR),& + regionSize(SECOND_DIR),& + regionSize(THIRD_DIR),& + regionSize(STRUCTSIZE)),intent(INOUT)::regionData + logical,intent(IN),dimension(regionSize(STRUCTSIZE)):: mask + logical, intent(OUT) :: applied + integer,intent(IN) :: blockHandle + integer,intent(IN) :: secondDir,thirdDir + integer,intent(IN),dimension(LOW:HIGH,MDIM) :: endPoints, blkLimitsGC + integer,intent(IN),OPTIONAL:: idest + + integer :: i,j, k,ivar,je,ke,n + + applied = .FALSE. + + if (gridDataStruct .NE. CENTER) then + return !RETURN immediately! + end if + + select case (bcType) + case(REFLECTING) + applied = .TRUE. !will handle these types of BCs below + case default + return !RETURN immediately! + end select + + call Grid_bcApplyToRegion(bcType,gridDataStruct,& + guard,axis,face,regionData,regionSize,mask,applied,& + blockHandle,secondDir,thirdDir,endPoints,blkLimitsGC, idest) + +#ifdef BDRY_VAR + + je=regionSize(SECOND_DIR) + ke=regionSize(THIRD_DIR) + + +!!$ if(mask(BDRY_VAR)) then + if (sim_bcSetBdryVar) then + + if(face==LOW) then + k = 2*guard+1 + do i = 1,guard + regionData(i,1:je,1:ke,BDRY_VAR)= 1.0 + end do + + else !(face==HIGH) + + k = 2*guard+1 + do i = 1,guard + regionData(k-i,1:je,1:ke,BDRY_VAR)= 1.0 + end do + + end if + end if +!!$ end if + +#endif + +end subroutine Grid_bcApplyToRegionSpecialized diff --git a/Grid_computeUserVars.F90.analytical b/Grid_computeUserVars.F90.analytical new file mode 100644 index 0000000..222c01d --- /dev/null +++ b/Grid_computeUserVars.F90.analytical @@ -0,0 +1,131 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Grid_computeUserVars +!! +!! NAME +!! Grid_computeUserVars +!! +!! +!! SYNOPSIS +!! +!! call Grid_computeUserVars() +!! +!! +!! DESCRIPTION +!! +!! Prepare user variables for output. +!! +!! ARGUMENTS +!! none +!! +!! EXAMPLE +!! +!! +!! +!! NOTES +!! +!!*** + +subroutine Grid_computeUserVars() + use Simulation_data, ONLY: sim_analyticGen + use Simulation_interface, ONLY: Simulation_computeAnalytical + use Driver_data, ONLY : dr_simGeneration + use Timers_interface, ONLY : Timers_start, Timers_stop + use Grid_interface, ONLY : Grid_getLocalNumBlks, & + Grid_getBlkData, & + Grid_getListOfBlocks, & + Grid_getBlkIndexLimits, Grid_getBlkPtr, & + Grid_releaseBlkPtr + use Driver_interface, ONLY: Driver_getSimTime +! use Grid_data, ONLY : gr_meshMe + implicit none + +#include "Flash.h" +#include "constants.h" + + real :: tnew + integer :: simGen + integer :: lb, blockID + integer :: localNumBlocks, blockCount + + integer,allocatable,dimension(:) :: blockList + integer,dimension(2,MDIM) :: bl,blkLimitsGC + integer,dimension( MDIM) :: bsize + real, pointer, dimension(:,:,:,:) :: solnData + real,allocatable :: cellVol(:,:,:) + + call Timers_start("computeUserVars") + call Driver_getSimTime(tnew, simGen) + + call Grid_getLocalNumBlks(localNumBlocks) + allocate(blockList(localNumBlocks)) + call Grid_getListOfBlocks(LEAF,blockList,blockCount) + + do lb=1,blockCount + blockID = blockList(lb) + call Simulation_computeAnalytical(blockID, tnew) + +#if defined(DEND_VAR) || defined(PRSD_VAR) || defined(VLRD_VAR) + call Grid_getBlkIndexLimits(blockID,bl,blkLimitsGC) + + call Grid_getBlkPtr(blockID,solnData) + +#if defined(DENC_VAR) || defined(PRSC_VAR) || defined(VLRC_VAR) + bsize(:) = bl(HIGH,:) - bl(LOW,:) + 1 + allocate( cellVol(bl(LOW,IAXIS):bl(HIGH,IAXIS), & + bl(LOW,JAXIS):bl(HIGH,JAXIS), & + bl(LOW,KAXIS):bl(HIGH,KAXIS)) ) + call Grid_getBlkData(blockID, CELL_VOLUME, 0, EXTERIOR, & + (/bl(LOW,IAXIS),bl(LOW,JAXIS),bl(LOW,KAXIS)/), & + cellVol (bl(LOW,IAXIS):bl(HIGH,IAXIS), & + bl(LOW,JAXIS):bl(HIGH,JAXIS), & + bl(LOW,KAXIS):bl(HIGH,KAXIS)), & + dataSize=bsize ) +#endif + +!!$ +#if defined(DEND_VAR) && defined(DENA_VAR) + solnData(DEND_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + solnData(DENS_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) - & + solnData(DENA_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#ifdef DENC_VAR + solnData(DENC_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + abs(solnData(DEND_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS))) * & + cellVol( bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#endif +#endif +!!$ +#if defined(PRSD_VAR) && defined(PRSA_VAR) + solnData(PRSD_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + solnData(PRES_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) - & + solnData(PRSA_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#ifdef PRSC_VAR + solnData(PRSC_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + abs(solnData(PRSD_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS))) * & + cellVol( bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#endif +#endif +!!$ +#if defined(VLRD_VAR) && defined(VLXA_VAR) + solnData(VLRD_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + solnData(VELX_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) - & + solnData(VLXA_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#ifdef VLRC_VAR + solnData(VLRC_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) = & + abs(solnData(VLRD_VAR,bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS))) * & + cellVol( bl(1,IAXIS):bl(2,IAXIS),bl(1,JAXIS):bl(2,JAXIS),bl(1,KAXIS):bl(2,KAXIS)) +#endif +#endif + +#if defined(DENC_VAR) || defined(PRSC_VAR) || defined(VLRC_VAR) + deallocate( cellVol ) +#endif + + call Grid_releaseBlkPtr(blockID,solnData) +#endif + end do + + deallocate(blockList) + dr_simGeneration = simGen + 1 + sim_analyticGen = dr_simGeneration + call Timers_stop("computeUserVars") + +end subroutine Grid_computeUserVars diff --git a/Grid_dump.F90 b/Grid_dump.F90 new file mode 100644 index 0000000..5792ed9 --- /dev/null +++ b/Grid_dump.F90 @@ -0,0 +1,210 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Grid_dump +!! +!! NAME +!! Grid_dump +!! +!! SYNOPSIS +!! +!! call Grid_dump(integer(IN) :: var(num), +!! integer(IN) :: num, +!! integer(IN) :: blockID, +!! logical(IN) :: gcell) +!! +!! DESCRIPTION +!! +!! Dumps the variables specified in "var" to a file. Can be done from +!! anywhere in the code, and is useful for diagnostic purposes +!! With paramesh this function doesn not work in parallel, but works +!! only with a single block +!! +!! ARGUMENTS +!! +!! var :: array containing the indices of the variables to be dumped +!! num :: number of variables being dumped. +!! blockID :: local number of block to be dumped +!! gcell :: indicates whether to include guardcells in the dump. +!! +!! EXAMPLE +!! +!! num = 3 !dumping 3 variables +!! var(1) = DENS_VAR +!! var(2) = PRES_VAR +!! var(3) = TEMP_VAR +!! blockID = 1 ! local block number +!! gcell = .false. +!! +!! call Grid_dump(var, num, blockID, gcell) +!! +!! will dump the interior cell values of density, pressure and temperature +!! for local block number 1. +!! +!! NOTES +!! DENS_VAR, PRES_VAR, TEMP_VAR etc are #defined values in Flash.h +!! indicating the index in the physical data array. +!! The routine calling Grid_dump will need to include Flash.h +!! +!!*** + +#include "Flash.h" + +subroutine Grid_dump(var,num, blockID, gcell) + + use Grid_interface, ONLY : Grid_getBlkIndexLimits, Grid_getBlkPtr, Grid_releaseBlkPtr + use Driver_interface, ONLY : Driver_getNStep, Driver_getSimTime, Driver_getDt + +#ifdef FIXEDBLOCKSIZE + use Grid_data, ONLY : gr_ilo, gr_ihi, gr_jlo, gr_jhi, & + gr_klo, gr_khi, gr_iloGC, gr_ihiGC, gr_jloGC, gr_jhiGC, & + gr_kloGC, gr_khiGC +#endif + + use Simulation_data , ONLY : sim_fileUnitOutNum, sim_fileUnitOutAna + use Simulation_data , ONLY : sim_ffNum, sim_ffAna + use Simulation_data , ONLY : sim_globalNumProcs, sim_globalMe + +#include "constants.h" + + implicit none + + integer, intent(IN) :: num, blockID + integer, dimension(num), intent(IN) :: var + logical, intent(IN) :: gcell + + integer,target :: blkLimitsGC(LOW:HIGH,MDIM) + integer,target :: blkLimits(LOW:HIGH,MDIM) + integer,pointer :: dumpLimits(:,:) + +!!$ character(len=80) :: ffTmp + integer,dimension(4), save :: filecount = 0 + integer :: i,j,k,count,nstep + integer,save :: iglobalCell = 0 + real,pointer :: blkPtr(:,:,:,:) + real :: rho + real,allocatable,dimension(:) :: x,y,z + +#ifdef FIXEDBLOCKSIZE + integer,parameter :: bxn=GRID_IHI_GC-GRID_ILO_GC+1 + integer,parameter :: byn=GRID_JHI_GC-GRID_JLO_GC+1 + integer,parameter :: bzn=GRID_KHI_GC-GRID_KLO_GC+1 +#else + integer :: bxn,byn,bzn +#endif + real :: stime, dt + integer,save :: numCalls = 0, lastBlockID = -1 + + if (lastBlockID < 0 .OR. blockID .LE. lastBlockID) then + sim_ffNum = "sedSol-num"//char(48+filecount(4))//char(48+filecount(3))//& + char(48+filecount(2))//char(48+filecount(1)) + sim_ffAna = "sedSol-ana"//char(48+filecount(4))//char(48+filecount(3))//& + char(48+filecount(2))//char(48+filecount(1)) + if (sim_globalNumProcs > 1) then +99 format("p",I6.6,".out") + write(sim_ffNum(15:),99) sim_globalMe + write(sim_ffAna(15:),99) sim_globalMe + end if + numCalls = 0 + !print*,'filecount',filecount + filecount(1) = filecount(1) + 1 + do i = 1,3 + if(filecount(i)==10)then + filecount(i) = 0 + filecount(i+1)=filecount(i+1)+1 + end if + end do + close(sim_fileUnitOutNum) + close(sim_fileUnitOutAna) + print*,'Opening new file:',sim_ffNum + open(sim_fileUnitOutNum,file=sim_ffNum,form='formatted') + write(sim_fileUnitOutNum,'(a10,7a15)') & + '# cellno', 'x ', 'y ', 'dens ', 'pres ', 'velx ', 'eint (spec.)' + print*,'Opening new file:',sim_ffAna + open(sim_fileUnitOutAna,file=sim_ffAna,form='formatted') + write(sim_fileUnitOutAna,'(a10,7a15)') & + '# cellno', 'x ', 'y ', 'dens ', 'pres ', 'velx ', 'eint density' + end if + + if (numCalls == 0) then + call Driver_getNStep(nstep) + call Driver_getSimTime(stime) + call Driver_getDt(dt) + write(sim_fileUnitOutNum, '(1x,"#nstep, stime, dt =",i8,7(1pe15.6))') & ! ,ADVANCE='NO') & + nstep, stime, dt + write(sim_fileUnitOutAna, '(1x,"#nstep, stime, dt =",i8,8(1pe15.6))') & + nstep, stime, dt + end if + + call Grid_getBlkPtr(blockID,blkPtr) + call Grid_getBlkIndexLimits(blockID, blkLimits,blkLimitsGC) +#ifndef FIXEDBLOCKSIZE + bxn = blkLimitsGC(HIGH,IAXIS) - blkLimitsGC(LOW,IAXIS) + 1 + byn = blkLimitsGC(HIGH,JAXIS) - blkLimitsGC(LOW,JAXIS) + 1 + bzn = blkLimitsGC(HIGH,KAXIS) - blkLimitsGC(LOW,KAXIS) + 1 +#endif + count = bxn*byn*bzn + + + allocate(x(bxn)) + allocate(y(byn)) + allocate(z(bzn)) + call Grid_getCellCoords(IAXIS,blockID,CENTER,.TRUE.,x,bxn) + call Grid_getCellCoords(JAXIS,blockID,CENTER,.TRUE.,y,byn) + call Grid_getCellCoords(KAXIS,blockID,CENTER,.TRUE.,z,bzn) + + + if(.not. gcell) then + dumpLimits => blkLimits +#ifdef DEBUG_SIM +#ifdef FIXEDBLOCKSIZE + print '(8F11.6)', blkPtr(var(1), gr_ilo:gr_ihi, gr_jlo:gr_jhi, gr_klo:gr_khi) +#endif +#endif + else + dumpLimits = blkLimitsGC +#ifdef DEBUG_SIM +#ifdef FIXEDBLOCKSIZE + print '(16F7.3)', blkPtr(var(1), gr_iloGc:gr_ihiGc, gr_jloGc:gr_jhiGc, gr_kloGc:gr_khiGc) +#endif +#endif + end if + + iglobalCell = 0 + do k = dumpLimits(LOW,KAXIS), dumpLimits(HIGH,KAXIS) + do j = dumpLimits(LOW,JAXIS), dumpLimits(HIGH,JAXIS) + do i = dumpLimits(LOW,IAXIS), dumpLimits(HIGH,IAXIS) + + iglobalCell = iglobalCell + 1 + ! Write temperatures (and whatever else) to a file. If + ! you add additional quantities here, you might want to + ! also change the file header in Simulation_init.F90: + rho = blkPtr(DENS_VAR,i,j,k) + write(sim_fileUnitOutNum, '(i10,7(1pe15.6))') & + iglobalCell, x(i), y(j), & + blkPtr(DENS_VAR,i,j,k), & + blkPtr(PRES_VAR,i,j,k), & + blkPtr(VELX_VAR,i,j,k), & + blkPtr(EINT_VAR,i,j,k) + write(sim_fileUnitOutAna, '(i10,8(1pe15.6))') & + iglobalCell, x(i), y(j), & + blkPtr(DENA_VAR,i,j,k), & + blkPtr(PRSA_VAR,i,j,k), & + blkPtr(VLXA_VAR,i,j,k), & + blkPtr(EINT_VAR,i,j,k)*rho + if ((blkPtr(VLXA_VAR,i,j,k)==0.0) .AND. (blkPtr(VELX_VAR,i,j,k)==0.0)) go to 100 +!!$ exit + enddo + end do + end do + 100 continue + + + + !print '(8F11.6)', unk(var(1), gr_ilo:gr_ihi, gr_jlo:gr_jhi, gr_klo:gr_khi, blockID) + + + deallocate(x,y,z) + lastBlockID = blockID + call Grid_releaseBlkPtr(blockID,blkPtr) + + numCalls = numCalls + 1 + return +end subroutine Grid_dump diff --git a/Grid_markRefineDerefine.F90 b/Grid_markRefineDerefine.F90 new file mode 100644 index 0000000..236026d --- /dev/null +++ b/Grid_markRefineDerefine.F90 @@ -0,0 +1,159 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Grid_markRefineDerefine +!! +!! NAME +!! Grid_markRefineDerefine +!! +!! SYNOPSIS +!! +!! call Grid_markRefineDerefine() +!! +!! DESCRIPTION +!! Mark blocks for refinement or derefinement +!! This routine is used with AMR only where individual +!! blocks are marked for refinement or derefinement based upon +!! some refinement criterion. The Uniform Grid does not need +!! this routine, and uses the stub. +!! +!! This routine is normally called by the implementation of +!! Grid_updateRefinement. It may also get called repeatedly +!! during the initial construction of the Grid from +!! Grid_initDomain. +!! +!! ARGUMENTS +!! +!! none +!! +!! SEE ALSO +!! +!! Grid_updateRefinement +!! Grid_initDomain +!! gr_expandDomain +!! +!! NOTES +!! +!! Every unit uses a few unit scope variables that are +!! accessible to all routines within the unit, but not to the +!! routines outside the unit. For Grid unit these variables begin with "gr_" +!! like, gr_meshMe or gr_eosMode, and are stored in fortran +!! module Grid_data (in file Grid_data.F90). The other variables +!! are local to the specific routines and do not have the prefix "gr_" +!! +!! +!!*** + +subroutine Grid_markRefineDerefine() + + use Grid_data, ONLY : gr_refine_cutoff, gr_derefine_cutoff,& + gr_refine_filter,& + gr_numRefineVars,gr_refine_var,gr_refineOnParticleCount,& + gr_enforceMaxRefinement, gr_maxRefine,& + gr_lrefineMaxByTime,& + gr_lrefineMaxRedDoByTime,& + gr_lrefineMaxRedDoByLogR,& + gr_lrefineCenterI,gr_lrefineCenterJ,gr_lrefineCenterK,& + gr_eosModeNow + use Simulation_data,ONLY : sim_forceCenterDerefine, sim_centerRefineLevel, & + sim_derefineRadius + use tree, ONLY : newchild, refine, derefine, stay, nodetype +!!$ use physicaldata, ONLY : force_consistency + use Logfile_interface, ONLY : Logfile_stampVarMask + use Grid_interface, ONLY : Grid_fillGuardCells + use Particles_interface, only: Particles_sinkMarkRefineDerefine + implicit none + +#include "constants.h" +#include "Flash.h" + + + real :: ref_cut,deref_cut,ref_filter + integer :: l,i,iref + logical,save :: gcMaskArgsLogged = .FALSE. + integer,save :: eosModeLast = 0 + logical :: doEos=.true. + integer,parameter :: maskSize = NUNK_VARS+NDIM*NFACE_VARS + logical,dimension(maskSize) :: gcMask + + if(gr_lrefineMaxRedDoByTime) then + call gr_markDerefineByTime() + end if + + if(gr_lrefineMaxByTime) then + call gr_setMaxRefineByTime() + end if + + if (gr_eosModeNow .NE. eosModeLast) then + gcMaskArgsLogged = .FALSE. + eosModeLast = gr_eosModeNow + end if + + ! that are implemented in this file need values in guardcells + + gcMask=.false. + do i = 1,gr_numRefineVars + iref = gr_refine_var(i) + if (iref > 0) gcMask(iref) = .TRUE. + end do + + gcMask(NUNK_VARS+1:min(maskSize,NUNK_VARS+NDIM*NFACE_VARS)) = .TRUE. +!!$ gcMask(NUNK_VARS+1:maskSize) = .TRUE. + + + if (.NOT.gcMaskArgsLogged) then + call Logfile_stampVarMask(gcMask, .true., '[Grid_markRefineDerefine]', 'gcArgs') + end if + +!!$ force_consistency = .FALSE. + call Grid_fillGuardCells(CENTER_FACES,ALLDIR,doEos=.true.,& + maskSize=maskSize, mask=gcMask, makeMaskConsistent=.true.,doLogMask=.NOT.gcMaskArgsLogged,& + selectBlockType=ACTIVE_BLKS) + gcMaskArgsLogged = .TRUE. +!!$ force_consistency = .TRUE. + + newchild(:) = .FALSE. + refine(:) = .FALSE. + derefine(:) = .FALSE. + stay(:) = .FALSE. + + do l = 1,gr_numRefineVars + iref = gr_refine_var(l) + ref_cut = gr_refine_cutoff(l) + deref_cut = gr_derefine_cutoff(l) + ref_filter = gr_refine_filter(l) + call gr_markRefineDerefine(iref,ref_cut,deref_cut,ref_filter) + end do + +#ifdef FLASH_GRID_PARAMESH2 + ! For PARAMESH2, call gr_markRefineDerefine here if it hasn't been called above. + ! This is necessary to make sure lrefine_min and lrefine_max are obeyed - KW + if (gr_numRefineVars .LE. 0) then + call gr_markRefineDerefine(-1, 0.0, 0.0, 0.0) + end if +#endif + + if(gr_refineOnParticleCount)call gr_ptMarkRefineDerefine() + + if(gr_enforceMaxRefinement) call gr_enforceMaxRefine(gr_maxRefine) + + if(gr_lrefineMaxRedDoByLogR) & + call gr_unmarkRefineByLogRadius(gr_lrefineCenterI,& + gr_lrefineCenterJ,gr_lrefineCenterK) + + if (sim_forceCenterDerefine) & + call gr_forceDerefInRadius(gr_lrefineCenterI,& + gr_lrefineCenterJ,gr_lrefineCenterK,& + sim_derefineRadius,& + sim_centerRefineLevel) + + + call Particles_sinkMarkRefineDerefine() + + ! When the flag arrays are passed to Paramesh for processing, only leaf + ! blocks should be marked. - KW + where (nodetype(:) .NE. LEAF) + refine(:) = .false. + derefine(:) = .false. + end where + + return +end subroutine Grid_markRefineDerefine + diff --git a/IO_writeIntegralQuantities.F90.analytical b/IO_writeIntegralQuantities.F90.analytical new file mode 100644 index 0000000..fe45885 --- /dev/null +++ b/IO_writeIntegralQuantities.F90.analytical @@ -0,0 +1,662 @@ +!!****if* source/Simulation/SimulationMain/Sedov/IO_writeIntegralQuantities +!! +!! +!! NAME +!! IO_writeIntegralQuantities +!! +!! SYNOPSIS +!! call IO_writeIntegralQuantities(integer(in) :: isFirst, +!! real(in) :: simTime) +!! +!! DESCRIPTION +!! +!! Compute the values of integral quantities (eg. total energy) +!! and write them to an ASCII file. If this is the initial step, +!! create the file and write a header to it before writing the data. +!! +!! Presently, this supports 1, 2, and 3-d Cartesian geometry and 2-d +!! cylindrical geometry (r,z). More geometries can be added by +!! modifying the volume of each zone (dvol). +!! +!! Users should modify this routine if they want to store any +!! quantities other than default values in the flash.dat. Make sure +!! to modify the nGlobalSum parameter to match the number of +!! quantities written. Also make sure to modify the header to match +!! the names of quantities with those calculated in the lsum and +!! gsum arrays. +!! +!! ARGUMENTS +!! +!! isFirst - if 1 then write header info plus data, otherwise just write data +!! simTime - simulation time +!! +!! +!!*** + +!!REORDER(4):solnData + +subroutine IO_writeIntegralQuantities ( isFirst, simTime) + + use IO_data, ONLY : io_restart, io_statsFileName, io_globalComm + use Driver_interface, ONLY : Driver_getDt + use Timers_interface, ONLY : Timers_start, Timers_stop + use Grid_interface, ONLY : Grid_getListOfBlocks, & + Grid_getMaxRefinement, Grid_getBlkRefineLevel, & + Grid_getBlkIndexLimits, Grid_getBlkPtr, Grid_getSingleCellVol, & + Grid_getCellCoords, & + Grid_releaseBlkPtr + + use IO_data, ONLY : io_globalMe, io_writeMscalarIntegrals + use Simulation_data, ONLY : sim_testInitialized, & + nLargestMaxSummary,& + sim_earliestLSTime, sim_latestLSTime, & + sim_smallestNormRadius, sim_largestNormRadius, & + sim_testFirstVals, & + sim_testLastVals, & + sim_testLargestVals, & + sim_testLargestWhen, & + sim_xCenter,sim_yCenter,sim_zCenter + use Simulation_data, ONLY : sim_oneLevelIntegralsOnly, & + sim_integralsLevel + use Simulation_data, ONLY : sim_smallu + implicit none + +#include "Flash_mpi.h" +#include "constants.h" +#include "Flash.h" + + + real, intent(in) :: simTime + + integer, intent(in) :: isFirst + + integer :: currentLevel, blkLevel + + integer :: lb, count + + integer :: funit = 99 + integer :: recl + integer :: error + integer :: nGlobalSumUsed, iSum + + character (len=MAX_STRING_LENGTH), save :: fname + + integer :: blockList(MAXBLOCKS) + + integer :: blkLimits(HIGH, MDIM), blkLimitsGC(HIGH, MDIM) + real, dimension(:), allocatable :: xCenter, yCenter, zCenter + +#ifdef MAGP_VAR + integer, parameter :: nGlobalSumProp = 20 ! Number of globally-summed regular quantities +#else + integer, parameter :: nGlobalSumProp = 19 ! Number of globally-summed regular quantities +#endif + integer, parameter :: nGlobalSum = nGlobalSumProp + NMASS_SCALARS ! Number of globally-summed quantities + real :: gsum(nGlobalSum) !Global summed quantities + real :: lsum(nGlobalSum) !Global summed quantities + + integer, parameter :: nGlobalErrSumProp = 8 ! Number of globally-summed error quantities + integer, parameter :: nRelErrSumProp = 5 ! Number of relative globally-summed error quantities + integer, parameter :: nRelErrMaxProp = 3 ! Number of relative max-error quantities + integer, parameter :: nRelErrProp = nRelErrSumProp+nRelErrMaxProp ! Number of relative error quantities + real :: gRelErrSum(nRelErrSumProp) !relative summed error quantities + + integer, parameter :: nGlobalExtProp = 15 ! Number of global extrema quantities +!!$ real :: gErrSum(nGlobalSum) !Global summed error quantities +!!$ real :: lErrSum(nGlobalSum) !Global summed error quantities +!!$ real :: gMax(nGlobalErrSumProp) !Global extrema quantities +!!$ real :: lMax(nGlobalErrSumProp) !Global extrema quantities + real :: gMax(nGlobalExtProp) !Global extrema quantities + real :: lMax(nGlobalExtProp) !Global extrema quantities + real :: gRelErrMax(nRelErrMaxProp) !relative max error quantities, relative Linf norm + + real :: currentTimeLargest(0:nLargestMaxSummary) + real :: dt + real :: xdist,ydist,zdist, radius, radius2 + + integer :: ivar + integer :: i, j, k + integer :: il, jl, kl, ih, jh, kh + real :: dvol !, del(MDIM) + real, DIMENSION(:,:,:,:), POINTER :: solnData + + integer :: point(MDIM) + integer :: ioStat + + call Timers_start("writeIntegQ") + if (sim_oneLevelIntegralsOnly) then + if (sim_integralsLevel > 0) then + currentLevel = sim_integralsLevel + else + call Grid_getMaxRefinement(currentLevel, 4, scope=2, inputComm=io_globalComm) + end if + end if + + call Grid_computeUserVars() + + if (io_writeMscalarIntegrals) then + nGlobalSumUsed = nGlobalSum + else + nGlobalSumUsed = nGlobalSumProp + end if + + ! Sum quantities over all locally held leaf-node blocks. + gsum(1:nGlobalSumUsed) = 0. + lsum(1:nGlobalSumUsed) = 0. + gRelErrSum(1:nRelErrSumProp) = 0. + lMax(1:nGlobalExtProp) = -HUGE(1.0) + + call Grid_getListOfBlocks(LEAF, blockList, count) + + do lb = 1, count + + if (sim_oneLevelIntegralsOnly) then + call Grid_getBlkRefineLevel(blockList(lb), blkLevel) + if (blkLevel .NE. currentLevel) CYCLE ! Skip to the next block + end if + + !get the index limits of the block + call Grid_getBlkIndexLimits(blockList(lb), blkLimits, blkLimitsGC) + + il = blkLimits(LOW,IAXIS); ih = blkLimits(HIGH,IAXIS) + jl = blkLimits(LOW,JAXIS); jh = blkLimits(HIGH,JAXIS) + kl = blkLimits(LOW,KAXIS); kh = blkLimits(HIGH,KAXIS) + allocate(xCenter(il:ih)) + allocate(yCenter(jl:jh)) + allocate(zCenter(kl:kh)) + !! Get the cell coordinates + call Grid_getCellCoords(IAXIS,blockList(lb),CENTER, .false., xCenter, ih-il+1) + call Grid_getCellCoords(JAXIS,blockList(lb),CENTER, .false., yCenter, jh-jl+1) + call Grid_getCellCoords(KAXIS,blockList(lb),CENTER, .false., zCenter, kh-kl+1) + + ! get a pointer to the current block of data + call Grid_getBlkPtr(blockList(lb), solnData) + + ! Sum contributions from the indicated blkLimits of cells. + do k = blkLimits(LOW,KAXIS), blkLimits(HIGH,KAXIS) + zdist = zCenter(k) - sim_zCenter + do j = blkLimits(LOW,JAXIS), blkLimits(HIGH,JAXIS) + ydist = yCenter(j) - sim_yCenter + do i = blkLimits(LOW,IAXIS), blkLimits(HIGH,IAXIS) + xdist = xCenter(i) - sim_xCenter +#if NDIM==1 + radius = xdist +#else + radius2 = xdist**2+ydist**2 +#if NDIM==3 + radius2 = radius2 +zdist**2 +#endif + radius = sqrt(radius2) +#endif + if (.NOT.(radius .GE. sim_smallestNormRadius .AND. & + radius .LE. sim_largestNormRadius)) then + CYCLE + end if + + + point(IAXIS) = i + point(JAXIS) = j + point(KAXIS) = k + +!! Get the cell volume for a single cell + call Grid_getSingleCellVol(blockList(lb), EXTERIOR, point, dvol) + + ! mass +#ifdef DENS_VAR + lsum(1) = lsum(1) + solnData(DENS_VAR,i,j,k)*dvol +#endif + + +#ifdef DENS_VAR +#ifdef VELX_VAR + ! momentum + lsum(2) = lsum(2) + solnData(DENS_VAR,i,j,k) * & + & solnData(VELX_VAR,i,j,k)*dvol + +#endif +#ifdef VELY_VAR + + lsum(3) = lsum(3) + solnData(DENS_VAR,i,j,k) * & + & solnData(VELY_VAR,i,j,k)*dvol + +#endif +#ifdef VELZ_VAR + lsum(4) = lsum(4) + solnData(DENS_VAR,i,j,k) * & + & solnData(VELZ_VAR,i,j,k)*dvol +#endif + + ! total energy +#ifdef ENER_VAR + lsum(5) = lsum(5) + solnData(ENER_VAR,i,j,k) * & + & solnData(DENS_VAR,i,j,k)*dvol +#ifdef MAGP_VAR + ! total plasma energy +!!$ lsum(5) = lsum(5) + (solnData(ENER_VAR,i,j,k) * & +!!$ & solnData(DENS_VAR,i,j,k) + solnData(MAGP_VAR,i,j,k))*dvol + + lsum(5) = lsum(5) + solnData(MAGP_VAR,i,j,k)*dvol +#endif +#endif + + +#ifdef VELX_VAR +#ifdef VELY_VAR +#ifdef VELZ_VAR + ! kinetic energy + lsum(6) = lsum(6) + 0.5*solnData(DENS_VAR,i,j,k) * & + & (solnData(VELX_VAR,i,j,k)**2+ & + & solnData(VELY_VAR,i,j,k)**2+ & + & solnData(VELZ_VAR,i,j,k)**2)*dvol + +#endif +#endif +#endif + + +#ifdef EINT_VAR + ! internal energy + lsum(7) = lsum(7) + solnData(DENS_VAR,i,j,k) * & + & solnData(EINT_VAR,i,j,k)*dvol +#endif +#endif ! ifdef DENS_VAR + +#ifdef PRES_VAR + ! pressure + lsum(8) = lsum(8) + solnData(PRES_VAR,i,j,k)*dvol + +#endif + +#ifdef VELX_VAR + ! velocity + lsum(9) = lsum(9) + solnData(VELX_VAR,i,j,k)*dvol + +#endif + +#ifdef DENA_VAR + ! analytic density + lsum(10) = lsum(10) + abs(solnData(DENA_VAR,i,j,k))*dvol + +#endif + +#ifdef PRSA_VAR + ! analytic pressure + lsum(11) = lsum(11) + abs(solnData(PRSA_VAR,i,j,k))*dvol + +#endif + +#ifdef VLXA_VAR + ! analytic velocity + lsum(12) = lsum(12) + abs(solnData(VLXA_VAR,i,j,k))*dvol + +#endif + +#ifdef VLYA_VAR + ! analytic Y-velocity + lsum(13) = lsum(13) + abs(solnData(VLYA_VAR,i,j,k))*dvol + +#endif + +#ifdef VLZA_VAR + ! analytic Z-velocity + lsum(14) = lsum(14) + abs(solnData(VLZA_VAR,i,j,k))*dvol + +#endif + +#if defined(DENA_VAR) && defined(DENA_VAR) + ! density L1 error + lsum(15) = lsum(15) + abs(solndata(DENS_VAR,i,j,k)-solnData(DENA_VAR,i,j,k))*dvol + +#endif + +#if defined(PRES_VAR) && defined(PRSA_VAR) + ! pressure L1 error + lsum(16) = lsum(16) + abs(solndata(PRES_VAR,i,j,k)-solnData(PRSA_VAR,i,j,k))*dvol + +#endif + +#if defined(VELX_VAR) && defined(VLXA_VAR) + ! velocity L1 error + lsum(17) = lsum(17) + abs(solndata(VELX_VAR,i,j,k)-solnData(VLXA_VAR,i,j,k))*dvol + +#endif + +#if defined(VELY_VAR) && defined(VLYA_VAR) + ! velocity L1 error + lsum(18) = lsum(18) + abs(solndata(VELY_VAR,i,j,k)-solnData(VLYA_VAR,i,j,k))*dvol + +#endif + +#if defined(VELZ_VAR) && defined(VLZA_VAR) + ! velocity L1 error + lsum(19) = lsum(19) + abs(solndata(VELZ_VAR,i,j,k)-solnData(VLZA_VAR,i,j,k))*dvol + +#endif + +#ifdef MAGP_VAR + ! magnetic energy + lsum(20) = lsum(20) + solnData(MAGP_VAR,i,j,k)*dvol +#endif + +#ifdef DENS_VAR + if (io_writeMscalarIntegrals) then + iSum = nGlobalSumProp +!!$ do ivar=MASS_SCALARS_BEGIN,MASS_SCALARS_END + lsum(iSum+1:iSum+NMASS_SCALARS) = & + lsum(iSum+1:iSum+NMASS_SCALARS) + & + solnData(DENS_VAR,i,j,k) * & + solnData(MASS_SCALARS_BEGIN: & + MASS_SCALARS_END,i,j,k)*dvol +!!$ end do + end if +#endif + +#ifdef DENS_VAR + ! density + lMax(1) = max(lMax(1), solnData(DENS_VAR,i,j,k)) + lMax(2) = max(lMax(2),-solnData(DENS_VAR,i,j,k)) +#endif + +#ifdef PRES_VAR + ! pressure + lMax(3) = max(lMax(3), solnData(PRES_VAR,i,j,k)) + lMax(4) = max(lMax(4),-solnData(PRES_VAR,i,j,k)) +#endif + +#ifdef VELX_VAR + ! velocity + lMax(5) = max(lMax(5), solnData(VELX_VAR,i,j,k)) + lMax(6) = max(lMax(6),-solnData(VELX_VAR,i,j,k)) +#endif + +#ifdef DENA_VAR + ! analytic density + lMax(7) = max(lMax(7), solnData(DENA_VAR,i,j,k)) + lMax(8) = max(lMax(8),-solnData(DENA_VAR,i,j,k)) +#endif + +#ifdef PRSA_VAR + ! analytic pressure + lMax(9) = max(lMax(9), solnData(PRSA_VAR,i,j,k)) + lMax(10) = max(lMax(10),-solnData(PRSA_VAR,i,j,k)) +#endif + +#ifdef VLXA_VAR + ! analytic velocity + lMax(11) = max(lMax(11), solnData(VLXA_VAR,i,j,k)) + lMax(12) = max(lMax(12),-solnData(VLXA_VAR,i,j,k)) +#endif + +#if defined(DENS_VAR) && defined(DENA_VAR) + ! density Linf error + lMax(13) = max(lMax(13), abs(solndata(DENS_VAR,i,j,k)-solnData(DENA_VAR,i,j,k))) + +#endif + +#if defined(PRES_VAR) && defined(PRSA_VAR) + ! pressure Linf error + lMax(14) = max(lMax(14), abs(solndata(PRES_VAR,i,j,k)-solnData(PRSA_VAR,i,j,k))) + +#endif + +#if defined(VELX_VAR) && defined(VLXA_VAR) + ! velocity Linf error + lMax(15) = max(lMax(15), abs(solndata(VELX_VAR,i,j,k)-solnData(VLXA_VAR,i,j,k))) +#endif + enddo + enddo + enddo + call Grid_releaseBlkPtr(blockList(lb), solnData) + + deallocate(xCenter) + deallocate(yCenter) + deallocate(zCenter) + enddo + + + + ! Now the MASTER_PE sums the local contributions from all of + ! the processors and writes the total to a file. + + call MPI_Reduce (lsum, gsum, nGlobalSumUsed, FLASH_REAL, MPI_SUM, & + & MASTER_PE, io_globalComm, error) + call MPI_Reduce (lMax, gMax, nGlobalExtProp, FLASH_REAL, MPI_MAX, & + & MASTER_PE, io_globalComm, error) + + + if (io_globalMe == MASTER_PE) then + +#if defined(DENS_VAR) && defined(DENA_VAR) + ! density L1 error + gRelErrSum(1) = gsum(15) / gsum(10) +#endif + +#if defined(PRES_VAR) && defined(PRSA_VAR) + ! pressure L1 error + gRelErrSum(2) = gsum(16) / gsum(11) +#endif + +#if defined(VELX_VAR) && defined(VLXA_VAR) + ! velocity L1 error + gRelErrSum(3) = gsum(17) / max(gsum(12),sim_smallu) +#endif + +#if defined(VELY_VAR) && defined(VLYA_VAR) + ! Y-velocity L1 error + gRelErrSum(4) = gsum(18) / max(gsum(13),sim_smallu) +#endif + +#if defined(VELZ_VAR) && defined(VLZA_VAR) + ! Z-velocity L1 error + gRelErrSum(5) = gsum(19) / max(gsum(14),sim_smallu) +#endif + +#ifdef DENS_VAR + ! density + lMax(2) = gMax(2) + gMax(2) = -gMax(2) +#endif + +#ifdef PRES_VAR + ! pressure + lMax(4) = gMax(4) + gMax(4) = -gMax(4) +#endif + +#ifdef VELX_VAR + ! velocity + lMax(6) = gMax(6) + gMax(6) = -gMax(6) +#endif + +#ifdef DENA_VAR + ! analytic density + lMax(8) = gMax(8) + gMax(8) = -gMax(8) +#endif + +#ifdef PRSA_VAR + ! analytic pressure + lMax(10) = gMax(10) + gMax(10) = -gMax(10) +#endif + +#ifdef VLXA_VAR + ! analytic velocity + lMax(12) = gMax(12) + gMax(12) = -gMax(12) +#endif + +#if defined(DENA_VAR) && defined(DENA_VAR) + ! density Linf error + gRelErrMax(1) = gMax(13) / max(gMax(7),lMax(8)) +#endif + +#if defined(PRES_VAR) && defined(PRSA_VAR) + ! pressure Linf error + gRelErrMax(2) = gMax(14) / max(gMax(9),lMax(10)) +#endif + +#if defined(VELX_VAR) && defined(VLXA_VAR) + ! velocity Linf error + gRelErrMax(3) = gMax(15) / max(gMax(11),lMax(12),sim_smallu) +#endif + + ! create the file from scratch if it is a not a restart simulation, + ! otherwise append to the end of the file + + recl = max(1024,43*26+2) + !No matter what, we are opening the file. Check to see if already there + ioStat = 0 + open(funit, file=trim(io_statsFileName), position='APPEND', status='OLD', iostat=ioStat,RECL=recl) + if(ioStat .NE. 0) then + !print *, 'FILE FOUND' + open(funit, file=trim(io_statsFileName), position='APPEND',RECL=recl) + endif + + if (isFirst .EQ. 1 .AND. (.NOT. io_restart .or. ioStat .NE. 0)) then + +#ifndef MAGP_VAR + write (funit, 10) & + '#time ', & + 'mass ', & + 'x-momentum ', & + 'y-momentum ', & + 'z-momentum ', & + 'E_total ', & + 'E_kinetic ', & + 'E_internal ', & + '|| pres ||_1 ', & + '|| velx ||_1 ', & + '|| dens_ana ||_1 ', & + '|| pres_ana ||_1 ', & + '|| velx_ana ||_1 ','|| vely_ana ||_1 ','|| velz_ana ||_1 ', & + '|| Density Error ||_1 ', & + '|| Pressure Error ||_1 ','|| x-velocity error ||_1 ','|| y-velocity error ||_1 ', & + '|| z-velocity error ||_1 ', & + 'rel density error L1 ', & + 'rel pressure error L1 ','rel x-velocity error L1 ','rel y-velocity error L1 ', & + 'rel z-velocity error L1 ', & + 'rel density error Linf ', & + 'rel pressure error Linf ', & + 'rel x-velocity error Linf ', & + 'max dens ', 'min dens ', & + 'max pres ', 'min pres ', & + 'max velx ', 'min velx ', & + 'max dens_ana ', 'min dens_ana ', & + 'max pres_ana ', 'min pres_ana ', & + 'max velx_ana ', 'min velx_ana ', & + '|| Density Error ||_infty ', & + '|| Pressure Error ||_infty', & + '|| x-velocity error ||_inf', & + (msName(ivar),ivar=MASS_SCALARS_BEGIN,& + min(MASS_SCALARS_END,& + MASS_SCALARS_BEGIN+nGlobalSumUsed-nGlobalSumProp-1)) + +#else + + write (funit, 10) & + '#time ', & + 'mass ', & + 'x-momentum ', & + 'y-momentum ', & + 'z-momentum ', & + 'E_total ', & + 'E_kinetic ', & + 'E_internal ', & + 'MagEnergy ', & + '|| pres ||_1 ', & + '|| velx ||_1 ', & + '|| dens_ana ||_1 ', & + '|| pres_ana ||_1 ', & + '|| velx_ana ||_1 ','|| vely_ana ||_1 ','|| velz_ana ||_1 ', & + '|| Density Error ||_1 ', & + '|| Pressure Error ||_1 ', & + '|| x-velocity error ||_1 ','|| y-velocity error ||_1 ','|| z-velocity error ||_1 ', & + 'rel density error L1 ', & + 'rel pressure error L1 ', & + 'rel x-velocity error L1 ','rel y-velocity error L1 ','rel z-velocity error L1 ', & + 'rel density error Linf ', & + 'rel pressure error Linf ', & + 'rel x-velocity error Linf ', & + 'max dens ', 'min dens ', & + 'max pres ', 'min pres ', & + 'max velx ', 'min velx ', & + 'max dens_ana ', 'min dens_ana ', & + 'max pres_ana ', 'min pres_ana ', & + 'max velx_ana ', 'min velx_ana ', & + '|| Density Error ||_infty ', & + '|| Pressure Error ||_infty', & + '|| x-velocity error ||_inf', & + (msName(ivar),ivar=MASS_SCALARS_BEGIN,& + min(MASS_SCALARS_END,& + MASS_SCALARS_BEGIN+nGlobalSumUsed-nGlobalSumProp-1)) +#endif + +10 format (2x,99(a25, :, 1X)) + + else if(isFirst .EQ. 1) then + write (funit, 11) +11 format('# simulation restarted') + endif + + ! Write the global sums to the file. + if (nGlobalSumProp+1 .LE. nGlobalSumUsed) then + write (funit, 12) simtime, gsum(1:nGlobalSumProp),gRelErrSum, & + gRelErrMax, & + gMax, & + gsum(nGlobalSumProp+1:nGlobalSumUsed) + else + write (funit, 12) simtime, gsum(1:nGlobalSumProp),gRelErrSum, & + gRelErrMax, & + gMax + end if + +12 format (1x, 50(es25.18, :, 1x)) + + close (funit) ! Close the file. + + if (simTime .GE. sim_earliestLSTime .AND. & + simTime .LE. sim_latestLSTime) then + call Driver_getDt(dt) + currentTimeLargest(0) = dt + currentTimeLargest(1:nGlobalSumProp) = gsum(:nGlobalSumProp) + currentTimeLargest(nGlobalSumProp+ 1 : nGlobalSumProp+ nRelErrSumProp) = gRelErrSum(:) + currentTimeLargest(nGlobalSumProp+ nRelErrSumProp+1 : nGlobalSumProp+ nRelErrProp ) = gRelErrMax(:) + currentTimeLargest(nGlobalSumProp+ nRelErrProp +1 : nLargestMaxSummary) = gMax(:) + + if (.NOT.sim_testInitialized) then + sim_testFirstVals(0:nLargestMaxSummary) = currentTimeLargest(0:nLargestMaxSummary) + sim_testLargestVals(0:nLargestMaxSummary) = currentTimeLargest(0:nLargestMaxSummary) + sim_testLargestWhen(0:nLargestMaxSummary) = simTime + sim_testInitialized = .TRUE. + end if + sim_testLastVals(0:nLargestMaxSummary) = currentTimeLargest(0:nLargestMaxSummary) + do i=0,nLargestMaxSummary + if (sim_testLastVals(i) > sim_testLargestVals(i)) then +!!$ print*,'sim_testLastVals increases for',i,' from',sim_testLargestVals(i),' to',sim_testLastVals(i),'at', simTime,dt + sim_testLargestVals(i) = sim_testLastVals(i) + sim_testLargestWhen(i) = simTime + end if + end do + endif + end if + + call MPI_Barrier (io_globalComm, error) + + call Timers_stop("writeIntegQ") + + !============================================================================= + + return + + contains + character(len=25) function msName(ivar) + integer,intent(in) :: ivar + character(len=25) :: str + call Simulation_mapIntToStr(ivar,str,MAPBLOCK_UNK) + msName = str + end function msName +end subroutine IO_writeIntegralQuantities + + + diff --git a/Makefile b/Makefile new file mode 100644 index 0000000..c007063 --- /dev/null +++ b/Makefile @@ -0,0 +1,3 @@ + +Simulation += Simulation_data.o + diff --git a/Sedov_hedp_regime.par b/Sedov_hedp_regime.par new file mode 100644 index 0000000..242be55 --- /dev/null +++ b/Sedov_hedp_regime.par @@ -0,0 +1,134 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E9 #1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1.E14 #1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01E-7 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05E-7 + +dtinit = 1.0E-17 +dtmax = 1.E5 +dtmin = 1.0E-17 + + + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "vanLeer" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .true. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/Sedov_thscTest.par b/Sedov_thscTest.par new file mode 100644 index 0000000..2e4bef6 --- /dev/null +++ b/Sedov_thscTest.par @@ -0,0 +1,227 @@ +#Runtime parameters for testing the ThomsonScattering unit with a Sedov explosion problem. + +# ./setup -auto -objdir=Composite_Sedov_AMR_non-threaded_3d -3d Sedov -makefile=gnu -debug +uhd3t +pm4dev -unit=diagnostics/ThomsonScattering -noc +mtmmmt species=h thsc_maxBeams=1 thsc_maxDetectors=1 thsc_maxPulseSections=2 thsc_maxPulses=1 -parfile=Sedov_thscTest.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E9 #1.E-5 +sim_rhoAmbient = 1.e-4 +sim_expEnergy = 1.E17 #1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + + +### SETUP PROBE LASER PULSES FOR Thomson SCATTERING ### +thsc_numberOfPulses = 1 + +# Define Pulse 1: +thsc_numberOfSections_1 = 2 +thsc_time_1_1 = 0.0 +thsc_time_1_2 = 1.0e-09 + +thsc_power_1_1 = 40.0e9 +thsc_power_1_2 = 40.0e9 + + +### SETUP LASER BEAM ### +thsc_numberOfBeams = 1 + +# Setup Gaussian Beam 1: +thsc_beamLensX_1 = 0.5 +thsc_beamLensY_1 = -1.0 +thsc_beamLensZ_1 = 0.5 +thsc_lensSemiAxisMajor_1 = 50.0e-03 +thsc_beamTargetX_1 = 0.5 +thsc_beamTargetY_1 = 10.0e-03 +thsc_beamTargetZ_1 = 0.5 +thsc_targetSemiAxisMajor_1 = 50.0e-03 +thsc_targetSemiAxisMinor_1 = 50.0e-03 +thsc_beamPowerMeasureDist1_1 = 0 +thsc_beamPowerMeasureDist2_1 = 0.25 +thsc_pulseNumber_1 = 1 +thsc_wavelength_1 = 0.5265 # 1.053 / 2 +thsc_crossSectionFunctionType_1 = "gaussian2D" +thsc_gaussianExponent_1 = 1.0 +thsc_gaussianRadiusMajor_1 = 120.1122e-04 +thsc_gaussianRadiusMinor_1 = 120.1122e-04 +thsc_semiAxisMajorTorsionAxis_1 = "z" +thsc_semiAxisMajorTorsionAngle_1 = 0.0 +thsc_gridType_1 = "square2D" +thsc_beamDetector_1 = 1 + +thsc_nSubZonesI = 2 +thsc_nSubZonesJ = 2 +thsc_nSubZonesK = 2 + +thsc_numberOfDetectors = 1 +thsc_detectorApertureAngle_1 = 70 # 20 +thsc_detectorTargetRadius_1 = 16.0e-03 +thsc_detectorCenterX_1 = .1 +thsc_detectorCenterY_1 = .1 +thsc_detectorCenterZ_1 = .1 +thsc_detectorTargetX_1 = .5 +thsc_detectorTargetY_1 = .5 +thsc_detectorTargetZ_1 = .5 +thsc_dOmegaOfDetector_1 = 1.0 + +thsc_detectorXYwriteFormat = "(1P,G18.8)" #"es18.8" +thsc_detectorDGwriteFormat = "(-1PG15.5)" #"es15.5" +thsc_detectorWriteAnglesInDeg = .TRUE. +thsc_detectorWriteTempInKeV = .TRUE. +thsc_detectorFileAllowOverwrite = .TRUE. +thsc_computeSpectra = .TRUE. +thsc_spectrumFileAllowOverwrite = .TRUE. +thsc_spectrumLamsMin_1 = 525.75 # minimum scattered wavelength (nm) +thsc_spectrumLamsMax_1 = 527.25 # maximum scattered wavelength (nm) +thsc_spectrumNpts_1 = 50000 + +thsc_detectedRayDiagnostics = .TRUE. +thsc_printPulses = .TRUE. +thsc_printBeams = .TRUE. +thsc_printDetectors = .TRUE. +thsc_printMain = .TRUE. + +threadThomsonScBlockList = .TRUE. +threadThomsonScWithinBlock = .FALSE. + +# Gas ratio of specific heats + +gamma = 1.6666666666667 # 1.4 +ms_hA = 1.00794 +ms_hZ = 1.0 +eos_hEosType = "EOS_GAM" +eosModeInit = "dens_ie_scatter" + +smallT = 1.0e-1 +eos_maxNewton = 50 +eos_tolerance = 1.e-8 +eos_maxFactorUp = 100.0 +eos_maxFactorDown = 0.001 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01E-7 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 1 #10000 +tmax = 0.05E-7 + +dtinit = 1.0E-17 +dtmax = 1.E5 +dtmin = 1.0E-17 + + + +run_comment = "Sedov explosion" +log_file = "sedov.log" +#eachProcWritesSummary = .TRUE. +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +#lrefine_min_init = 1 +lrefine_max = 4 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +#useHydro = .FALSE. +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "vanLeer" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + +##use_avisc = .true. # use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +##use_flattening = .false. # use flattening (dissipative) (originally for PPM) +##use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .true. # Shock Detect for numerical stability +#shockLowerCFL = .TRUE. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/Simulation_adjustEvolution.F90 b/Simulation_adjustEvolution.F90 new file mode 100644 index 0000000..3a79ecc --- /dev/null +++ b/Simulation_adjustEvolution.F90 @@ -0,0 +1,69 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_adjustEvolution +!! +!! NAME +!! Simulation_adjustEvolution +!! +!! +!! SYNOPSIS +!! Simulation_adjustEvolution( integer(IN) :: blkcnt, +!! integer(IN) :: blklst(blkcnt), +!! integer(IN) :: nstep, +!! real(IN) :: dt, +!! real(IN) :: stime ) +!! +!! DESCRIPTION +!! This routine is called every cycle. It can be used to adjust +!! the simulation while it is running. +!! +!! ARGUMENTS +!! blkcnt - number of blocks +!! blklst - block list +!! nstep - current cycle number +!! dt - current time step length +!! stime - current simulation time +!! +!!*** + +#include "Flash.h" + +subroutine Simulation_adjustEvolution(blkcnt, blklst, nstep, dt, stime) + use Simulation_interface, ONLY: Simulation_computeAnalytical + use Grid_interface, ONLY : Grid_dump + use Timers_interface, ONLY : Timers_start, Timers_stop + + use Driver_data, ONLY: dr_simTime, dr_initialSimTime + implicit none + + integer, intent(in) :: blkcnt + integer, intent(in) :: blklst(blkcnt) + integer, intent(in) :: nstep + real, intent(in) :: dt + real, intent(in) :: stime + +#if NDIM==1 + real :: tnew + integer :: lb + + call Timers_start("adjustEvo") + + if (dr_simTime .LE. dr_initialSimTime) then + do lb = 1, blkcnt + call Grid_dump((/DENS_VAR,PRES_VAR,VELX_VAR,EINT_VAR/),4, blklst(lb),gcell=.FALSE.) + end do + end if + + +!!$ ! We want the NEW time that we are advancing TO. +!!$ ! This is based on where Simulation_adjustEvolution is called from Driver_evolveFlash: +!!$ ! dr_simTime has not been updated yet at this point. +!!$ !!DEV: Check whether this needs adjustments for non-"Unsplit" Driver_evolveFlash.F90 ! +!!$ !!DEV: Check whether this needs adjustments for when STS is used! +!!$ tnew = stime+dt +!!$ +!!$ do lb = 1, blkcnt +!!$ call Simulation_computeAnalytical(blklst(lb), tnew) +!!$ end do + call Timers_stop("adjustEvo") +#endif + +end subroutine Simulation_adjustEvolution diff --git a/Simulation_computeAnalytical.F90.analytical b/Simulation_computeAnalytical.F90.analytical new file mode 100644 index 0000000..5937b4b --- /dev/null +++ b/Simulation_computeAnalytical.F90.analytical @@ -0,0 +1,387 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_computeAnalytical +!! +!! NAME +!! +!! Simulation_computeAnalytical +!! +!! +!! SYNOPSIS +!! +!! call Simulation_computeAnalytical(integer(IN) :: blockID, +!! real(IN) :: tcurr) +!! +!! +!! +!! DESCRIPTION +!! +!! Compute an analytical solution for +!! a specified block. +!! +!! ARGUMENTS +!! +!! blockID - the number of the block to initialize +!! tcurr - current time +!! +!! +!! SIDE EFFECTS +!! +!! The analytical solution is computed and stored in the appropriate slots +!! in the solution vector, UNK. +!! +!! In this implementation, the following UNK variables are set: +!! !!DEV : changed UNK variables - to be documented. +!! +!!*** + +subroutine Simulation_computeAnalytical(blockID, tcurr) + + use Simulation_data, ONLY: sim_xMax, sim_xMin, sim_yMax, sim_yMin, sim_zMax, sim_zMin, & + & sim_nProfile, sim_rProf, sim_vProf, sim_pProf, sim_pExp, sim_rhoProf, & + & sim_tInitial, sim_gamma, sim_expEnergy, sim_pAmbient, sim_rhoAmbient, & + & sim_analyticTime, sim_analyticGen, & + & sim_useProfileFromFile, sim_profileInitial, & + & sim_smallX, sim_smallRho, sim_minRhoInit, sim_smallP, sim_rInit, & + & sim_smallT, & + & sim_nSubZones, sim_xCenter, sim_yCenter, sim_zCenter, sim_inSubzones, sim_inszd, & + sim_threadBlockList, sim_threadWithinBlock + use Driver_data, ONLY : dr_simGeneration + use Grid_interface, ONLY : Grid_getBlkPtr, Grid_releaseBlkPtr, & + Grid_getBlkIndexLimits, & + Grid_getDeltas, Grid_getCellCoords, Grid_subcellGeometry + use Driver_interface, ONLY : Driver_getSimTime + use Timers_interface, ONLY : Timers_start, Timers_stop + use ut_interpolationInterface + + + implicit none + +#include "constants.h" +#include "Flash.h" +!#include "Eos.h" + + ! compute the maximum length of a vector in each coordinate direction + ! (including guardcells) + + integer, intent(in) :: blockID + real, intent(in) :: tcurr + + integer,parameter :: op = 2 + integer :: i, j, k, jLo, jHi + integer :: ii, jj, kk, kat + integer :: simGen + real :: drProf + real :: distInv, xDist, yDist, zDist + real :: sumRho, sumP, sumVX, sumVY, sumVZ + real :: vel, diagonal + real :: xx, dxx, yy, dyy, zz, dzz, frac + real :: vx, vy, vz, p, rho, e, ek, eint + real :: dist + real :: vSub, rhoSub, pSub, errIgnored + real :: simTime + real,allocatable,dimension(:) :: xCoord,yCoord,zCoord + integer :: sizeX,sizeY,sizeZ + integer, dimension(2,MDIM) :: blkLimits, blkLimitsGC + real, dimension(:,:,:,:),pointer :: solnData + +!!$ real :: dvSub(0:sim_nSubZones-1,0:(sim_nSubZones-1)*K2D) + real,allocatable :: dvSub(:,:) + real :: dvc, quotinv + + logical :: gcell = .true. + + + if (tcurr == sim_analyticTime) then + call Driver_getSimTime(simTime, simGen) + if (simTime == sim_analyticTime) then + if (simGen == sim_analyticGen) then + ! analytical solution is already computed for the current time, and + ! per (simGen test) the grid does not seem to have changed - + RETURN ! return immediately + end if + end if + end if + + +!!$ call Timers_start("computeAna 1") + + if (sim_useProfileFromFile) then + ! Prepare the solution that has been read in for use in interpolation + if (sim_tinitial > 0.0) call sim_scaleProfile(tcurr) ! DEV: Is tcurr right time? + else + ! + ! Construct the radial samples needed for the initialization. + ! + diagonal = (sim_xMax-sim_xMin)**2 + diagonal = diagonal + K2D*(sim_yMax-sim_yMin)**2 + diagonal = diagonal + K3D*(sim_zMax-sim_zMin)**2 + diagonal = sqrt(diagonal) + + drProf = diagonal / (sim_nProfile-1) + + do i = 1, sim_nProfile + sim_rProf(i) = (i-1) * drProf + enddo + ! + ! Use the analytic Sedov solution implemented in Simulation_initBlock, + ! WHICH IS WRONG. + ! + call set_analytic_sedov (sim_nProfile, sim_rProf, sim_rhoProf, sim_pProf, & + sim_vProf, tcurr, sim_gamma, sim_expEnergy, & + sim_pAmbient, sim_rhoAmbient) + end if !useProfileFromFile + +!!$ call Timers_stop("computeAna 1") +!!$ call Timers_start("computeAna 2") + + ! get the coordinate information for the current block from the database + + call Grid_getBlkIndexLimits(blockId,blkLimits,blkLimitsGC) + sizeX = blkLimitsGC(HIGH,IAXIS) - blkLimitsGC(LOW,IAXIS) + 1 + allocate(xCoord(sizeX)); xCoord = 0.0 + sizeY = blkLimitsGC(HIGH,JAXIS) - blkLimitsGC(LOW,JAXIS) + 1 + allocate(yCoord(sizeY)); yCoord = 0.0 + sizeZ = blkLimitsGC(HIGH,KAXIS) - blkLimitsGC(LOW,KAXIS) + 1 + allocate(zCoord(sizeZ)); zCoord = 0.0 + + if (NDIM == 3) call Grid_getCellCoords& + (KAXIS, blockId, CENTER, gcell, zCoord, sizeZ) + if (NDIM >= 2) call Grid_getCellCoords& + (JAXIS, blockId, CENTER,gcell, yCoord, sizeY) + call Grid_getCellCoords(IAXIS, blockId, CENTER, gcell, xCoord, sizeX) + ! + ! For each cell + ! + call Grid_getBlkPtr(blockId,solnData) + + !There is no parallel region in Grid_initDomain or other code from + !which this routine is expected to be called, and so we use the + !same thread within block code for both multithreading strategies. + + !$omp parallel if (sim_threadBlockList .or. sim_threadWithinBlock) & + !$omp default(none) & + !$omp shared(blkLimitsGC,xCoord,yCoord,zCoord,blockID,& + !$omp sim_inSubzones,sim_nSubZones,sim_rProf,sim_minRhoInit,sim_smallRho,sim_smallP,& + !$omp sim_smallX,sim_pProf,sim_rhoProf,sim_vProf,sim_gamma,sim_inszd,& + !$omp sim_smallT,& + !$omp sim_useProfileFromFile,errIgnored,solnData, & + !$omp sim_rhoAmbient,sim_pAmbient, & + !$omp sim_xCenter,sim_yCenter,sim_zCenter) & + !$omp private(i,j,k,ii,jj,kk,dxx,dyy,dzz,sumRho,sumP,sumVX,sumVY,sumVZ,& + !$omp xx,yy,zz,xDist,yDist,zDist,dist,distInv,jLo,jHi,frac,vel,& + !$omp rho,p,vx,vy,vz,ek,e,eint,kat,rhoSub,pSub,vSub,dvc,quotinv,dvSub) + + allocate(dvSub(0:sim_nSubZones-1,0:(sim_nSubZones-1)*K2D)) + +#if NDIM == 3 + !$omp do schedule(static) +#endif + do k = blkLimitsGC(LOW,KAXIS), blkLimitsGC(HIGH,KAXIS) + ! Find a real difference between z's if problem is >= 3D + if (NDIM > 2) then + if (k .eq. 1) then + dzz = zCoord(2) - zCoord(1) + else + dzz = zCoord(k) - zCoord(k-1) + endif + ! Otherwise this problem is <= 2D, so dzz is meaningless + else + dzz = 0.0 + endif + zz = zCoord(k) + +#if NDIM == 2 + !$omp do schedule(static) +#endif + do j = blkLimitsGC(LOW, JAXIS), blkLimitsGC(HIGH, JAXIS) + ! Find a real difference between y's if problem is >= 2D + if (NDIM > 1) then + if (j .eq. 1) then + dyy = yCoord(2) - yCoord(1) + else + dyy = yCoord(j) - yCoord(j-1) + endif + ! Otherwise this problem is <= 1D, so dyy is meaningless + else + dyy = 0.0 + endif + yy = yCoord(j) + +#if NDIM == 1 + !$omp do schedule(static) +#endif + do i = blkLimitsGC(LOW,IAXIS), blkLimitsGC(HIGH, IAXIS) + xx = xCoord(i) + if (i .eq. 1) then + dxx = xCoord(2) - xCoord(1) + else + dxx = xCoord(i) - xCoord(i-1) + endif + + call Grid_getSingleCellVol(blockID, EXTERIOR, (/i,j,k/), dvc) + call Grid_subcellGeometry(sim_nSubZones,1+(sim_nSubZones-1)*K2D,1+(sim_nSubZones-1)*K3D, & + dvc, dvSub, xCoord(i)-0.5*dxx, xCoord(i)+0.5*dxx, & + blockID = blockID) + + + sumRho = 0. + sumP = 0. + sumVX = 0. + sumVY = 0. + sumVZ = 0. + + ! + ! Break the cell into sim_nSubZones^NDIM sub-zones, and look up the + ! appropriate quantities along the 1d profile for that subzone. + ! + ! Have the final values for the zone be equal to the average of + ! the subzone values. + ! + + do kk = 0, (sim_nSubZones-1)*K3D + zz = zCoord(k) + ((real(kk)+0.5)*sim_inSubzones-.5)*dzz + zDist = (zz - sim_zCenter) * K3D + + do jj = 0, (sim_nSubZones-1)*K2D + yy = yCoord(j) + ((real(jj)+0.5)*sim_inSubzones-.5)*dyy + yDist = (yy - sim_yCenter) * K2D + + do ii = 0, (sim_nSubZones-1) + xx = xCoord(i) + ((real(ii)+0.5)*sim_inSubzones-.5)*dxx + xDist = xx - sim_xCenter + + dist = sqrt( xDist**2 + yDist**2 + zDist**2 ) + distInv = 1. / max( dist, 1.E-10 ) + if (sim_useProfileFromFile) then + if (dist .LE. sim_rProf(sim_nProfile+1)) then + call ut_hunt(sim_rProf,sim_nProfile+1,dist,kat) + kat = max(1, min(kat - op/2 + 1, sim_nProfile - op + 2)) + call ut_polint(sim_rProf(kat),sim_vProf (kat),op,dist,vSub ,errIgnored) + call ut_polint(sim_rProf(kat),sim_rhoProf(kat),op,dist,rhoSub,errIgnored) + call ut_polint(sim_rProf(kat),sim_pProf (kat),op,dist,pSub ,errIgnored) + else + vSub = 0.0 + rhoSub = sim_rhoAmbient + psub = sim_pAmbient + end if + else + call sim_find (sim_rProf, sim_nProfile, dist, jLo) + ! + ! a point at `dist' is frac-way between jLo and jHi. We do a + ! linear interpolation of the quantities at jLo and jHi and sum those. + ! + if (jLo .eq. 0) then + jLo = 1 + jHi = 1 + frac = 0. + else if (jLo .eq. sim_nProfile) then + jLo = sim_nProfile + jHi = sim_nProfile + frac = 0. + else + jHi = jLo + 1 + frac = (dist - sim_rProf(jLo)) / & + (sim_rProf(jHi)-sim_rProf(jLo)) + endif + + pSub = sim_pProf(jLo) + frac*(sim_pProf(jHi) - sim_pProf(jLo)) + + rhoSub = sim_rhoProf(jLo) + frac*(sim_rhoProf(jHi)- sim_rhoProf(jLo)) + rhoSub = max(rhoSub, sim_minRhoInit) + + vSub = sim_vProf(jLo) + frac*(sim_vProf(jHi) - sim_vProf(jLo)) + + end if + ! + ! Now total these quantities. Note that v is a radial velocity; + ! we multiply by the tangents of the appropriate angles to get + ! the projections in the x, y and z directions. + ! + sumP = sumP + pSub * dvSub(ii,jj) + + sumRho = sumRho + rhoSub * dvSub(ii,jj) + + vel = vSub * dvSub(ii,jj) + + sumVX = sumVX + vel*xDist*distInv + sumVY = sumVY + vel*yDist*distInv + sumVZ = sumVZ + vel*zDist*distInv + + enddo + enddo + enddo + +!!$ quotinv = sim_inszd + quotinv = 1.0 / dvc + rho = max(sumRho * quotinv, sim_smallRho) + p = max(sumP * quotinv, sim_smallP) + vx = sumVX * quotinv + vy = sumVY * quotinv + vz = sumVZ * quotinv + ek = 0.5*(vx*vx + vy*vy + vz*vz) + ! + ! assume gamma-law equation of state + ! + e = p/(sim_gamma-1.) + eint= e/rho + e = e/rho + ek + e = max (e, sim_smallP) + + +!!$ if (NSPECIES > 0) then +!!$ solnData(SPECIES_BEGIN,i,j,k)=1.0-(NSPECIES-1)*sim_smallX +!!$ solnData(SPECIES_BEGIN+1:SPECIES_END,i,j,k)=sim_smallX +!!$ end if +!!$ solnData(DENS_VAR,i,j,k)=rho +!!$ solnData(PRES_VAR,i,j,k)=p +!!$ solnData(ENER_VAR,i,j,k)=e +!!$#ifdef EINT_VAR +!!$ solnData(EINT_VAR,i,j,k)=eint +!!$#endif +!!$ solnData(GAME_VAR,i,j,k)=sim_gamma +!!$ solnData(GAMC_VAR,i,j,k)=sim_gamma +!!$ solnData(VELX_VAR,i,j,k)=vx +!!$ solnData(VELY_VAR,i,j,k)=vy +!!$ solnData(VELZ_VAR,i,j,k)=vz +!!$ solnData(TEMP_VAR,i,j,k)=sim_smallT + + solnData(DENA_VAR,i,j,k)=rho + solnData(PRSA_VAR,i,j,k)=p +#ifdef ENRA_VAR + solnData(ENRA_VAR,i,j,k)=e +#endif +#ifdef EINA_VAR + solnData(EINA_VAR,i,j,k)=eint +#endif + solnData(VLXA_VAR,i,j,k)=vx +#ifdef VLYA_VAR + solnData(VLYA_VAR,i,j,k)=vy +#endif +#ifdef VLZA_VAR + solnData(VLZA_VAR,i,j,k)=vz +#endif + enddo +#if NDIM == 1 + !$omp end do nowait +#endif + enddo +#if NDIM == 2 + !$omp end do nowait +#endif + enddo +#if NDIM == 3 + !$omp end do nowait +#endif + deallocate(dvSub) + !$omp end parallel + + call Grid_releaseBlkPtr(blockID, solnData) + + deallocate(xCoord) + deallocate(yCoord) + deallocate(zCoord) + + sim_analyticTime = tcurr + +!!$ call Timers_stop("computeAna 2") + +end subroutine Simulation_computeAnalytical diff --git a/Simulation_data.F90 b/Simulation_data.F90 new file mode 100644 index 0000000..fed1eac --- /dev/null +++ b/Simulation_data.F90 @@ -0,0 +1,88 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_data +!! +!! NAME +!! +!! Simulation_data +!! +!! SYNOPSIS +!! +!! use Simulation_data +!! +!! DESCRIPTION +!! +!! Stores the local data for Simulation setup: Sedov +!! +!! PARAMETERS +!! +!! sim_pAmbient Initial ambient pressure +!! sim_rhoAmbient Initial ambient density +!! sim_tempAmbient Initial ambient temperature +!! sim_nsubzones Number of `sub-zones' in cells for applying 1d profile +!! +!! +!!*** + +module Simulation_data + + implicit none +#include "constants.h" +#include "Flash.h" + + real,parameter :: sim_pi = PI + + !! *** Runtime Parameters *** !! + + real, save :: sim_pAmbient, sim_rhoAmbient, sim_tempAmbient + real, save :: sim_gamma, R_sp + real, save :: sim_smallX, sim_smallRho, sim_smallP, sim_minRhoInit + real, save :: sim_smallT + real, save :: sim_smallu + real, save :: sim_xMin, sim_xMax, sim_yMin, sim_yMax, sim_zMin, sim_zMax + real, save :: sim_exl, sim_exu, sim_eyl, sim_eyu, sim_vx, sim_vy, sim_vz ! electrode dimensions + real, save :: sim_pxl, sim_pxu, sim_pyl, sim_pyu ! Plasma channel initial dimensions + integer, save :: sim_nSubZones + real, save :: sim_tInitial + logical, save :: sim_forceCenterDerefine + integer, save :: sim_centerRefineLevel + real, save :: sim_derefineRadius + logical, save :: sim_bcSetBdryVar + logical, save :: sim_oneLevelIntegralsOnly + integer,save :: sim_integralsLevel = 0 + + !! *** Variables pertaining to this Simulation *** !! + + integer, parameter :: sim_nProfile = 10000 + real , save :: sim_inSubZones, sim_inSubzm1 + real , save :: sim_inszd + real, dimension(4,sim_nProfile+1), save :: sim_profileInitial + real, save :: sim_pExp + logical, save :: sim_useProfileFromFile = .FALSE. + character(len=MAX_STRING_LENGTH), save :: sim_profFileName + logical,save :: sim_profileIsScaled = .FALSE. + real ,save :: sim_profileScaledTime=0.0 + real ,save :: sim_analyticTime + integer,save :: sim_analyticGen + + integer, save :: sim_meshMe, sim_globalMe + integer, save :: sim_globalNumProcs + logical, save :: sim_threadBlockList = .false. + logical, save :: sim_threadWithinBlock = .false. + + integer, save :: sim_fileUnitOutNum = 91, sim_fileUnitOutAna = 92 !initial values not really used + character(len=80) :: sim_ffNum, sim_ffAna + +#ifdef MAGP_VAR + ! Cf. IO_writeIntegralQuantities, should be nGlobalSumProp+2*nRelErrSumProp+nGlobaExtProp + integer,parameter :: nLargestMaxSummary = 20 + 5 + 3 + 15 +#else + integer,parameter :: nLargestMaxSummary = 19 + 5 + 3 + 15 +#endif + logical, save :: sim_testInitialized + real, save :: sim_testFirstVals(0:nLargestMaxSummary) + real, save :: sim_testLastVals(0:nLargestMaxSummary) + real, save :: sim_testLargestVals(0:nLargestMaxSummary) + real, save :: sim_testLargestWhen(0:nLargestMaxSummary) + + real, save :: sim_earliestLSTime, sim_latestLSTime + real, save :: sim_smallestNormRadius, sim_largestNormRadius +end module Simulation_data diff --git a/Simulation_defineDomain.F90 b/Simulation_defineDomain.F90 new file mode 100644 index 0000000..ede0b7c --- /dev/null +++ b/Simulation_defineDomain.F90 @@ -0,0 +1,205 @@ +!!****f* source/Simulation/Simulation_defineDomain +!! +!! NAME +!! +!! Simulation_defineDomain +!! +!! SYNOPSIS +!! +!! call Simulation_defineDomain(logical(:,:,:),OUT :: initialDomain, +!! integer(:,:,:,:),OUT :: boundaries, +!! integer(MDIM), IN :: nblks) +!! +!! +!! DESCRIPTION +!! +!! This routine provides a hook for defining domains that are not +!! shaped like boxes. The stub implementation returns a domain that is +!! shaped like a box. The users wishing to define a non-box like domain +!! should have a custom implementation of this routine in their +!! Simulations directory. Only domains that can be represented as +!! a union of non-overlapping same-size boxes place on an equally-space +!! grid can represented. +!! +!! This feature is currently only available with PARAMESH. When building +!! FLASH with UG, any Simulation_defineDomain is ignored. +!! +!! Conceptually, one defines an irregular domain by placing obstacle blocks +!! in a regular box-shaped domain. These obstacle blocks all have the +!! same physical size, and the original domain size must be a multiple +!! of this size in each dimesion. Obstacle may touch the outer boundaries +!! and each other, and can be combined to form walls etc. +!! +!! To use this feature: +!! 1) Set up a regular domain as usual. Use the nblockx, nblocky, and +!! nblockz runtime parameters to divide the domain equally into +!! a grid of nblockx*nblocky*nblockz original blocks. +!! 2) Provide an implementation of Simulation_defineDomain that marks +!! some of these original blocks with obstacles. Only the parts of +!! the original domain that are not so marked will end up being in +!! the physical domain. +!! PARAMESH will use the blocks that remain in the domain as root blocks +!! (with refinement level 1) and may adaptively refine (but not combine) +!! them as usual. +!! +!! To implement Simulation_defineDomain: For each block that belongs in the domain +!! the corresponding entry in the output array initialDomain is set true, and +!! the corresponding entries for all faces in the boundaries array are set to +!! "NOT_BOUNDARY". For the blocks that do not belong in the domain, the +!! corresponding initialDomain entries are set false. The boundaries entries +!! on faces that are adjacent to physical boundaries or to other blocks +!! not in the domain are redundant. However, those boundaries entries that +!! correspond to faces adjacent to the valid blocks in the domain must be +!! given appropriate boundary values. The example included illustrates how +!! to define a domain. +!! +!! This routine will be called with nblks set to the values given by the +!! paramesh runtime parameters nblockx, nblocky, and nblockz, and the +!! initialDomain and boundaries arrays will be dimensioned accordingly. +!! That is, the boundaries set by this routine apply to blocks at refinement +!! level 1. Any additional refinement levels are generated only after this +!! routine returns. +!! +!! ARGUMENTS +!! +!! nblks - Integer Array of size MDIM, containing the number of blocks along +!! each dimension +!! initialDomain - Logical 3D array of size nblks(IAXIS),nblks(JAXIS), +!! nblks(KAXIS) +!! If the block i,j,k is in the domain then on return +!! initialDomain(i,j,k)=.true. otherwise .false. +!! boundaries - integer array of size 2*MDIM,nblks(IAXIS),nblks(JAXIS), +!! nblks(KAXIS) +!! If the block i,j,k is in the domain, the values in +!! this array have no meaning. If the block is not in the +!! domain, but is adjacent to one or more blocks that +!! are in the domain, then the entries corresponding to +!! the common faces get initialized with appropriate +!! boundary values. +!! Constants for boundary conditions are defined in +!! "constants.h". Any boundary conditions in the allowed +!! range of numerical values -50..-20 can be used if they +!! are recognized by the GridBoundaryConditions implementation, +!! with the exception that PERIODIC is not allowed here. +!! +!! Example +!! Consider a 2D domain with the following shape with reflecting boundaries +!! +!! **** **** **** +!! * * +!! * * +!! * **** +!! * * +!! * * +!! * * +!! * * +!! * * +!! * * +!! **** * +!! * * +!! * * +!! **** **** **** +!! +!! It can be divided into 4x4 blocks as follows +!! **** **** **** **** +!! * T * T * T * F * +!! * * * * * +!! **** **** **** **** +!! * T * T * T * T * +!! * * * * * +!! **** **** **** **** +!! * T * T * T * T * +!! * * * * * +!! **** **** **** **** +!! * F * T * T * T * +!! * * * * * +!! **** **** **** **** +!! +!! This domain can be initialize through the following sequence of +!! instructions +!! +!! !! This implementation is meant to be used with NDIM==2. +!! initialDomain = .true. +!! boundaries = NOT_BOUNDARY +!! initialDomain(1,1,1)=.false. +!! boundaries(IHI_FACE,1,1,1)=REFLECTING +!! boundaries(JHI_FACE,1,1,1)=REFLECTING +!! initialDomain(4,4)=.false. +!! boundaries(ILO_FACE,4,4,1)=REFLECTING +!! boundaries(JLO_FACE,4,4,1)=REFLECTING +!! +!! NOTES +!! +!! To use any Simulation_defineDomain implementation that actually +!! removes blocks with Paramesh 4, it is currently necessary to increase +!! the value of the constant NBOUNDARIES. This preprocessor symbol is used +!! by Paramesh 4 to dimension certain arrays that store information on +!! boundary blocks. The value of NBOUNDARIES should be set to +!! 2*NDIM + (number of blocks for which this routine returns false). +!! This is most conveniently done with a PPDEFINE in a Config file before +!! setup. See the SodStep simulation as an example. FLASH will abort if +!! Simulation_defineDomain is used and NBOUNDARIES is too low. +!! +!! For users' convenience, the constants defining the low +!! and high faces along the dimensions are defined in "constants.h". +!! They can be used to specify the first index of the boundaries +!! array. They are {I,J,K}LO_FACE and {I,J,K}HI_FACE, respectively. +!! +!! Constants for boundary conditions like REFLECTING and OUTFLOW +!! are defined in "constants.h" as well. The most common of them +!! correspond to recognized values of the {xyz}{lr}_boundary_type +!! runtime parameters. +!! +!! This routine is only meaningful (and will only be called) when an +!! AMR Grid implementation is used. +!! +!! Particles have not been tested in combination with arbitrary +!! boundaries. Particles (active or passive) should not be used +!! in irregular domain, at least not if there is any chance that +!! a particle will run into an obstacle block. The behavior of +!! particles at obstacle boundaries should be considered as +!! undefined. +!! +!!*** + +subroutine Simulation_defineDomain(initialDomain,boundaries,nblks) +#include "constants.h" + implicit none + integer,dimension(MDIM),intent(IN) :: nblks + integer,dimension(2*MDIM,nblks(IAXIS),nblks(JAXIS),nblks(KAXIS)),& + intent(OUT)::boundaries + logical,dimension(nblks(IAXIS),nblks(JAXIS),nblks(KAXIS)),& + intent(OUT)::initialDomain + + integer :: i,j,ii,jj + REAL, DIMENSION(1) :: indX + REAL, DIMENSION(14) :: indY + + + ! Trying to create an obstacle geometry in the lower left corner of the domain + initialDomain = .true. + boundaries = NOT_BOUNDARY + + indX = (/1/) + indY = (/1,2,3,4,5,6,7,12,13,14,15,16,17,18/) + + do ii=1,size(indX) + do jj=1,size(indY) + + i = indX(ii) + j = indY(jj) + initialDomain(i, j, 1)=.false. + + ! no-slip corresponds to reflecting + ! x- boundaries + !boundaries(ILO_FACE,i,j,1)=REFLECTING ! no need for this as it doesn't touch the domain + boundaries(:,i,j,1)=REFLECTING + + enddo + enddo + + ! y-boundaries for the lower and upper part of the electrodes + !boundaries(JLO_FACE,i,j,1)=REFLECTING ! no need for this as it doesn't touch the domain + !boundaries(JHI_FACE,i,j,1)=REFLECTING + +end subroutine Simulation_defineDomain diff --git a/Simulation_finalize.F90 b/Simulation_finalize.F90 new file mode 100644 index 0000000..b396304 --- /dev/null +++ b/Simulation_finalize.F90 @@ -0,0 +1,142 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_finalize +!! +!! NAME +!! Simulation_finalize +!! +!! SYNOPSIS +!! +!! Simulation_finalize() +!! +!! DESCRIPTION +!! +!! This dummy function cleans up the Simulation unit, deallocates memory, etc. +!! However, as nothing needs to be done, only this stub is included. +!! +!! ARGUMENTS +!! +!! +!! +!!*** + +#include "Flash.h" +#include "constants.h" + +subroutine Simulation_finalize() + use Grid_interface, ONLY : Grid_getListOfBlocks, Grid_dump + use Simulation_data, ONLY: sim_fileUnitOutNum, sim_fileUnitOutAna + use Simulation_data, ONLY : sim_globalMe, & + nLargestMaxSummary, & + sim_testInitialized, & + sim_testFirstVals, & + sim_testLastVals, & + sim_testLargestVals, & + sim_testLargestWhen + + implicit none + + + character (len = MAX_STRING_LENGTH) :: fileName + + logical :: perfect, imperfect + + integer :: i + integer :: fileUnit + integer :: ut_getFreeFileUnit + real :: tols(4) + +#if NDIM==1 + integer :: blkcnt + integer :: blklst(MAXBLOCKS) + + integer :: lb + + call Grid_getListOfBlocks(LEAF,blklst,blkcnt) + do lb = 1, blkcnt + call Grid_dump((/DENS_VAR,PRES_VAR,VELX_VAR,EINT_VAR/),4, blklst(lb),gcell=.FALSE.) + end do +#endif + + close(sim_fileUnitOutNum) + close(sim_fileUnitOutAna) + + if (sim_globalMe .NE. MASTER_PE) return ! avoid writing lots of (empty) files if using many procs... + + perfect = .TRUE. + + tols(1) = 1.e-10 + tols(2) = 1.e-6 + tols(3) = 1.e-6 + tols(4) = 1.e-6 + + fileUnit = ut_getFreeFileUnit () + fileName = "LargestSummary.out" + + open (fileUnit, file = fileName) +!!$ if (sim_globalMe==MASTER_PE) then +!!$ do i=1,min(4,1+N_DIM) +!!$ imperfect = (abs(sim_testLargestVals(i)-sim_testRefVals(i)) > tols(i)) +!!$ perfect = (perfect .AND. .NOT. imperfect) +!!$ if (.NOT. perfect) then +!!$ select case (i) +!!$ case(1) +!!$ call Logfile_stamp(sim_testLargestWhen(i), & +!!$ '[Simulation_finalize] Total mass conservation - worst at') +!!$ case(2) +!!$ call Logfile_stamp(sim_testLargestWhen(i), & +!!$ '[Simulation_finalize] Total X momentum conservation - worst at') +!!$ case(3) +!!$ if (imperfect .OR. N_DIM>1) call Logfile_stamp(sim_testLargestWhen(i), & +!!$ '[Simulation_finalize] Total Y momentum conservation - worst at') +!!$ case(4) +!!$ if (imperfect .OR. N_DIM>2) call Logfile_stamp(sim_testLargestWhen(i), & +!!$ '[Simulation_finalize] Total Z momentum conservation - worst at') +!!$ end select +!!$ end if +!!$ if (imperfect) then +!!$ call Logfile_stamp(sim_testLargestVals(i)-sim_testRefVals(i), & +!!$ '[Simulation_finalize] Test failed, Error') +!!$ call Logfile_stamp(sim_testFirstVals(i), & +!!$ '[Simulation_finalize] Test failed, reference value') +!!$ call Logfile_stamp(sim_testLastVals(i), & +!!$ '[Simulation_finalize] Test failed, last value') +!!$ call Logfile_stamp(sim_testLargestVals(i), & +!!$ '[Simulation_finalize] Test failed, worst value') +!!$ else if (.NOT. perfect .AND. i .LE. 1+N_DIM) then +!!$ call Logfile_stamp(sim_testLargestVals(i)-sim_testRefVals(i), & +!!$ '[Simulation_finalize] Test succeeded, Error') +!!$ call Logfile_stamp(sim_testFirstVals(i), & +!!$ '[Simulation_finalize] Test succeeded, reference value') +!!$ call Logfile_stamp(sim_testLastVals(i), & +!!$ '[Simulation_finalize] Test succeeded, last value') +!!$ call Logfile_stamp(sim_testLargestVals(i), & +!!$ '[Simulation_finalize] Test succeeded, worst value') +!!$ end if +!!$ end do +!!$ end if + + +!!$ if (perfect) then +!!$ write (fileUnit,'(a)') 'SUCCESS all results conformed with expected values.' +!!$ else +!!$ write (fileUnit,'(a)') 'FAILURE' +!!$ end if + +!!$97 format(1x,"=========",1x,I3,1x,"=========") +97 format(1x,1x,I3,". ") +98 format(1x,A,":",(2x,1PG14.7,6x)) +99 format(1x,A,(1PG17.10)) + if (sim_globalMe==MASTER_PE) then + do i=0,nLargestMaxSummary + write (fileUnit,97,ADVANCE="NO") i+1 + write (fileUnit,98,ADVANCE="NO") "First val ",sim_testFirstVals(i) + write (fileUnit,98,ADVANCE="NO") "Last val ",sim_testLastVals(i) + write (fileUnit,98,ADVANCE="NO") "Largest val",sim_testLargestVals(i) + write (fileUnit,99) "Largest at t=",sim_testLargestWhen(i) + end do + end if + close (fileUnit) + + + return + +end subroutine Simulation_finalize diff --git a/Simulation_init.F90 b/Simulation_init.F90 new file mode 100644 index 0000000..5a492f7 --- /dev/null +++ b/Simulation_init.F90 @@ -0,0 +1,181 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_init +!! +!! NAME +!! +!! Simulation_init +!! +!! +!! SYNOPSIS +!! +!! Simulation_init() +!! +!! DESCRIPTION +!! +!! Initializes all the data specified in Simulation_data. +!! It calls RuntimeParameters_get rotuine for initialization. +!! Initializes initial conditions for Sedov Spherical Explosion +!! problem. +!! +!! ARGUMENTS +!! +!! +!! +!! PARAMETERS +!! +!! sim_pAmbient Initial ambient pressure +!! sim_rhoAmbient Initial ambient density +!! sim_tempAmbient Initial ambient temperature +!! sim_minRhoInit Density floor for initial condition +!! sim_nsubzones Number of `sub-zones' in cells for applying 1d profile +!! sim_forceCenterDerefine Try to force low refinement level around explosion center? +!! sim_centerRefineLevel Desired refinement level at center (if "forcing") +!! sim_derefineRadius Radius of center region to force derefinement +!! sim_profFileName Name of file from which to read a 1D Sedov solution for the +!! initial condition +!! +!!*** + +subroutine Simulation_init() + + use Simulation_data + use Driver_interface, ONLY : Driver_getMype, Driver_getNumProcs + use RuntimeParameters_interface, ONLY : RuntimeParameters_get + use Logfile_interface, ONLY : Logfile_stamp + use ut_generalInterface, ONLY : ut_getFreeFileUnit + use PhysicalConstants_interface, ONLY : PhysicalConstants_get + + implicit none + +#include "Flash.h" +#include "constants.h" + + logical :: threadBlockListBuild, threadWithinBlockBuild + real :: vctr + real :: R_u, eos_singleSpeciesA + + call Driver_getMype(MESH_COMM, sim_meshMe) + call Driver_getMype(GLOBAL_COMM, sim_globalMe) + call Driver_getNumProcs(GLOBAL_COMM, sim_globalNumProcs) + + call RuntimeParameters_get('sim_pAmbient', sim_pAmbient) + call RuntimeParameters_get('sim_rhoAmbient', sim_rhoAmbient) + call RuntimeParameters_get('sim_tempAmbient', sim_tempAmbient) + call RuntimeParameters_get('sim_nsubzones',sim_nSubZones) + call RuntimeParameters_get('sim_exl',sim_exl) + call RuntimeParameters_get('sim_exu',sim_exu) + call RuntimeParameters_get('sim_eyl',sim_eyl) + call RuntimeParameters_get('sim_eyu',sim_eyu) + call RuntimeParameters_get('sim_pxl',sim_pxl) + call RuntimeParameters_get('sim_pxu',sim_pxu) + call RuntimeParameters_get('sim_pyl',sim_pyl) + call RuntimeParameters_get('sim_pyu',sim_pyu) + call RuntimeParameters_get('sim_vx',sim_vx) + call RuntimeParameters_get('sim_vy',sim_vy) + call RuntimeParameters_get('sim_vz',sim_vz) + call RuntimeParameters_get('gamma', sim_gamma) + call RuntimeParameters_get('eos_singleSpeciesA', eos_singleSpeciesA) + call PhysicalConstants_get("ideal gas constant", R_u) + call RuntimeParameters_get('smallx', sim_smallX) + call RuntimeParameters_get('smlrho', sim_smallRho) + call RuntimeParameters_get('sim_minRhoInit', sim_minRhoInit) + call RuntimeParameters_get('smallp', sim_smallP) + call RuntimeParameters_get('smallT', sim_smallT) + call RuntimeParameters_get('smallu', sim_smallu) + call RuntimeParameters_get('xmin',sim_xMin) + call RuntimeParameters_get('ymin',sim_yMin) + call RuntimeParameters_get('zmin',sim_zMin) + call RuntimeParameters_get('xmax',sim_xMax) + call RuntimeParameters_get('ymax',sim_yMax) + call RuntimeParameters_get('zmax',sim_zMax) + call RuntimeParameters_get('tinitial',sim_tInitial) + call RuntimeParameters_get('sim_forceCenterDerefine',sim_forceCenterDerefine) + call RuntimeParameters_get('sim_centerRefineLevel',sim_centerRefineLevel) + call RuntimeParameters_get('sim_derefineRadius',sim_derefineRadius) + call RuntimeParameters_get('sim_profFileName',sim_profFileName) + call RuntimeParameters_get('sim_bcSetBdryVar',sim_bcSetBdryVar) + call RuntimeParameters_get('sim_earliestLSTime',sim_earliestLSTime) + call RuntimeParameters_get('sim_latestLSTime',sim_latestLSTime) + call RuntimeParameters_get('sim_smallestNormRadius',sim_smallestNormRadius) + call RuntimeParameters_get('sim_largestNormRadius',sim_largestNormRadius) + call RuntimeParameters_get('sim_oneLevelIntegralsOnly',sim_oneLevelIntegralsOnly) + call RuntimeParameters_get('sim_integralsLevel', sim_integralsLevel) + + sim_useProfileFromFile = .FALSE. + if (sim_nProfile > 1) then + sim_useProfileFromFile = (trim(sim_profFileName) .NE. "/dev/null") + end if + + ! calculate the specific gas constant + R_sp = R_u/eos_singleSpeciesA + + + sim_inSubZones = 1./real(sim_nSubZones) + sim_inSubzm1 = 1./real(max(sim_nSubZones-1,1)) + sim_inszd = sim_inSubZones**NDIM + + ! + ! Calculate the initial volume and interior pressure. + ! + !if (NDIM .eq. 1) then + !vctr = 2. * sim_rInit + !elseif (NDIM .eq. 2) then + !vctr = sim_pi * sim_rInit**2 + !else + !vctr = 4./3.*sim_pi*sim_rInit**3 + !endif + + !sim_pExp = (sim_gamma-1.) * sim_expEnergy / vctr ! only used if tinitial .LE. 0. + + !sim_pExp = sim_rhoAmbient*15000.0*288.0946 !PRAO + + + call RuntimeParameters_get("threadBlockListBuild", threadBlockListBuild) + call RuntimeParameters_get("threadHydroBlockList", sim_threadBlockList) + + call RuntimeParameters_get("threadWithinBlockBuild", threadWithinBlockBuild) + call RuntimeParameters_get("threadHydroWithinBlock", sim_threadWithinBlock) + + if (sim_threadBlockList .and. .not. threadBlockListBuild) then + call Logfile_stamp('WARNING! Turning off block list threading '//& + 'because FLASH is not built appropriately','[Simulation_init]') + sim_threadBlockList = .false. + end if + if (sim_threadWithinBlock .and. .not. threadWithinBlockBuild) then + call Logfile_stamp('WARNING! Turning off within block threading '//& + 'because FLASH is not built appropriately','[Simulation_init]') + sim_threadWithinBlock = .false. + end if + + if (sim_useProfileFromFile) then + !call sim_readProfile() + !if (sim_tinitial > 0.0) call sim_scaleProfile(sim_tinitial) + write (*,*) "GetOut" + end if + sim_analyticTime = -HUGE(1.0) + sim_analyticGen = -1 + if (sim_meshMe == MASTER_PE) then + print*,'sim_rhoAmbient is',sim_rhoAmbient + end if + + ! Open file for writing the numerical solution discretized onto the FLASH grid: + sim_fileUnitOutNum = ut_getFreeFileUnit() + open(unit=sim_fileUnitOutNum, status='SCRATCH') +!!$ +!!$ ! Write the file header: +!!$ if(sim_globalME == MASTER_PE) then +!!$ write(sim_fileUnitOutNum,'(a10,7a15)') & +!!$ '# cellno', 'x ', 'y ', 'dens ', 'pres ', 'velx ', 'eint (spec.)' +!!$ end if + + ! Open file for writing the analytical solution discretized onto the FLASH grid: + sim_fileUnitOutAna = ut_getFreeFileUnit() +!!$ open(unit=sim_fileUnitOutAna, file="sedSol-ana.out", form="formatted", position='append') +!!$ +!!$ ! Write the file header: +!!$ if(sim_globalME == MASTER_PE) then +!!$ write(sim_fileUnitOutAna,'(a10,7a15)') & +!!$ '# cellno', 'x ', 'y ', 'dens ', 'pres ', 'velx ', 'eint density' +!!$ end if + close(sim_fileUnitOutNum) + +end subroutine Simulation_init diff --git a/Simulation_initBlock.F90 b/Simulation_initBlock.F90 new file mode 100644 index 0000000..0fc4650 --- /dev/null +++ b/Simulation_initBlock.F90 @@ -0,0 +1,228 @@ +!!****if* source/Simulation/SimulationMain/Sedov/Simulation_initBlock +!! +!! NAME +!! +!! Simulation_initBlock +!! +!! SYNOPSIS +!! +!! call Simulation_initBlock(integer(IN) :: blockId) +!! +!! DESCRIPTION +!! +!! Initializes fluid data (density, pressure, velocity, etc.) for +!! a specified block. This version sets up the Sedov spherical +!! explosion problem. +!! +!! References: Sedov, L. I., 1959, Similarity and Dimensional Methods +!! in Mechanics (New York: Academic) +!! +!! Landau, L. D., & Lifshitz, E. M., 1987, Fluid Mechanics, +!! 2d ed. (Oxford: Pergamon) +!! +!! ARGUMENTS +!! +!! blockId - The number of the block to initialize +!! +!! PARAMETERS +!! +!! sim_pAmbient Initial ambient pressure +!! sim_rhoAmbient Initial ambient density +!! sim_tempAmbient Initial ambient temperature +!! sim_exl Electrode lower x-coordinates +!! sim_exu Electrode upper x-coordinates +!! sim_exl Electrode lower y-coordinates +!! sim_exu Electrode upper y-coordinates +!! sim_nsubzones Number of `sub-zones' in cells for applying 1d profile +!! +!!*** + +!!REORDER(4): solnData + + +subroutine Simulation_initBlock(blockId) + + use Simulation_data, ONLY: sim_xMax, sim_xMin, sim_yMax, sim_yMin, sim_zMax, sim_zMin, & + & sim_exl, sim_exu, sim_eyl, sim_eyu, & + & sim_pxl, sim_pxu, sim_pyl, sim_pyu, & + & sim_tInitial, sim_gamma, sim_pAmbient, sim_rhoAmbient, sim_tempAmbient, & + & sim_smallT, sim_smallP, & + & sim_vx, sim_vy, sim_vz, & + & R_sp + + use Grid_interface, ONLY : Grid_getBlkIndexLimits, Grid_getBlkPtr, Grid_releaseBlkPtr,& + Grid_getCellCoords, Grid_putPointData + + implicit none + +#include "constants.h" +#include "Flash.h" + + integer,intent(IN) :: blockId + + integer :: i, j, k + integer :: ii, jj, kk + real :: xx, dxx, yy, dyy, zz, dzz + real :: vx, vy, vz, p, rho, e, ek, eint, ti + + real,allocatable,dimension(:) :: xCoord, yCoord, zCoord + integer,dimension(2,MDIM) :: blkLimits, blkLimitsGC + integer :: sizeX, sizeY, sizeZ + integer,dimension(MDIM) :: axis + real, dimension(:,:,:,:),pointer :: solnData + + logical :: gcell = .true. + + + call Grid_getBlkIndexLimits(blockId,blkLimits,blkLimitsGC) + + ! get the coordinate information for the current block from the database + + sizeX = blkLimitsGC(HIGH,IAXIS) - blkLimitsGC(LOW,IAXIS) + 1 + allocate(xCoord(sizeX)); xCoord = 0.0 + sizeY = blkLimitsGC(HIGH,JAXIS) - blkLimitsGC(LOW,JAXIS) + 1 + allocate(yCoord(sizeY)); yCoord = 0.0 + sizeZ = blkLimitsGC(HIGH,KAXIS) - blkLimitsGC(LOW,KAXIS) + 1 + allocate(zCoord(sizeZ)); zCoord = 0.0 + + if (NDIM == 3) call Grid_getCellCoords& + (KAXIS, blockId, CENTER, gcell, zCoord, sizeZ) + if (NDIM >= 2) call Grid_getCellCoords& + (JAXIS, blockId, CENTER, gcell, yCoord, sizeY) + call Grid_getCellCoords(IAXIS, blockId, CENTER, gcell, xCoord, sizeX) + + call Grid_getBlkPtr(blockId,solnData) + + + do k = blkLimitsGC(LOW,KAXIS), blkLimitsGC(HIGH,KAXIS) + ! Find a real difference between z's if problem is >= 3D + if (NDIM > 2) then + if (k .eq. 1) then + dzz = zCoord(2) - zCoord(1) + else + dzz = zCoord(k) - zCoord(k-1) + endif + ! Otherwise this problem is <= 2D, so dzz is meaningless + else + dzz = 0.0 + endif + zz = zCoord(k) + + do j = blkLimitsGC(LOW, JAXIS), blkLimitsGC(HIGH, JAXIS) + ! Find a real difference between y's if problem is >= 2D + if (NDIM > 1) then + if (j .eq. 1) then + dyy = yCoord(2) - yCoord(1) + else + dyy = yCoord(j) - yCoord(j-1) + endif + ! Otherwise this problem is <= 1D, so dyy is meaningless + else + dyy = 0.0 + endif + yy = yCoord(j) + + do i = blkLimitsGC(LOW,IAXIS), blkLimitsGC(HIGH, IAXIS) + xx = xCoord(i) + if (i .eq. 1) then + dxx = xCoord(2) - xCoord(1) + else + dxx = xCoord(i) - xCoord(i-1) + endif + + rho = sim_rhoAmbient + vx = sim_vx + vy = sim_vy + vz = sim_vz + ek = 0.5*(vx*vx + vy*vy + vz*vz) + ti = sim_tempAmbient ! ambient temperature + + ! implement the initial temperature in the plasma channel + if (xx >= sim_pxl .and. xx <= 2.0*sim_pxu .and. yy >= sim_pyl .and. yy <= sim_pyu) then + call expFunc (xx, sim_pxl, 18500.0, 2.0*sim_pxu, 300.0, ti) + !ti = 10000.0 ! set is to 10000 K like in Ekici paper + endif + !write (*,*) ti + + p = sim_rhoAmbient*ti*R_sp !PRAO: P = rho*T*R + e = p/(sim_gamma-1.) + eint= e/rho + e = e/rho + ek + e = max (e, sim_smallP) + + + ! implement the electrode geometry here + ! PRAO: is there a need for this? + if ((xx > sim_exl .and. xx < sim_exu) .and. (yy < sim_eyl .or. yy > sim_eyu) ) then + ti = sim_tempAmbient ! temp inside electrode is 300 K + endif + + + axis(IAXIS)=i + axis(JAXIS)=j + axis(KAXIS)=k + + solnData(DENS_VAR,i,j,k)=rho + solnData(PRES_VAR,i,j,k)=p + solnData(ENER_VAR,i,j,k)=e +#ifdef EINT_VAR + solnData(EINT_VAR,i,j,k)=eint +#endif + solnData(GAME_VAR,i,j,k)=sim_gamma + solnData(GAMC_VAR,i,j,k)=sim_gamma + solnData(VELX_VAR,i,j,k)=vx + solnData(VELY_VAR,i,j,k)=vy + solnData(VELZ_VAR,i,j,k)=vz + solnData(TEMP_VAR,i,j,k)=ti +#ifdef BDRY_VAR + solnData(BDRY_VAR,i,j,k)= -1.0 +#endif + + call Grid_putPointData(blockId, CENTER, DENS_VAR, EXTERIOR, axis, rho) + call Grid_putPointData(blockId, CENTER, PRES_VAR, EXTERIOR, axis, p) + call Grid_putPointData(blockId, CENTER, ENER_VAR, EXTERIOR, axis, e) +#ifdef EINT_VAR + call Grid_putPointData(blockId, CENTER, EINT_VAR, EXTERIOR, axis, eint) +#endif + call Grid_putPointData(blockId, CENTER, GAME_VAR, EXTERIOR, axis, sim_gamma) + call Grid_putPointData(blockId, CENTER, GAMC_VAR, EXTERIOR, axis, sim_gamma) + call Grid_putPointData(blockId, CENTER, VELX_VAR, EXTERIOR, axis, vx) + call Grid_putPointData(blockId, CENTER, VELY_VAR, EXTERIOR, axis, vy) + call Grid_putPointData(blockId, CENTER, VELZ_VAR, EXTERIOR, axis, vz) + call Grid_putPointData(blockId, CENTER, TEMP_VAR, EXTERIOR, axis, ti) +#ifdef BDRY_VAR + call Grid_putPointData(blockId, CENTER, BDRY_VAR, EXTERIOR, axis, -1.0) +#endif + enddo + enddo + enddo + + call Grid_releaseBlkPtr(blockID, solnData) + deallocate(xCoord) + deallocate(yCoord) + deallocate(zCoord) + + return +end subroutine Simulation_initBlock + + +!!!!!!for interpolating to an exponential function!!!!!! + +subroutine expFunc (x, x1, y1, x2, y2, y) + + implicit none + real, intent(IN) :: x ! interpolate at x + real, intent(OUT) :: y ! interpolated value at x + real, intent(IN) :: x1, y1, x2, y2 !two given points + real :: a, b, test, test2 !coefficients of exp function + + test = log(y1) + test2 = log(y2) + b = (log(y1) - log(y2)) / (x1-x2) + a = y1/(exp(b*x1)) + + y = a*exp(b*x) + + return + +end subroutine expFunc diff --git a/UNITS_TO_DELETE_FOR_COMPACT_APP b/UNITS_TO_DELETE_FOR_COMPACT_APP new file mode 100644 index 0000000..689467e --- /dev/null +++ b/UNITS_TO_DELETE_FOR_COMPACT_APP @@ -0,0 +1,20 @@ +physics/Cosmology +physics/Flame +physics/Gravity +physics/IncompNS +physics/RadTrans +physics/materialProperties/MagneticResistivity +physics/materialProperties/MassDiffusivity +physics/materialProperties/Opacity +physics/sourceTerms/Burn +physics/sourceTerms/Cool +physics/sourceTerms/Deleptonize +physics/sourceTerms/EnergyDeposition +physics/sourceTerms/Heat +physics/sourceTerms/Heatexchange +physics/sourceTerms/Ionize +physics/sourceTerms/Stir +monitors/Profiler +Particles +flashUtilities/contiguousConversion +flashUtilities/interpolation diff --git a/WriteParticleSubset/Config b/WriteParticleSubset/Config new file mode 100644 index 0000000..65b730c --- /dev/null +++ b/WriteParticleSubset/Config @@ -0,0 +1,43 @@ +# Configuration file for the Sedov explosion problem +# (Sedov, L. I., 1959, Similarity and Dimensional Methods +# in Mechanics [New York: Academic]) + +REQUIRES Driver +REQUIRES physics/Hydro +REQUIRES physics/Eos + +PARTICLETYPE passive INITMETHOD lattice MAPMETHOD quadratic ADVMETHOD rungekutta +REQUIRES Particles/ParticlesMain +REQUESTS Particles/ParticlesInitialization/Lattice +REQUESTS Particles/ParticlesMapping/Quadratic +REQUESTS IO/IOMain/ +REQUESTS IO/IOParticles + + + +D sim_pAmbient Initial ambient pressure +PARAMETER sim_pAmbient REAL 1.E-5 + +D sim_rhoAmbient Initial ambient density +PARAMETER sim_rhoAmbient REAL 1. + +D sim_expEnergy Explosion energy (distributed over 2^dimen central zones) +PARAMETER sim_expEnergy REAL 1. + +D sim_rInit Radial position of inner edge of grid (for 1D) +PARAMETER sim_rInit REAL 0.05 + +D sim_xctr Explosion center coordinates +PARAMETER sim_xctr REAL 0.5 + +D sim_yctr Explosion center coordinates +PARAMETER sim_yctr REAL 0.5 + +D sim_zctr Explosion center coordinates +PARAMETER sim_zctr REAL 0.5 + +D sim_nsubzones Number of `sub-zones' in cells for applying 1d profile +PARAMETER sim_nsubzones INTEGER 7 + + +# No VARIABLE declarations here, using VARIABLES declared in Hydro etc. diff --git a/WriteParticleSubset/README b/WriteParticleSubset/README new file mode 100644 index 0000000..240e1cd --- /dev/null +++ b/WriteParticleSubset/README @@ -0,0 +1,13 @@ +This is the standard Sedov test with particles, but is +designed to test writing a particle subset. + +Two subsets of the particles array are written. + +1. The tags for every single particle. + Dataset: "Tags_of_all_particles" +2. The full properties of all particles that are at x position > 0.5. + Dataset: "Posx_greater_than_0.5" + + +Setup line: +./setup Sedov/WriteParticleSubset -auto +parallelIO diff --git a/WriteParticleSubset/flash.par b/WriteParticleSubset/flash.par new file mode 120000 index 0000000..eae535d --- /dev/null +++ b/WriteParticleSubset/flash.par @@ -0,0 +1 @@ +test_paramesh_particles_2d.par \ No newline at end of file diff --git a/WriteParticleSubset/io_ptCreateSubset.F90 b/WriteParticleSubset/io_ptCreateSubset.F90 new file mode 100644 index 0000000..a2c32c9 --- /dev/null +++ b/WriteParticleSubset/io_ptCreateSubset.F90 @@ -0,0 +1,141 @@ +!!****if* source/Simulation/SimulationMain/Sedov/WriteParticleSubset/io_ptCreateSubset +!! +!! NAME +!! +!! io_ptCreateSubset +!! +!! SYNOPSIS +!! +!! io_ptCreateSubset(integer(IN) :: numProcs, +!! integer(IN) :: subsetIndex, +!! integer(IN) :: numProperties, +!! integer(IN) :: numParticles, +!! char(IN) :: partLabels(OUTPUT_PROP_LENGTH,numParticles), +!! real(INOUT) :: particlest(numProperties,numParticles), +!! real(OUT) :: subsetSize(2), +!! char(OUT) :: subsetName(MAX_STRING_LENGTH), +!! char(OUT) :: subsetLabelName(MAX_STRING_LENGTH), +!! char(OUT) :: subsetLabels(OUTPUT_PROP_LENGTH,numParticles), +!! logical(OUT) :: moreSubsetsRemain +!! +!! ARGUMENTS +!! +!! numProcs - Global number of processes. +!! subsetIndex - Current subset iteration. This subroutine will +!! continually be called with incremented values of +!! subsetIndex until the user sets moreSubsetsRemain to +!! .false.. +!! numProperties - Number of particle properties. +!! numParticles - Number of particles on myPE (local process ID). +!! partLabels - Text labels of particle properties. +!! particlest - Temporary particles array that is used to hold a +!! user-defined subset. We reuse the same space for +!! different values of subsetIndex. +!! subsetSize - The size of user-defined subset. +!! subsetName - The particle dataset name in file. +!! subsetLabelName - The particle labels dataset name in file. +!! subsetLabels - The text labels of the particle properties in the +!! user-defined subset. +!! moreSubsetsRemain - Whether there are more subsets after subset +!! "subsetIndex". +!! +!! DESCRIPTION +!! +!! Creates custom particle subset(s) that are written to a particle file. +!! These subsets do not get written to a checkpoint file. +!! +!! NOTES +!! +!! Visit will only read the particle dataset name "tracer particles" +!! and the particle labels name "particle names". You can replace these +!! datasets with your custom data by setting the runtime parameters +!! writeParticleSubset = .true. and writeParticleAll = .false.. Then +!! return a subset from io_ptCreateSubset with names: +!! subsetName = "tracer particles" and subsetLabelName = "particle names" +!! +!! The following example shows how to create a subset that replaces the +!! standard particle datasets (and so can be visualized with Visit). +!! In this case the user particles array (particlest) is identical +!! to the FLASH particles array (particles). Customize as needed, e.g. +!! only include particles that meet a certain criterion. +!! +!! if (subsetIndex == 0) then +!! moreSubsetsRemain = .false. +!! subsetName = "tracer particles" +!! subsetLabelName = "particle names" +!! subsetLabels(:) = partLabels(:) +!! subsetSize(1) = numProperties +!! subsetSize(2) = numParticles +!! particlest(1:numProperties,1:numParticles) = & +!! particles(1:numProperties,1:numParticles) +!! end if +!! +!!*** + +subroutine io_ptCreateSubset ( subsetIndex, numProperties, & + numParticles, partLabels, particlest, & + subsetSize, subsetName, subsetLabelName, subsetLabels, & + moreSubsetsRemain) + + use Particles_data, ONLY : particles + implicit none + +#include "Flash.h" +#include "constants.h" + + integer, intent(IN) :: subsetIndex, numProperties, & + numParticles + character(len=OUTPUT_PROP_LENGTH), dimension(numProperties), & + intent(IN) :: partLabels + + real, dimension(numProperties,numParticles), intent(INOUT) :: particlest + + integer, dimension(2), intent(OUT) :: subsetSize + character(len=MAX_STRING_LENGTH), intent(OUT) :: subsetName, subsetLabelName + character(len=OUTPUT_PROP_LENGTH), dimension(numProperties), & + intent(OUT) :: subsetLabels + logical, intent(OUT) :: moreSubsetsRemain + + + integer :: i, matchingParticles + + + !I will make 2 custom subsets. Check particle files using: + ! + !h5dump -d Tags_of_all_particles_labels \ + !-d Tags_of_all_particles \ + !-d Posx_greater_than_0.5_labels \ + !-d Posx_greater_than_0.5 \ + !sedov_2d_6lev_hdf5_part_0000 + + if (subsetIndex == 0) then + moreSubsetsRemain = .true. + subsetName = "Tags_of_all_particles" + subsetLabelName = "Tags_of_all_particles_labels" + subsetLabels(1) = "tag" + + subsetSize(1) = 1 !We only want a single property. + subsetSize(2) = numParticles + do i = 1, numParticles + particlest(1,i) = particles(TAG_PART_PROP,i) + end do + end if + + if (subsetIndex == 1) then + moreSubsetsRemain = .false. + subsetName = "Posx_greater_than_0.5" + subsetLabelName = "Posx_greater_than_0.5_labels" + subsetLabels(:) = partLabels(:) + + subsetSize(1) = numProperties !We want all properties. + matchingParticles = 0 + do i = 1, numParticles + if (particles(POSX_PART_PROP,i) >= 0.5) then + matchingParticles = matchingParticles + 1 + particlest(:,matchingParticles) = particles(:,i) + end if + end do + subsetSize(2) = matchingParticles + end if + +end subroutine io_ptCreateSubset diff --git a/WriteParticleSubset/test_paramesh_particles_2d.par b/WriteParticleSubset/test_paramesh_particles_2d.par new file mode 100644 index 0000000..a0d54ad --- /dev/null +++ b/WriteParticleSubset/test_paramesh_particles_2d.par @@ -0,0 +1,146 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + +pt_numX = 10 +pt_numY = 10 + +pt_initialXmin = 0.45 +pt_initialXmax = 0.55 +pt_initialYmin = 0.45 +pt_initialYmax = 0.55 + +pt_maxPerProc = 100 + +useParticles = .true. + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_2d_6lev_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +convertToConsvdInMeshInterp = .true. + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "Roe" # Roe, HLL, HLLC, LF +shockInstabilityFix = .true. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + + +#Must set this runtime parameter to write a custom particle subset. +writeParticleSubset = .true. + +#Make the particle file smaller by not writing the full particles array. +writeParticleAll = .false. diff --git a/adjustSedSol.pl b/adjustSedSol.pl new file mode 100755 index 0000000..481b157 --- /dev/null +++ b/adjustSedSol.pl @@ -0,0 +1,17 @@ +#! /usr/bin/perl -p +$E=1.0, $rho_up=1.0, $t=0.01; +$minRho_Flash = 0.001; +$minRho_Flash_sq = $minRho_Flash * $minRho_Flash; +$minRho_Flash_4th = $minRho_Flash_sq * $minRho_Flash_sq; +$S = ($rho_up / ($E*$t*$t) )**0.2 ; +#s/^# SOLUTION:/# ADJUSTED SOLUTION: E=$E, rho_up=$rho_up, t=$t => S = $S/ ; +s/^# SOLUTION:/# SOLUTION WITH DENSITY FLOOR:/ ; +unless (m/^#/) { + s/^((?:\s+[\d.Ee+-]+){2}\s+)([\d.Ee+-]+)\s(?=\s)/ # modify the 3rd number, leaving others as they are + "$1" . + sprintf("%14.9E", + ( ($2 < 10.0 * $minRho_Flash) ? + sqrt(sqrt($2**4 + $minRho_Flash_4th)) : $2 ) + ) + /e +} diff --git a/change.txt b/change.txt new file mode 100644 index 0000000..9f7da52 --- /dev/null +++ b/change.txt @@ -0,0 +1,7 @@ +p_ambient sim_pAmbient +rho_ambient sim_rhoAmbient +exp_energy sim_expEnergy +r_init sim_rInit +xctr sim_xctr +yctr sim_yctr +zctr sim_zctr diff --git a/coldstart_pm.par b/coldstart_pm.par new file mode 100644 index 0000000..c9e477a --- /dev/null +++ b/coldstart_pm.par @@ -0,0 +1,136 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_nsubzones = 7 + +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.03 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 +use_auxEintEqn = .TRUE. + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM + +#hy_fPresInMomFlux = 1.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +#EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +#shockDetect = .false. # Shock Detect for numerical stability +shockLowerCFL = .false. # Lower CFL at shocks? +## -------------------------------------------------------------## \ No newline at end of file diff --git a/coldstart_pm_3d.par b/coldstart_pm_3d.par new file mode 100644 index 0000000..1ff3871 --- /dev/null +++ b/coldstart_pm_3d.par @@ -0,0 +1,84 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_nsubzones = 7 + +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_" +restart = .false. +checkpointFileIntervalTime = 0.02 +nend = 1000 +tmax = 0.02 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 +use_auxEintEqn = .TRUE. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM +use_flattening = .true. + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +#EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +#shockDetect = .false. # Shock Detect for numerical stability +shockLowerCFL = .false. # Lower CFL at shocks? +## -------------------------------------------------------------## \ No newline at end of file diff --git a/coldstart_ug.par b/coldstart_ug.par new file mode 100644 index 0000000..d4f8ead --- /dev/null +++ b/coldstart_ug.par @@ -0,0 +1,130 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_profFileName = "sedovSolutionModLong.dat" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.03 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 2 #num procs in i direction +jProcs = 2 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/flash.bgp.2048.par b/flash.bgp.2048.par new file mode 100644 index 0000000..9fdcc61 --- /dev/null +++ b/flash.bgp.2048.par @@ -0,0 +1,109 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +useCollectiveHDF5 = .false. + +p_ambient = 1.E-5 +rho_ambient = 1. +exp_energy = 1. +r_init = 0.013671875 +xctr = 0.5 +yctr = 0.5 +zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. +nblockx = 9 +nblocky = 9 +nblockz = 9 + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 7 +basenm = "sedov_" +restart = .false. +trstrt = 0.01 +nend = 4 +tmax = 0.05 + +checkpointFileIntervalStep = 2 +plotFileIntervalStep = 2 +particleFileIntervalStep = 2 + +plot_var_1 = "dens" +plot_var_2 = "temp" +plot_var_3 = "pres" + +refine_var_1 = "dens" +refine_var_2 = "pres" + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + + +#These parameters below are only necessary for the Uniform Grid +# see note below for more explanation + +gridImax = 40 #defined as nxb + 2* # guard cells +gridJmax = 40 +gridKmax = 40 +iGridSize = 32 #defined as nxb * iprocs +jGridSize = 32 +kGridSize = 32 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +useParticles= .true. +pt_numX = 100 +pt_numY = 100 +pt_numZ = 4 +pt_maxPerProc = 40000 +#pt_maxPerBlock=100 + +sim_vx_amb = 1.0 +sim_seed = 1.0 +sim_vz_pert=1.0 +sim_vy_pert=1.0 +sim_vx_pert=1.0 + + diff --git a/flash.bgp.4.par b/flash.bgp.4.par new file mode 100644 index 0000000..a58f806 --- /dev/null +++ b/flash.bgp.4.par @@ -0,0 +1,110 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +useCollectiveHDF5 = .true. +eachProcWritesSummary = .false. + +p_ambient = 1.E-5 +rho_ambient = 1. +exp_energy = 1. +r_init = 0.013671875 +xctr = 0.5 +yctr = 0.5 +zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. +nblockx = 1 +nblocky = 1 +nblockz = 1 + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 5 +basenm = "sedov_" +restart = .false. +trstrt = 0.01 +nend = 4 +tmax = 0.05 + +checkpointFileIntervalStep = 2 +plotFileIntervalStep = 2 +particleFileIntervalStep = 2 + +plot_var_1 = "dens" +plot_var_2 = "temp" +plot_var_3 = "pres" + +refine_var_1 = "dens" +refine_var_2 = "pres" + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + + +#These parameters below are only necessary for the Uniform Grid +# see note below for more explanation + +gridImax = 40 #defined as nxb + 2* # guard cells +gridJmax = 40 +gridKmax = 40 +iGridSize = 32 #defined as nxb * iprocs +jGridSize = 32 +kGridSize = 32 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +useParticles= .true. +pt_numX = 10 +pt_numY = 10 +pt_numZ = 4 +pt_maxPerProc = 400 +#pt_maxPerBlock=100 + +sim_vx_amb = 1.0 +sim_seed = 1.0 +sim_vz_pert=1.0 +sim_vy_pert=1.0 +sim_vx_pert=1.0 + + diff --git a/flash.bgp.4096.par b/flash.bgp.4096.par new file mode 100644 index 0000000..51baf3d --- /dev/null +++ b/flash.bgp.4096.par @@ -0,0 +1,115 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +eachProcWritesSummary = .false. + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.03 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.03 +wall_clock_time_limit = 2700 + + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 7 +lrefine_min = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + diff --git a/flash.bgp_bench.4096.par b/flash.bgp_bench.4096.par new file mode 100644 index 0000000..7015445 --- /dev/null +++ b/flash.bgp_bench.4096.par @@ -0,0 +1,89 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +useCollectiveHDF5 = .true. +eachProcWritesSummary = .false. + +p_ambient = 1.E-5 +rho_ambient = 1. +exp_energy = 1. +r_init = 0.013671875 +xctr = 0.5 +yctr = 0.5 +zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. +nblockx = 9 +nblocky = 9 +nblockz = 9 + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 7 +basenm = "sedov_" +restart = .false. +trstrt = 0.01 +nend = 4 +tmax = 0.05 + +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 + +plot_var_1 = "dens" +plot_var_2 = "temp" +plot_var_3 = "pres" + +refine_var_1 = "dens" +refine_var_2 = "pres" + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + + +sim_vx_amb = 1.0 +sim_seed = 1.0 +sim_vz_pert=1.0 +sim_vy_pert=1.0 +sim_vx_pert=1.0 + + diff --git a/flash.bgp_bench.512.par b/flash.bgp_bench.512.par new file mode 100644 index 0000000..8348e79 --- /dev/null +++ b/flash.bgp_bench.512.par @@ -0,0 +1,89 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +useCollectiveHDF5 = .true. +eachProcWritesSummary = .false. + +p_ambient = 1.E-5 +rho_ambient = 1. +exp_energy = 1. +r_init = 0.013671875 +xctr = 0.5 +yctr = 0.5 +zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. +nblockx = 9 +nblocky = 9 +nblockz = 9 + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 6 +basenm = "sedov_" +restart = .false. +trstrt = 0.01 +nend = 4 +tmax = 0.05 + +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 + +plot_var_1 = "dens" +plot_var_2 = "temp" +plot_var_3 = "pres" + +refine_var_1 = "dens" +refine_var_2 = "pres" + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + + +sim_vx_amb = 1.0 +sim_seed = 1.0 +sim_vz_pert=1.0 +sim_vy_pert=1.0 +sim_vx_pert=1.0 + + diff --git a/flash.par b/flash.par new file mode 100644 index 0000000..25c79a0 --- /dev/null +++ b/flash.par @@ -0,0 +1,176 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# location of explosion source + +sim_rhoAmbient = 1.172358 +sim_tempAmbient = 300.0 + +# electrode dimensions +sim_exl = 0.0 +sim_exu = 0.5e-3 # electrode radius is changed +sim_eyl = -1.e-3 +sim_eyu = 1.e-3 + +# plasma dimensions +sim_pxl = 0.0 +#sim_pxu = 0.1e-3 # plasma radius +sim_pxu = 0.3e-3 +sim_pyl = -1.e-3 +sim_pyu = 1.e-3 + +sim_vx = 0.0 +sim_vy = 0.0 +sim_vz = 0.0 + +# Specify file from which to read initial / analytical profile, or "/dev/null" for none: +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cylindrical" + +# Size of computational volume + +xmin = 0. +xmax = 6.e-3 +ymin = -4.5e-3 +ymax = 4.5e-3 + +# Boundary conditions + +##xl_boundary_type = "reflect" +xl_boundary_type = "axisymmetric" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 2.0 +#checkpointFileIntervalStep = 5000 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0.2e-6 +#plotfileIntervalStep = 20 +plotfileNumber = 0 + +ignoreForcedPlot = .true. + +nend = 1000000 +tmax = 40.e-6 +#dtMax = 5.e-9 + +run_comment = "ESD Plasma" +log_file = "esd.log" +eintSwitch = 0.2e-6 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" +plot_var_4 = "ener" +plot_var_5 = "velx" +plot_var_6 = "vely" + +# Adaptive Grid refinement parameters +lrefine_max = 1 +refine_var_1 = "dens" +refine_var_2 = "temp" + + +# Uniform Grid specific parameters +# see note below for more explanation + +iGridSize = 200 #global number of gridpoints along x, excluding gcells +jGridSize = 200 #global number of gridpoints along y, excluding gcells +kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (first/second/third/fifth order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + +use_avisc = .true. # use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "Roe" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + +## ---------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE SUPER-TIME-STEPPING (STS) ALGORITHM ## +## NOTE: For details on using STS runtime parameters, please ## +## refer to user's guide (Driver chapter). ## +useSTS = .false. +nstepTotalSTS = 5 +nuSTS = 0.2 +## ---------------------------------------------------------------## + +## SI Units +pc_unitsBase = "MKS" + +# eos mode +##eosMode = "dens_temp" +eosModeInit = "dens_temp" +# molecular weight of dry air in kg/mol +eos_singleSpeciesA = .02896 + +gr_pmrpNboundaries = 18 + +# switch for the source term +usePlasmaPR = .true. +useJouleHeating = .true. +useRadiationCooling = .true. + +# turn the conductivity on +#useConductivity = .false. +#useDiffuse = .false. +#useDiffuseTherm = .false. +#useDiffuseComputeDtTherm = .false. # always off to avoid very small timesteps + diff --git a/flash.par.Particles b/flash.par.Particles new file mode 100644 index 0000000..cd2878c --- /dev/null +++ b/flash.par.Particles @@ -0,0 +1,93 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +p_ambient = 1.E-5 +rho_ambient = 1. +exp_energy = 1. +r_init = 0.013671875 +xctr = 0.5 +yctr = 0.5 +zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 6 +basenm = "sedov_" +restart = .false. +trstrt = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + + +#These parameters below are only necessary for the Uniform Grid +# see note below for more explanation + +gridImax = 40 #defined as nxb + 2* # guard cells +gridJmax = 40 +gridKmax = 40 +iGridSize = 32 #defined as nxb * iprocs +jGridSize = 32 +kGridSize = 32 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +useParticles= .true. +pt_numX = 4 +pt_numY = 4 +pt_numZ = 4 +pt_maxPerProc=100 +pt_maxPerBlock=100 + +sim_vx_amb = 1.0 +sim_seed = 1.0 +sim_vz_pert=1.0 +sim_vy_pert=1.0 +sim_vx_pert=1.0 + + diff --git a/flash.par.hdf5_plotfile_bug b/flash.par.hdf5_plotfile_bug new file mode 100644 index 0000000..e9d5f5e --- /dev/null +++ b/flash.par.hdf5_plotfile_bug @@ -0,0 +1,82 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + + +# Data in plotfiles is mixed up when enabling collective IO HDF5 mode and +# running on surveyor. You need to adjust io_h5write_allunknowns.c so that +# plotfiles contain double precision data to reproduce problem, i.e. +# +/* dataTypeInFile = H5T_NATIVE_FLOAT;*/ +# + dataTypeInFile = H5T_NATIVE_DOUBLE; +# Problem does not appear in independent IO HDF5 mode. +# NOTE: This is for experimental IO code only (uses MPI derived datatypes). + +# Setup line: +# ./setup Sedov -auto +parallelIO -debug +cube16 +pm4dev -parfile=flash.par.hdf5_plotfile_bug -3d -maxblocks=90 --with-unit=IO/IOMain/hdf5/parallel/PM_argonne +# Run on 4 cores. Modify useCollectiveHDF5 flag. + + +useCollectiveHDF5 = .true. +eachProcWritesSummary = .false. + + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalTime = 0.02 +nend = 1 +tmax = 0.02 + +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 + + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 + + +plot_var_1 = "dens" +plot_var_2 = "temp" +plot_var_3 = "pres" + diff --git a/flash.par.particles_benchmark b/flash.par.particles_benchmark new file mode 100644 index 0000000..0062be8 --- /dev/null +++ b/flash.par.particles_benchmark @@ -0,0 +1,144 @@ +# Sedov particle movement strong scaling experiments. +# +# Basic setup line: +# ./setup Sedov -auto +pm4dev -3d -maxblocks=200 -with-unit=Particles +noio +# +# This will fit on 512 cores in VN mode on a BG/P. +# Has also been run on 2048, 8192 cores. +# + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +max_particles_per_blk = 20000 +refine_on_particle_count = .true. +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +nblockx = 4 +nblocky = 4 +nblockz = 4 + +pt_numX = 256 +pt_numY = 256 +pt_numZ = 256 +pt_maxPerProc = 1500000 + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 100 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 9 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "Roe" # Roe, HLL, HLLC, LF +RoeAvg = .true. # Roe averages +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## \ No newline at end of file diff --git a/flash_uhd_mh_benchmark.par b/flash_uhd_mh_benchmark.par new file mode 100644 index 0000000..d73761c --- /dev/null +++ b/flash_uhd_mh_benchmark.par @@ -0,0 +1,150 @@ +# ------------------------------------------------------------------- # +# This is a par file for the unsplit hydro code using a second-order # +# MUSCL-Hancock reconstruction scheme: # +# 1. without using flattening and steepening, # +# 2. with hllc solver. # +# # +# This setup is expected to equally perform as the split PPM. # +# ------------------------------------------------------------------- # + +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + +use_avisc = .true. # use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + +## ---------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE SUPER-TIME-STEPPING (STS) ALGORITHM ## +## NOTE: For details on using STS runtime parameters, please ## +## refer to user's guide (Driver chapter). ## +useSTS = .false. +nstepTotalSTS = 5 +nuSTS = 0.2 +## ---------------------------------------------------------------## \ No newline at end of file diff --git a/flash_uhd_ppm_benchmark.par b/flash_uhd_ppm_benchmark.par new file mode 100644 index 0000000..8aeeb2c --- /dev/null +++ b/flash_uhd_ppm_benchmark.par @@ -0,0 +1,151 @@ +# ---------------------------------------------------------------------- # +# This is a par file for the unsplit hydro code using a third-order # +# PPM scheme for reconstruction, # +# 1. without using flattening and steepeing # +# 2. with hllc solver. # +# # +# This setup is expected to be 1.5 or more expensive than the split PPM. # +# ---------------------------------------------------------------------- # + + +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_uhd_ppm_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov_uhd_ppm.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (first/second/third/fifth order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + +use_avisc = .true. # use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + +## ---------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE SUPER-TIME-STEPPING (STS) ALGORITHM ## +## NOTE: For details on using STS runtime parameters, please ## +## refer to user's guide (Driver chapter). ## +useSTS = .false. +nstepTotalSTS = 5 +nuSTS = 0.2 +## ---------------------------------------------------------------## \ No newline at end of file diff --git a/flash_uhd_ppm_steep-flat_benchmark.par b/flash_uhd_ppm_steep-flat_benchmark.par new file mode 100644 index 0000000..36d1eb0 --- /dev/null +++ b/flash_uhd_ppm_steep-flat_benchmark.par @@ -0,0 +1,153 @@ +# ---------------------------------------------------------------------- # +# This is a par file for the unsplit hydro code using a third-order # +# PPM scheme for reconstruction, # +# 1. with using flattening and steepeing # +# 2. with hllc solver. # +# # +# This setup is expected to be 1.5 or more expensive than the split PPM. # +# Parameters were chosen to provide the UHD's solutions as close to that # +# of split PPM's solutions. +# ---------------------------------------------------------------------- # + + +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_uhd_ppm_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov_uhd_ppm.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (first/second/third/fifth order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + +use_avisc = .true. # use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .true. # use flattening (dissipative) (originally for PPM) +use_steepening = .true. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + +## ---------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE SUPER-TIME-STEPPING (STS) ALGORITHM ## +## NOTE: For details on using STS runtime parameters, please ## +## refer to user's guide (Driver chapter). ## +useSTS = .false. +nstepTotalSTS = 5 +nuSTS = 0.2 +## ---------------------------------------------------------------## \ No newline at end of file diff --git a/gr_expandDomain.F90 b/gr_expandDomain.F90 new file mode 100644 index 0000000..d623e90 --- /dev/null +++ b/gr_expandDomain.F90 @@ -0,0 +1,242 @@ +!!****if* source/Simulation/SimulationMain/Sedov/gr_expandDomain +!! +!! NAME +!! gr_expandDomain +!! +!! SYNOPSIS +!! call gr_expandDomain(logical(OUT) :: particlesInitialized) +!! +!! DESCRIPTION +!! +!! The grid is initialized in gr_createDomain, with a specified +!! number of root blocks, typically one single block. This routine +!! refines appropriate portions of the initialized physical +!! domain according to the given refinement criteria, and applies +!! initial conditions to the AMR domain. +!! +!! In simulations with particles, under certain conditions particle +!! positions will also be initialized. Currently this is the case +!! if and only if the runtime parameter refine_on_particle_count is +!! true. +!! +!! ARGUMENTS +!! particlesInitialized : is true if this routine initialized particles positions +!! +!! SIDE EFFECTS +!! +!! Particle positions may be initialized, see DESCRIPTION above. +!!*** + +#define DEBUG_PARTICLES + +subroutine gr_expandDomain (particlesInitialized) + + use Grid_data, ONLY : gr_domainBC,gr_eosModeInit,gr_refineOnParticleCount,& + gr_refineOnPdens,gr_maxParticlesPerBlk,gr_minParticlesPerBlk, gr_meshMe,& + gr_meshNumProcs, gr_lrefineMinInit, gr_gcellsUpToDate + use Driver_data, ONLY : dr_simGeneration + use Timers_interface, ONLY : Timers_start, Timers_stop + use Logfile_interface, ONLY : Logfile_stamp, Logfile_stampVarMask + use Grid_interface, ONLY : Grid_getBlkIndexLimits, & + Grid_getLocalNumBlks, Grid_getListOfBlocks, & + Grid_markRefineDerefine, Grid_getBlkPtr, Grid_releaseBlkPtr + use Grid_data, ONLY : gr_ihiGc,gr_jhiGc,gr_khiGc,gr_blkList + use tree, ONLY : lrefine, lrefine_min, lrefine_max, grid_changed + use paramesh_interfaces, ONLY : amr_refine_derefine, amr_restrict + use Eos_interface, ONLY : Eos_wrapped + +#include "Flash.h" + +#ifndef FLASH_GRID_PARAMESH2 + use physicaldata, ONLY: no_permanent_guardcells, mpi_pattern_id +#endif + use Simulation_interface, ONLY : Simulation_initBlock + use Particles_interface, ONLY : Particles_accumCount, & + Particles_initPositions, & + Particles_updateRefinement + use Driver_interface, ONLY : Driver_abortFlash + use RadTrans_interface, ONLY: RadTrans_sumEnergy + implicit none + +#include "constants.h" + + include 'Flash_mpi.h' + + real, pointer:: solnData(:,:,:,:) + logical, intent(out) :: particlesInitialized + integer :: lnblocks, lrefineMinSave + + + !! Local variables and functions + + integer :: ntimes, i + + integer, dimension(2,MDIM) :: blkLimits + integer, dimension(2,MDIM) :: blkLimitsGC + integer :: count, cur_treedepth, grid_changed_anytime + logical :: restart = .false. + logical :: particlesPosnsDone, retainParticles + integer :: level = FINEST !not yet implemented, 1 is a dummy value + integer ,dimension(MAXBLOCKS) :: blkList + character(len=32), dimension(2,2) :: block_buff + character(len=32) :: int_to_str + integer :: gridDataStruct, whichBlocks + + !!============================================================================ + + + + !!============================================================================ + + !! The beginning timestep number, time, and timestep. + !! If the initial redshift (zinitial) is physical (>= 0), + !! we use it to initialize the time; otherwise we set the + !! redshift to zero and get the initial time from tinitial. + !! The latter case (no cosmology) is the default. + + ! initialize the step counter and the simulation time + ! the timestep initialization is moved to after the initialization, + ! so we can check whether it is > t_cfl + + particlesInitialized=.false. + call Grid_getBlkIndexLimits(1, blkLimits, blkLimitsGC) + + call gr_initParameshArrays(restart, & + gr_domainBC(LOW,IAXIS),gr_domainBC(HIGH,IAXIS), & + gr_domainBC(LOW,JAXIS),gr_domainBC(HIGH,JAXIS), & + gr_domainBC(LOW,KAXIS),gr_domainBC(HIGH,KAXIS)) + + ! The Paramesh call above may have already resulted in some block refining, + ! so try get the current max level from the lrefine array. This is only used for + ! diagnostic output. Note that this assumes that lrefine on the current + ! processor is representative of the grid as a whole. + cur_treedepth = maxval(lrefine) + + gridDataStruct = CENTER +#if NFACE_VARS > 0 + gridDataStruct = CENTER_FACES +#endif + + lrefineMinSave = lrefine_min + lrefine_min = min(gr_lrefineMinInit,lrefine_max) + + grid_changed_anytime = grid_changed ! save value established by previous Paramesh initialization + + retainParticles=.false. + + do ntimes = 1, lrefine_max+2 + if (ntimes .EQ. gr_lrefineMinInit) then + lrefine_min = lrefineMinSave + end if + write (block_buff(1,1), '(a)') 'iteration' + write (int_to_str, '(i7,a1)') ntimes, ',' + write (block_buff(1,2), '(a,1x,a)') trim(adjustl(int_to_str)) + + write (block_buff(2,1), '(a)') 'create level' + write (int_to_str, '(i7)') min(cur_treedepth+1,lrefine_max) + write (block_buff(2,2), '(a)') trim(adjustl(int_to_str)) + + call Logfile_stamp( block_buff, 2, 2, '[GRID gr_expandDomain]') + + call gr_updateData() + call Grid_getLocalNumBlks(lnblocks) + whichBlocks = LEAF + ! Paramesh may have already refined the original root block(s) once by this point. + ! (That can happen in particular when lrefine_min > 1.) + ! So initialize all existing blocks in the first iteration here. This makes sure + ! that root blocks are not left with uninitialized contents. (Normally that + ! situation would only last until Grid_fillGuardCells is called with LEAF blocks + ! at refinement level 2 anyway, since PARENT blocks are then updated as a side + ! effect by restriction.) - KW + if (ntimes == 1) whichBlocks = ALL_BLKS + call Grid_getListOfBlocks(whichBlocks, blkList,count) + + +#ifndef FLASH_GRID_PARAMESH2 + if (no_permanent_guardcells) then + call gr_commSetup(gridDataStruct) + end if +#endif + + do i = 1, count + ! We need to zero data in case we reuse blocks from previous levels + ! but don't initialize all data in Simulation_initBlock... in particular + ! the total vs. internal energies can cause problems in the eos call that + ! follows. + call Grid_getBlkPtr(blkList(i), solnData) + solnData = 0.0 + call Grid_releaseBlkPtr(blkList(i), solnData) + ! Now reinitialize the solution on the new grid so that it has + ! the exact solution. + call Simulation_initBlock (blkList(i)) + end do + +#ifdef ERAD_VAR + ! Sum radiation energy density over all meshes. This call is + ! needed for mesh replication. + call RadTrans_sumEnergy(ERAD_VAR, count, blkList) +#endif + + ! This is here for safety, in case the user did not take care to make things + ! thermodynamically consistent in the initial state.- KW + call Timers_start("eos") + do i = 1, count + call Eos_wrapped(gr_eosModeInit,blkLimits,blkList(i)) + end do + + call Timers_stop("eos") + + if(gr_refineOnParticleCount ) then + + !! This loop initializes the particle positions if + !! their count is one of the refinement criteria. + !! If the initialization routine intends to keep + !! the already initialized particles around, instead + !! of reinitializing them as the grid is refined, + !! it should return retainParticles true. + !! In case of initializing particles from a file, + !! if the whole file has been read in + !! then particlesPosnsDone should be true, otherwise false. + !! + if(.not.retainParticles) then + particlesPosnsDone=.false. + end if + call Particles_initPositions(particlesPosnsDone,retainParticles) +#ifdef DEBUG_PARTICLES + if (gr_meshMe == MASTER_PE .OR. gr_meshNumProcs .LE. 4) then + print*,'gr_expandDomain after Particles_initPositions on',gr_meshMe,':',particlesPosnsDone,retainParticles + end if +#endif + end if + dr_simGeneration = dr_simGeneration + 1 + if (ntimes .le. lrefine_max+1) then + ! Guard cell filling and Eos_wrapped are done in Grid_markRefineDerefine as needed. + call Grid_markRefineDerefine() + grid_changed_anytime = max(grid_changed, grid_changed_anytime) + grid_changed = 0 ! will be 1 after amr_refine_derefine if the grid actually changed + call amr_refine_derefine() +#ifndef FLASH_GRID_PARAMESH2 + if (grid_changed .NE. 0) mpi_pattern_id = -abs(mpi_pattern_id) !make it different from recognized values +#endif + if(gr_refineOnParticleCount.and.retainParticles) call Particles_updateRefinement(lnblocks) + cur_treedepth = max(maxval(lrefine),min(cur_treedepth+1,lrefine_max)) + + gr_gcellsUpToDate = .false. + end if + + end do !ntimes + + grid_changed = max(grid_changed, grid_changed_anytime) !leave global flag true if grid changed in ANY iteration + + if(gr_refineOnParticleCount) then + if(.not.particlesPosnsDone) call Driver_abortFlash(& + "This distribution of particles will not fit on the grid. Increase pt_maxPerProc, or decrease the particle count.") + particlesInitialized=.true. + end if + + lrefine_min = lrefineMinSave + + call gr_ensureValidNeighborInfo(10) + + return +end subroutine gr_expandDomain diff --git a/lanl_3d.par b/lanl_3d.par new file mode 100644 index 0000000..c82cfbe --- /dev/null +++ b/lanl_3d.par @@ -0,0 +1,173 @@ +# Runtime parameters for the Sedov explosion problem. +#./setup Sedov -auto -3d -nxb=8 -nyb=8 -nzb=8 +pm4dev -objdir=sedov_lanl_pm3d -parfile=lanl_3d.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +tinitial = 0.01 + +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +#x_refine_center = 0.5 # 0.0 is the default +#y_refine_center = 0.5 +#z_refine_center = 0.5 + +sim_nsubzones = 1 # 7 # 10000 + +sim_profFileName = "sedovSolutionModLong.dat" +sim_minRhoInit = 1.0E-5 +smlRho = 1.0E-10 + +#eosModeInit = "eos_nop" +eosModeInit = "dens_ie" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +sim_smallestNormRadius = 0.16 +#sim_largestNormRadius = 1.0 +sim_earliestLSTime = 0.021 +sim_latestLSTime = 0.026 + + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation time, I/O parameters + +cfl = 0.8 +#hy_cflFallbackFactor = 0.9 + +summaryOutputOnly = .TRUE. +basenm = "sedov_" +restart = .false. + +# integral quantities & errors write frequency +wr_integrals_freq = 1 + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0.002 +plotfileIntervalStep = 0 +plotfileNumber = 0 + +memory_stat_freq = 200 + +#tstep_change_factor = 1.1 +nend = 10000 +tmax = 0.026 +dr_shortenLastStepBeforeTMax = .TRUE. + +run_comment = "3D Sedov explosion from tinitial=0.01" +log_file = "sedov.log" +eintSwitch = 0.0 # 1.e-4 +use_auxEintEqn = .FALSE. + +plot_var_1 = "dens" +plot_var_2 = "dena" +plot_var_3 = "pres" +plot_var_4 = "prsa" +plot_var_5 = "velx" +plot_var_6 = "vlxa" +plot_var_7 = "eint" +plot_var_8 = "eina" +plot_var_9 = "ener" +plot_var_10 = "enra" +plot_var_11 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 7 +lrefine_min = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +#sim_forceCenterDerefine = .TRUE. +sim_centerRefineLevel = 4 +sim_derefineRadius = 0.1 + +nblockx = 1 +nblocky = 1 +nblockz = 1 + +# Uniform Grid specific parameters +# see note below for more explanation + +iGridSize = 512 #global number of gridpoints along x, excluding gcells +jGridSize = 512 #global number of gridpoints along y, excluding gcells +kgridsize = 512 +iProcs = 1 #num procs in i direction +jProcs = 8 #num procs in j direction +kprocs = 32 + + +# When using UG, iProcs, jProcs, and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +sim_bcSetBdryVar = .FALSE. +slopeLimiter = "vanLeer1.5" # Slope limiters (minmod,mc,vanLeer,vanLeer1.5,hybrid,limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .FALSE. # Characteristic limiting vs. Primitive limiting + +use_avisc = .FALSE. # Do not use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +hy_fPresInMomFlux = 0.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/lanl_sph_1d.par b/lanl_sph_1d.par new file mode 100644 index 0000000..a993d89 --- /dev/null +++ b/lanl_sph_1d.par @@ -0,0 +1,123 @@ +# Runtime parameters for the Sedov explosion problem. +# ./setup Sedov -site=eugenia.asci.uchicago.edu -auto -test -1d +spherical +uhd -noc -objdir=sedov_lanl_1d -parfile=lanl_sph_1d.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +tinitial = 0.01 +sim_rInit = 0.109375 +#sim_rInit = 0.013671875 # something to use for tinitial = 0.0 +#sim_rInit = 0.16368419815302118 # shock radius at tinitial = 0.01 +#sim_rInit = 0.31159806851954913 # shock radius at tmax = 0.05 + +sim_xctr = 0.0 +#sim_yctr = 0.5 +#sim_zctr = 0.5 + +sim_minRhoInit = 1.0E-3 +smlRho = 1.0E-10 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "spherical" + +# Size of computational volume + +xmin = 0. +xmax = 0.5 + +# Boundary conditions +# +xl_boundary_type = "reflecting" +xr_boundary_type = "outflow" + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.004 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0.0004 +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 1000000 +tmax = 0.05 + +run_comment = "1D Sedov explosion from tinitial=0.1" +log_file = "sedov.log" +eintSwitch = 0.0 # 1.e-4 +use_auxEintEqn = .FALSE. + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 7 +refine_var_1 = "dens" +refine_var_2 = "pres" +sim_forceCenterDerefine = .TRUE. +sim_centerRefineLevel = 4 +sim_derefineRadius = 0.1 + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +iProcs = 1 #num procs in i direction + + +# When using UG, iProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +slopeLimiter = "vanLeer" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .FALSE. # Characteristic limiting vs. Primitive limiting + +use_avisc = .FALSE. # Do not use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/lanl_ug_3d.par b/lanl_ug_3d.par new file mode 100644 index 0000000..081c7c6 --- /dev/null +++ b/lanl_ug_3d.par @@ -0,0 +1,162 @@ +# Runtime parameters for the Sedov explosion problem. +#./setup Sedov -auto -3d +uhd +nofbs -objdir=sedov_lanl_ug3d -parfile=lanl_ug_3d.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +tinitial = 0.01 + +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_nsubzones = 1 # 7 # 10000 + +sim_profFileName = "sedovSolutionModLong.dat" +sim_minRhoInit = 1.0E-5 +smlRho = 1.0E-10 + +#eosModeInit = "eos_nop" +eosModeInit = "dens_ie" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +sim_smallestNormRadius = 0.16 +#sim_largestNormRadius = 1.0 +sim_earliestLSTime = 0.021 +sim_latestLSTime = 0.026 + + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation time, I/O parameters + +cfl = 0.8 +#hy_cflFallbackFactor = 0.9 + +summaryOutputOnly = .TRUE. +basenm = "sedov_" +restart = .false. + +# integral quantities & errors write frequency +wr_integrals_freq = 1 + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0.002 +plotfileIntervalStep = 0 +plotfileNumber = 0 + +memory_stat_freq = 1000 + +#tstep_change_factor = 1.1 +nend = 10000 +tmax = 0.026 +dr_shortenLastStepBeforeTMax = .TRUE. + +run_comment = "#D Sedov explosion from tinitial=0.01" +log_file = "sedov.log" +eintSwitch = 0.0 # 1.e-4 +use_auxEintEqn = .FALSE. + +plot_var_1 = "dens" +plot_var_2 = "dena" +plot_var_3 = "pres" +plot_var_4 = "prsa" +plot_var_5 = "velx" +plot_var_6 = "vlxa" +plot_var_7 = "eint" +plot_var_8 = "eina" +plot_var_9 = "ener" +plot_var_10 = "enra" +plot_var_11 = "temp" + +# Adaptive Grid refinement parameters + +#lrefine_max = 7 +#refine_var_1 = "dens" +#refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +iGridSize = 512 #global number of gridpoints along x, excluding gcells +jGridSize = 512 #global number of gridpoints along y, excluding gcells +kgridsize = 512 +iProcs = 1 #num procs in i direction +jProcs = 8 #num procs in j direction +kprocs = 32 + + +# When using UG, iProcs, jProcs, and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +sim_bcSetBdryVar = .FALSE. +slopeLimiter = "vanLeer1.5" # Slope limiters (minmod,mc,vanLeer,vanLeer1.5,hybrid,limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .FALSE. # Characteristic limiting vs. Primitive limiting + +use_avisc = .FALSE. # Do not use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +hy_fPresInMomFlux = 0.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/lanl_ug_cyl_2d.par b/lanl_ug_cyl_2d.par new file mode 100644 index 0000000..6d48fda --- /dev/null +++ b/lanl_ug_cyl_2d.par @@ -0,0 +1,156 @@ +# Runtime parameters for the Sedov explosion problem. +#./setup Sedov -site=eugenia.asci.uchicago.edu -auto -test -2d +cylindrical +uhd -noc +nofbs -objdir=sedov_lanl_ug2d -parfile=lanl_ug_cyl_2d.par +#./setup Sedov -makefile=gnu -auto -test -2d +cylindrical +uhd -noc +nofbs -objdir=sedov_lanl_ug2d -parfile=lanl_ug_cyl_2d.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +tinitial = 0.01 + +sim_xctr = 0.0 +sim_yctr = 0.0 +#sim_zctr = 0.5 + +sim_nsubzones = 1 # 7 # 10000 + +sim_profFileName = "sedovSolutionModLong.dat" +sim_minRhoInit = 1.0E-5 +smlRho = 1.0E-10 + +#eosModeInit = "eos_nop" +eosModeInit = "dens_ie" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cylindrical" + +# Size of computational volume + +xmin = 0. +xmax = 0.5 +ymin = -0.5 +ymax = 0.5 + +sim_smallestNormRadius = 0.16 +#sim_largestNormRadius = 1.0 +sim_earliestLSTime = 0.021 +sim_latestLSTime = 0.026 + + +# Boundary conditions +# +xl_boundary_type = "reflecting" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +# Simulation time, I/O parameters + +cfl = 0.8 +#hy_cflFallbackFactor = 0.9 +basenm = "sedov_" +restart = .false. + +# integral quantities & errors write frequency +wr_integrals_freq = 1 + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 1 + +# plotfile output parameters +plotfileIntervalTime = 0.0004 +plotfileIntervalStep = 0 +plotfileNumber = 0 + +memory_stat_freq = 1000 + +#tstep_change_factor = 1.1 +nend = 2000000 +tmax = 0.05 +dr_shortenLastStepBeforeTMax = .TRUE. + +run_comment = "2D Sedov explosion from tinitial=0.01" +log_file = "sedov.log" +eintSwitch = 0.0 # 1.e-4 +use_auxEintEqn = .FALSE. + +plot_var_1 = "dens" +plot_var_2 = "dena" +plot_var_3 = "pres" +plot_var_4 = "prsa" +plot_var_5 = "velx" +plot_var_6 = "vlxa" +plot_var_7 = "eint" +plot_var_8 = "eina" +plot_var_9 = "ener" +plot_var_10 = "enra" +plot_var_11 = "temp" + +# Adaptive Grid refinement parameters + +#lrefine_max = 7 +#refine_var_1 = "dens" +#refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +iGridSize = 512 #global number of gridpoints along x, excluding gcells +jGridSize = 1024 #global number of gridpoints along y, excluding gcells +iProcs = 4 #num procs in i direction +jProcs = 8 #num procs in j direction + + +# When using UG, iProcs and jProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +sim_bcSetBdryVar = .FALSE. +slopeLimiter = "vanLeer1.5" # Slope limiters (minmod,mc,vanLeer,vanLeer1.5,hybrid,limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .FALSE. # Characteristic limiting vs. Primitive limiting + +use_avisc = .FALSE. # Do not use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +hy_fPresInMomFlux = 0.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/lanl_ug_sph_1d.par b/lanl_ug_sph_1d.par new file mode 100644 index 0000000..0c7c768 --- /dev/null +++ b/lanl_ug_sph_1d.par @@ -0,0 +1,153 @@ +# Runtime parameters for the Sedov explosion problem. +# ./setup Sedov -site=eugenia.asci.uchicago.edu -auto -test -1d +spherical +uhd -noc +ug -objdir=sedov_lanl_ug1d -parfile=lanl_ug_sph_1d.par +# For 512 cells with iProcs = 2: +# ./setup Sedov -makefile=gnu -auto -test -1d +spherical +uhd -noc +ug -nxb=256 -objdir=sedov_lanl_ug1d -parfile=lanl_ug_sph_1d.par +# non-fixed blocksize UG: +# ./setup Sedov -makefile=gnu -auto -test -1d +spherical +uhd -noc +nofbs -objdir=sedov_lanl_ug1d -parfile=lanl_ug_sph_1d.par + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +tinitial = 0.01 +sim_rInit = 0.109375 +#sim_rInit = 0.013671875 # something to use for tinitial = 0.0 +#sim_rInit = 0.16368419815302118 # shock radius at tinitial = 0.01 +#sim_rInit = 0.31159806851954913 # shock radius at tmax = 0.05 + +sim_xctr = 0.0 +#sim_yctr = 0.5 +#sim_zctr = 0.5 + +sim_nsubzones = 1 # 10 # 7 + +sim_profFileName = "sedovSolutionModLong.dat" +sim_minRhoInit = 1.0E-5 +smlRho = 1.0E-10 + +#eosModeInit = "eos_nop" +eosModeInit = "dens_ie" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "spherical" + +# Size of computational volume + +xmin = 0. +xmax = 0.5 + +#sim_smallestNormRadius = 0.16 +#sim_largestNormRadius = 1.0 +#sim_earliestLSTime = 0.021 +#sim_latestLSTime = 0.026 + + +# Boundary conditions +# +xl_boundary_type = "reflecting" +xr_boundary_type = "outflow" + +# Simulation time, I/O parameters + +cfl = 0.65 # 0.233 # 0.8 +#hy_cflFallbackFactor = 0.5 +basenm = "sedov_" +restart = .false. + +# integral quantities & errors write frequency +wr_integrals_freq = 1 + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 1 + +# plotfile output parameters +plotfileIntervalTime = 0.0004 +plotfileIntervalStep = 0 +plotfileNumber = 0 + +#tstep_change_factor = 1.1 +nend = 2000000 +tmax = 0.05 +dr_shortenLastStepBeforeTMax = .TRUE. + +run_comment = "1D Sedov explosion from tinitial=0.01" +log_file = "sedov.log" +eintSwitch = 0.0 # 1.e-4 +use_auxEintEqn = .FALSE. + +plot_var_1 = "dens" +plot_var_2 = "dena" +plot_var_3 = "pres" +plot_var_4 = "prsa" +plot_var_5 = "velx" +plot_var_6 = "vlxa" +plot_var_7 = "eint" +plot_var_8 = "eina" +plot_var_9 = "ener" +plot_var_10 = "enra" +plot_var_11 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 4 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 512 #global number of gridpoints along x, excluding gcells +iProcs = 2 #num procs in i direction + + +# When using UG, iProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (first/second/third/fifth order) +sim_bcSetBdryVar = .FALSE. +slopeLimiter = "vanLeer1.5" # Slope limiters (minmod,mc,vanLeer,vanLeer1.5,hybrid,limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .FALSE. # Characteristic limiting vs. Primitive limiting + +use_avisc = .FALSE. # Do not use artificial viscosity (originally for PPM) +cvisc = 0.1 # coefficient for artificial viscosity +use_flattening = .false. # use flattening (dissipative) (originally for PPM) +use_steepening = .false. # use contact steepening (originally for PPM) +use_upwindTVD = .false. # use upwind biased TVD slope for PPM (need nguard=6) + +hy_fPresInMomFlux = 0.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/modrefine.par b/modrefine.par new file mode 100644 index 0000000..7052d50 --- /dev/null +++ b/modrefine.par @@ -0,0 +1,136 @@ +# Runtime parameters for the Sedov explosion problem. +# Testing of various runtime parameters that modify the maximum +# refinement level, beased on Sean Couch's adaptations. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.0 +sim_yctr = 0.0 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cylindrical" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "reflecting" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +gr_lrefineMaxRedDoByLogR = .true. +gr_lrefineMaxRedRadiusFact = 0.20 + +gr_lrefineMaxRedDoByTime = .true. + +#gr_refineMaxLevelLogTimeScale = -1.7 +gr_lrefineMaxRedTimeScale = 0.00002 + +gr_lrefineMaxRedTRef = 0.0 + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +##restart = .true. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 24 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.30 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 10 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "vanLeer" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .true. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/restart_pm.par b/restart_pm.par new file mode 100644 index 0000000..5c4b154 --- /dev/null +++ b/restart_pm.par @@ -0,0 +1,134 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .true. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 1 + +# plotfile output parameters +#plotfileIntervalTime = 0. +#plotfileIntervalStep = 0 +#plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 +use_auxEintEqn = .TRUE. + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM + +#hy_fPresInMomFlux = 1.0 # Percentage of pressure gradient for the momentum equation that is handled in momentum fluxes + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +#EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +#shockDetect = .false. # Shock Detect for numerical stability +shockLowerCFL = .false. # Lower CFL at shocks? +## -------------------------------------------------------------## \ No newline at end of file diff --git a/restart_pm_3d.par b/restart_pm_3d.par new file mode 100644 index 0000000..d20a75e --- /dev/null +++ b/restart_pm_3d.par @@ -0,0 +1,84 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_" +restart = .true. +checkpointFileIntervalTime = 0.02 +checkpointFileNumber = 1 + +nend = 1000 +tmax = 0.03 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 +use_auxEintEqn = .TRUE. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM +use_flattening = .true. + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LLF, Marquina +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +#EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. # Entropy fix for the Roe solver + +# III. STRONG SHOCK HANDLING SCHEME: +#shockDetect = .false. # Shock Detect for numerical stability +shockLowerCFL = .false. # Lower CFL at shocks? +## -------------------------------------------------------------## \ No newline at end of file diff --git a/restart_ug.par b/restart_ug.par new file mode 100644 index 0000000..8c58571 --- /dev/null +++ b/restart_ug.par @@ -0,0 +1,130 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_profFileName = "sedovSolutionModLong.dat" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_" +restart = .true. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 1 + +# plotfile output parameters +#plotfileIntervalTime = 0. +#plotfileIntervalStep = 0 +#plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptive Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" + + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 2 #num procs in i direction +jProcs = 2 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 3 # Interpolation order (First/Second/Third order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting +use_steepening = .true. # Contact Steepening for Third order PPM + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver +EOSforRiemann = .false. # Call EoS for Riemann solves +entropy = .false. + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## diff --git a/sedovSolution.dat b/sedovSolution.dat new file mode 100644 index 0000000..843049a --- /dev/null +++ b/sedovSolution.dat @@ -0,0 +1,1017 @@ +# SEDOV SOLUTION ASSUMING E=1, rho_up=1, t=1 +# +# In general, you can define S = [rho_up / (E*t^2)]^(1/5), and scale +# the solution using r -> r/S, v -> v / (S*t), rho -> rho * rho_up, +# and P -> P * rho_up / (S*t)^2. +# +# Gamma = 1.40000000E+00 +# r_0 (shock location) = 1.03277747E+00 +# +# Number of sample points = 1000 +# COLUMNS: +# 1 = r +# 2 = v +# 3 = rho +# 4 = P +# +# SOLUTION: + 1.03277747E-03 2.95079276E-04 5.89478590E-23 5.19751502E-02 + 2.06555493E-03 5.90158553E-04 1.06707023E-20 5.19751502E-02 + 3.09833240E-03 8.85237829E-04 2.23294202E-19 5.19751502E-02 + 4.13110987E-03 1.18031711E-03 1.93160344E-18 5.19751502E-02 + 5.16388734E-03 1.47539638E-03 1.02977672E-17 5.19751502E-02 + 6.19666480E-03 1.77047566E-03 4.04205682E-17 5.19751502E-02 + 7.22944227E-03 2.06555493E-03 1.28440899E-16 5.19751502E-02 + 8.26221974E-03 2.36063421E-03 3.49657573E-16 5.19751502E-02 + 9.29499720E-03 2.65571349E-03 8.45837346E-16 5.19751502E-02 + 1.03277747E-02 2.95079276E-03 1.86409498E-15 5.19751502E-02 + 1.13605521E-02 3.24587204E-03 3.80989647E-15 5.19751502E-02 + 1.23933296E-02 3.54095132E-03 7.31690441E-15 5.19751502E-02 + 1.34261071E-02 3.83603059E-03 1.33365402E-14 5.19751502E-02 + 1.44588845E-02 4.13110987E-03 2.32502862E-14 5.19751502E-02 + 1.54916620E-02 4.42618914E-03 3.90078917E-14 5.19751502E-02 + 1.65244395E-02 4.72126842E-03 6.32947816E-14 5.19751502E-02 + 1.75572169E-02 5.01634770E-03 9.97320959E-14 5.19751502E-02 + 1.85899944E-02 5.31142697E-03 1.53112915E-13 5.19751502E-02 + 1.96227719E-02 5.60650625E-03 2.29678341E-13 5.19751502E-02 + 2.06555493E-02 5.90158553E-03 3.37437235E-13 5.19751502E-02 + 2.16883268E-02 6.19666480E-03 4.86533497E-13 5.19751502E-02 + 2.27211043E-02 6.49174408E-03 6.89664929E-13 5.19751502E-02 + 2.37538817E-02 6.78682336E-03 9.62557774E-13 5.19751502E-02 + 2.47866592E-02 7.08190263E-03 1.32450118E-12 5.19751502E-02 + 2.58194367E-02 7.37698191E-03 1.79894589E-12 5.19751502E-02 + 2.68522141E-02 7.67206118E-03 2.41417165E-12 5.19751502E-02 + 2.78849916E-02 7.96714046E-03 3.20402774E-12 5.19751502E-02 + 2.89177691E-02 8.26221974E-03 4.20875137E-12 5.19751502E-02 + 2.99505465E-02 8.55729901E-03 5.47586862E-12 5.19751502E-02 + 3.09833240E-02 8.85237829E-03 7.06118266E-12 5.19751502E-02 + 3.20161015E-02 9.14745757E-03 9.02985423E-12 5.19751502E-02 + 3.30488789E-02 9.44253684E-03 1.14575793E-11 5.19751502E-02 + 3.40816564E-02 9.73761612E-03 1.44318692E-11 5.19751502E-02 + 3.51144339E-02 1.00326954E-02 1.80534378E-11 5.19751502E-02 + 3.61472113E-02 1.03277747E-02 2.24377016E-11 5.19751502E-02 + 3.71799888E-02 1.06228539E-02 2.77163982E-11 5.19751502E-02 + 3.82127663E-02 1.09179332E-02 3.40393271E-11 5.19751502E-02 + 3.92455437E-02 1.12130125E-02 4.15762208E-11 5.19751502E-02 + 4.02783212E-02 1.15080918E-02 5.05187491E-11 5.19751502E-02 + 4.13110987E-02 1.18031711E-02 6.10826642E-11 5.19751502E-02 + 4.23438762E-02 1.20982503E-02 7.35100911E-11 5.19751502E-02 + 4.33766536E-02 1.23933296E-02 8.80719706E-11 5.19751502E-02 + 4.44094311E-02 1.26884089E-02 1.05070658E-10 5.19751502E-02 + 4.54422086E-02 1.29834882E-02 1.24842688E-10 5.19751502E-02 + 4.64749860E-02 1.32785674E-02 1.47761703E-10 5.19751502E-02 + 4.75077635E-02 1.35736467E-02 1.74241569E-10 5.19751502E-02 + 4.85405410E-02 1.38687260E-02 2.04739657E-10 5.19751502E-02 + 4.95733184E-02 1.41638053E-02 2.39760324E-10 5.19751502E-02 + 5.06060959E-02 1.44588845E-02 2.79858586E-10 5.19751502E-02 + 5.16388734E-02 1.47539638E-02 3.25643991E-10 5.19751502E-02 + 5.26716508E-02 1.50490431E-02 3.77784692E-10 5.19751502E-02 + 5.37044283E-02 1.53441224E-02 4.37011749E-10 5.19751502E-02 + 5.47372058E-02 1.56392016E-02 5.04123634E-10 5.19751502E-02 + 5.57699832E-02 1.59342809E-02 5.79990973E-10 5.19751502E-02 + 5.68027607E-02 1.62293602E-02 6.65561523E-10 5.19751502E-02 + 5.78355382E-02 1.65244395E-02 7.61865379E-10 5.19751502E-02 + 5.88683156E-02 1.68195187E-02 8.70020435E-10 5.19751502E-02 + 5.99010931E-02 1.71145980E-02 9.91238102E-10 5.19751502E-02 + 6.09338706E-02 1.74096773E-02 1.12682928E-09 5.19751502E-02 + 6.19666480E-02 1.77047566E-02 1.27821060E-09 5.19751502E-02 + 6.29994255E-02 1.79998359E-02 1.44691093E-09 5.19751502E-02 + 6.40322030E-02 1.82949151E-02 1.63457822E-09 5.19751502E-02 + 6.50649804E-02 1.85899944E-02 1.84298651E-09 5.19751502E-02 + 6.60977579E-02 1.88850737E-02 2.07404340E-09 5.19751502E-02 + 6.71305354E-02 1.91801530E-02 2.32979769E-09 5.19751502E-02 + 6.81633128E-02 1.94752322E-02 2.61244738E-09 5.19751502E-02 + 6.91960903E-02 1.97703115E-02 2.92434802E-09 5.19751502E-02 + 7.02288678E-02 2.00653908E-02 3.26802132E-09 5.19751502E-02 + 7.12616452E-02 2.03604701E-02 3.64616415E-09 5.19751502E-02 + 7.22944227E-02 2.06555493E-02 4.06165785E-09 5.19751502E-02 + 7.33272002E-02 2.09506286E-02 4.51757791E-09 5.19751502E-02 + 7.43599776E-02 2.12457079E-02 5.01720399E-09 5.19751502E-02 + 7.53927551E-02 2.15407872E-02 5.56403030E-09 5.19751502E-02 + 7.64255326E-02 2.18358664E-02 6.16177639E-09 5.19751502E-02 + 7.74583100E-02 2.21309457E-02 6.81439825E-09 5.19751502E-02 + 7.84910875E-02 2.24260250E-02 7.52609989E-09 5.19751502E-02 + 7.95238650E-02 2.27211043E-02 8.30134522E-09 5.19751502E-02 + 8.05566424E-02 2.30161836E-02 9.14487042E-09 5.19751502E-02 + 8.15894199E-02 2.33112628E-02 1.00616967E-08 5.19751502E-02 + 8.26221974E-02 2.36063421E-02 1.10571433E-08 5.19751502E-02 + 8.36549748E-02 2.39014214E-02 1.21368414E-08 5.19751502E-02 + 8.46877523E-02 2.41965007E-02 1.33067479E-08 5.19751502E-02 + 8.57205298E-02 2.44915799E-02 1.45731599E-08 5.19751502E-02 + 8.67533072E-02 2.47866592E-02 1.59427296E-08 5.19751502E-02 + 8.77860847E-02 2.50817385E-02 1.74224802E-08 5.19751502E-02 + 8.88188622E-02 2.53768178E-02 1.90198208E-08 5.19751502E-02 + 8.98516396E-02 2.56718970E-02 2.07425636E-08 5.19751502E-02 + 9.08844171E-02 2.59669763E-02 2.25989404E-08 5.19751502E-02 + 9.19171946E-02 2.62620556E-02 2.45976199E-08 5.19751502E-02 + 9.29499720E-02 2.65571349E-02 2.67477254E-08 5.19751502E-02 + 9.39827495E-02 2.68522141E-02 2.90588537E-08 5.19751502E-02 + 9.50155270E-02 2.71472934E-02 3.15410931E-08 5.19751502E-02 + 9.60483044E-02 2.74423727E-02 3.42050437E-08 5.19751502E-02 + 9.70810819E-02 2.77374520E-02 3.70618367E-08 5.19751502E-02 + 9.81138594E-02 2.80325312E-02 4.01231550E-08 5.19751502E-02 + 9.91466368E-02 2.83276105E-02 4.34012546E-08 5.19751502E-02 + 1.00179414E-01 2.86226898E-02 4.69089857E-08 5.19751502E-02 + 1.01212192E-01 2.89177691E-02 5.06598155E-08 5.19751502E-02 + 1.02244969E-01 2.92128484E-02 5.46678501E-08 5.19751502E-02 + 1.03277747E-01 2.95079276E-02 5.89478590E-08 5.19751502E-02 + 1.04310524E-01 2.98030069E-02 6.35152979E-08 5.19751502E-02 + 1.05343302E-01 3.00980862E-02 6.83863342E-08 5.19751502E-02 + 1.06376079E-01 3.03931655E-02 7.35778717E-08 5.19751502E-02 + 1.07408857E-01 3.06882447E-02 7.91075766E-08 5.19751502E-02 + 1.08441634E-01 3.09833240E-02 8.49939042E-08 5.19751502E-02 + 1.09474412E-01 3.12784033E-02 9.12561254E-08 5.19751502E-02 + 1.10507189E-01 3.15734826E-02 9.79209268E-08 5.19742200E-02 + 1.11539966E-01 3.18685618E-02 1.04992029E-07 5.19748270E-02 + 1.12572744E-01 3.21636411E-02 1.12504146E-07 5.19750942E-02 + 1.13605521E-01 3.24587204E-02 1.20479229E-07 5.19751820E-02 + 1.14638299E-01 3.27537997E-02 1.28937737E-07 5.19754800E-02 + 1.15671076E-01 3.30488790E-02 1.37911299E-07 5.19752573E-02 + 1.16703854E-01 3.33439582E-02 1.47417230E-07 5.19754092E-02 + 1.17736631E-01 3.36390375E-02 1.57496285E-07 5.19746430E-02 + 1.18769409E-01 3.39341168E-02 1.68150980E-07 5.19752279E-02 + 1.19802186E-01 3.42291961E-02 1.79430280E-07 5.19753806E-02 + 1.20834964E-01 3.45242753E-02 1.91368598E-07 5.19748734E-02 + 1.21867741E-01 3.48193546E-02 2.03975921E-07 5.19752839E-02 + 1.22900519E-01 3.51144339E-02 2.17306120E-07 5.19750956E-02 + 1.23933296E-01 3.54095132E-02 2.31377027E-07 5.19753783E-02 + 1.24966074E-01 3.57045924E-02 2.46237784E-07 5.19752658E-02 + 1.25998851E-01 3.59996717E-02 2.61923754E-07 5.19748911E-02 + 1.27031628E-01 3.62947510E-02 2.78458520E-07 5.19750182E-02 + 1.28064406E-01 3.65898303E-02 2.95894427E-07 5.19749553E-02 + 1.29097183E-01 3.68849096E-02 3.14261078E-07 5.19752313E-02 + 1.30129961E-01 3.71799888E-02 3.33615942E-07 5.19751608E-02 + 1.31162738E-01 3.74750681E-02 3.53994018E-07 5.19751510E-02 + 1.32195516E-01 3.77701474E-02 3.75437684E-07 5.19753082E-02 + 1.33228293E-01 3.80652267E-02 3.98006405E-07 5.19751760E-02 + 1.34261071E-01 3.83603059E-02 4.21737227E-07 5.19751899E-02 + 1.35293848E-01 3.86553852E-02 4.46683806E-07 5.19752316E-02 + 1.36326626E-01 3.89504645E-02 4.72906052E-07 5.19750754E-02 + 1.37359403E-01 3.92455438E-02 5.00442824E-07 5.19751784E-02 + 1.38392181E-01 3.95406231E-02 5.29365830E-07 5.19750904E-02 + 1.39424958E-01 3.98357023E-02 5.59717510E-07 5.19752273E-02 + 1.40457736E-01 4.01307816E-02 5.91571735E-07 5.19752282E-02 + 1.41490513E-01 4.04258609E-02 6.24990391E-07 5.19751170E-02 + 1.42523290E-01 4.07209402E-02 6.60023983E-07 5.19751974E-02 + 1.43556068E-01 4.10160195E-02 6.96752799E-07 5.19751606E-02 + 1.44588845E-01 4.13110987E-02 7.35237307E-07 5.19751751E-02 + 1.45621623E-01 4.16061780E-02 7.75550769E-07 5.19751873E-02 + 1.46654400E-01 4.19012573E-02 8.17770025E-07 5.19751325E-02 + 1.47687178E-01 4.21963366E-02 8.61961494E-07 5.19751651E-02 + 1.48719955E-01 4.24914159E-02 9.08210074E-07 5.19751639E-02 + 1.49752733E-01 4.27864951E-02 9.56596967E-07 5.19751205E-02 + 1.50785510E-01 4.30815744E-02 1.00719963E-06 5.19751156E-02 + 1.51818288E-01 4.33766537E-02 1.06010621E-06 5.19751084E-02 + 1.52851065E-01 4.36717330E-02 1.11540046E-06 5.19751535E-02 + 1.53883843E-01 4.39668123E-02 1.17318358E-06 5.19751214E-02 + 1.54916620E-01 4.42618916E-02 1.23353805E-06 5.19751487E-02 + 1.55949398E-01 4.45569708E-02 1.29657000E-06 5.19751246E-02 + 1.56982175E-01 4.48520501E-02 1.36236722E-06 5.19751754E-02 + 1.58014952E-01 4.51471294E-02 1.43104679E-06 5.19751491E-02 + 1.59047730E-01 4.54422087E-02 1.50270728E-06 5.19751210E-02 + 1.60080507E-01 4.57372880E-02 1.57744928E-06 5.19751631E-02 + 1.61113285E-01 4.60323673E-02 1.65540113E-06 5.19751282E-02 + 1.62146062E-01 4.63274466E-02 1.73666002E-06 5.19751714E-02 + 1.63178840E-01 4.66225259E-02 1.82136266E-06 5.19751438E-02 + 1.64211617E-01 4.69176052E-02 1.90961495E-06 5.19751728E-02 + 1.65244395E-01 4.72126844E-02 2.00155494E-06 5.19751641E-02 + 1.66277172E-01 4.75077637E-02 2.09730864E-06 5.19751442E-02 + 1.67309950E-01 4.78028430E-02 2.19700242E-06 5.19751554E-02 + 1.68342727E-01 4.80979223E-02 2.30078079E-06 5.19751464E-02 + 1.69375505E-01 4.83930016E-02 2.40877660E-06 5.19751640E-02 + 1.70408282E-01 4.86880809E-02 2.52114524E-06 5.19751443E-02 + 1.71441060E-01 4.89831602E-02 2.63802459E-06 5.19751478E-02 + 1.72473837E-01 4.92782395E-02 2.75956925E-06 5.19751612E-02 + 1.73506614E-01 4.95733188E-02 2.88594359E-06 5.19751466E-02 + 1.74539392E-01 4.98683981E-02 3.01730001E-06 5.19751472E-02 + 1.75572169E-01 5.01634774E-02 3.15380623E-06 5.19751509E-02 + 1.76604947E-01 5.04585567E-02 3.29563374E-06 5.19751506E-02 + 1.77637724E-01 5.07536360E-02 3.44295756E-06 5.19751442E-02 + 1.78670502E-01 5.10487153E-02 3.59595100E-06 5.19751548E-02 + 1.79703279E-01 5.13437946E-02 3.75480607E-06 5.19751500E-02 + 1.80736057E-01 5.16388739E-02 3.91970726E-06 5.19751464E-02 + 1.81768834E-01 5.19339533E-02 4.09084678E-06 5.19751486E-02 + 1.82801612E-01 5.22290326E-02 4.26842405E-06 5.19751534E-02 + 1.83834389E-01 5.25241119E-02 4.45264567E-06 5.19751517E-02 + 1.84867167E-01 5.28191912E-02 4.64371977E-06 5.19751471E-02 + 1.85899944E-01 5.31142705E-02 4.84185619E-06 5.19751529E-02 + 1.86932722E-01 5.34093499E-02 5.04728032E-06 5.19751526E-02 + 1.87965499E-01 5.37044292E-02 5.26021366E-06 5.19751573E-02 + 1.88998276E-01 5.39995085E-02 5.48089263E-06 5.19751529E-02 + 1.90031054E-01 5.42945878E-02 5.70954922E-06 5.19751524E-02 + 1.91063831E-01 5.45896672E-02 5.94642485E-06 5.19751583E-02 + 1.92096609E-01 5.48847465E-02 6.19177458E-06 5.19751559E-02 + 1.93129386E-01 5.51798259E-02 6.44584817E-06 5.19751573E-02 + 1.94162164E-01 5.54749052E-02 6.70890835E-06 5.19751587E-02 + 1.95194941E-01 5.57699846E-02 6.98122556E-06 5.19751543E-02 + 1.96227719E-01 5.60650639E-02 7.26306900E-06 5.19751540E-02 + 1.97260496E-01 5.63601433E-02 7.55471918E-06 5.19751573E-02 + 1.98293274E-01 5.66552226E-02 7.85646791E-06 5.19751560E-02 + 1.99326051E-01 5.69503020E-02 8.16860452E-06 5.19751587E-02 + 2.00358829E-01 5.72453814E-02 8.49143282E-06 5.19751607E-02 + 2.01391606E-01 5.75404607E-02 8.82526243E-06 5.19751600E-02 + 2.02424384E-01 5.78355401E-02 9.17040774E-06 5.19751583E-02 + 2.03457161E-01 5.81306195E-02 9.52718838E-06 5.19751606E-02 + 2.04489938E-01 5.84256989E-02 9.89594045E-06 5.19751582E-02 + 2.05522716E-01 5.87207783E-02 1.02769961E-05 5.19751597E-02 + 2.06555493E-01 5.90158577E-02 1.06707033E-05 5.19751616E-02 + 2.07588271E-01 5.93109371E-02 1.10774170E-05 5.19751623E-02 + 2.08621048E-01 5.96060165E-02 1.14974991E-05 5.19751617E-02 + 2.09653826E-01 5.99010959E-02 1.19313182E-05 5.19751615E-02 + 2.10686603E-01 6.01961753E-02 1.23792522E-05 5.19751618E-02 + 2.11719381E-01 6.04912548E-02 1.28416889E-05 5.19751614E-02 + 2.12752158E-01 6.07863342E-02 1.33190212E-05 5.19751632E-02 + 2.13784936E-01 6.10814137E-02 1.38116577E-05 5.19751621E-02 + 2.14817713E-01 6.13764931E-02 1.43200040E-05 5.19751657E-02 + 2.15850491E-01 6.16715726E-02 1.48444919E-05 5.19751646E-02 + 2.16883268E-01 6.19666521E-02 1.53855453E-05 5.19751658E-02 + 2.17916046E-01 6.22617315E-02 1.59436094E-05 5.19751651E-02 + 2.18948823E-01 6.25568110E-02 1.65191286E-05 5.19751678E-02 + 2.19981600E-01 6.28518905E-02 1.71125707E-05 5.19751672E-02 + 2.21014378E-01 6.31469700E-02 1.77243978E-05 5.19751696E-02 + 2.22047155E-01 6.34420496E-02 1.83550981E-05 5.19751684E-02 + 2.23079933E-01 6.37371291E-02 1.90051538E-05 5.19751697E-02 + 2.24112710E-01 6.40322086E-02 1.96750679E-05 5.19751715E-02 + 2.25145488E-01 6.43272882E-02 2.03653537E-05 5.19751721E-02 + 2.26178265E-01 6.46223678E-02 2.10765307E-05 5.19751731E-02 + 2.27211043E-01 6.49174473E-02 2.18091309E-05 5.19751748E-02 + 2.28243820E-01 6.52125269E-02 2.25637016E-05 5.19751748E-02 + 2.29276598E-01 6.55076066E-02 2.33407916E-05 5.19751770E-02 + 2.30309375E-01 6.58026862E-02 2.41409734E-05 5.19751775E-02 + 2.31342153E-01 6.60977658E-02 2.49648201E-05 5.19751791E-02 + 2.32374930E-01 6.63928455E-02 2.58129242E-05 5.19751801E-02 + 2.33407708E-01 6.66879251E-02 2.66858871E-05 5.19751809E-02 + 2.34440485E-01 6.69830048E-02 2.75843192E-05 5.19751829E-02 + 2.35473262E-01 6.72780845E-02 2.85088507E-05 5.19751842E-02 + 2.36506040E-01 6.75731643E-02 2.94601198E-05 5.19751850E-02 + 2.37538817E-01 6.78682440E-02 3.04387744E-05 5.19751869E-02 + 2.38571595E-01 6.81633238E-02 3.14454810E-05 5.19751889E-02 + 2.39604372E-01 6.84584036E-02 3.24809178E-05 5.19751906E-02 + 2.40637150E-01 6.87534834E-02 3.35457772E-05 5.19751914E-02 + 2.41669927E-01 6.90485632E-02 3.46407590E-05 5.19751931E-02 + 2.42702705E-01 6.93436430E-02 3.57665822E-05 5.19751952E-02 + 2.43735482E-01 6.96387229E-02 3.69239806E-05 5.19751971E-02 + 2.44768260E-01 6.99338028E-02 3.81136995E-05 5.19751990E-02 + 2.45801037E-01 7.02288827E-02 3.93364985E-05 5.19752013E-02 + 2.46833815E-01 7.05239627E-02 4.05931556E-05 5.19752029E-02 + 2.47866592E-01 7.08190427E-02 4.18844558E-05 5.19752054E-02 + 2.48899370E-01 7.11141227E-02 4.32112074E-05 5.19752078E-02 + 2.49932147E-01 7.14092027E-02 4.45742294E-05 5.19752102E-02 + 2.50964925E-01 7.17042828E-02 4.59743598E-05 5.19752121E-02 + 2.51997702E-01 7.19993629E-02 4.74124439E-05 5.19752151E-02 + 2.53030479E-01 7.22944430E-02 4.88893548E-05 5.19752176E-02 + 2.54063257E-01 7.25895232E-02 5.04059743E-05 5.19752198E-02 + 2.55096034E-01 7.28846034E-02 5.19631999E-05 5.19752226E-02 + 2.56128812E-01 7.31796836E-02 5.35619471E-05 5.19752259E-02 + 2.57161589E-01 7.34747639E-02 5.52031535E-05 5.19752286E-02 + 2.58194367E-01 7.37698442E-02 5.68877650E-05 5.19752319E-02 + 2.59227144E-01 7.40649245E-02 5.86167536E-05 5.19752346E-02 + 2.60259922E-01 7.43600049E-02 6.03910982E-05 5.19752382E-02 + 2.61292699E-01 7.46550854E-02 6.22118070E-05 5.19752414E-02 + 2.62325477E-01 7.49501658E-02 6.40798988E-05 5.19752448E-02 + 2.63358254E-01 7.52452464E-02 6.59964125E-05 5.19752485E-02 + 2.64391032E-01 7.55403269E-02 6.79624063E-05 5.19752523E-02 + 2.65423809E-01 7.58354076E-02 6.99789590E-05 5.19752559E-02 + 2.66456587E-01 7.61304882E-02 7.20471623E-05 5.19752601E-02 + 2.67489364E-01 7.64255690E-02 7.41681342E-05 5.19752642E-02 + 2.68522141E-01 7.67206497E-02 7.63430086E-05 5.19752685E-02 + 2.69554919E-01 7.70157306E-02 7.85729418E-05 5.19752728E-02 + 2.70587696E-01 7.73108115E-02 8.08591068E-05 5.19752772E-02 + 2.71620474E-01 7.76058924E-02 8.32026973E-05 5.19752821E-02 + 2.72653251E-01 7.79009734E-02 8.56049334E-05 5.19752868E-02 + 2.73686029E-01 7.81960545E-02 8.80670496E-05 5.19752918E-02 + 2.74718806E-01 7.84911357E-02 9.05903030E-05 5.19752971E-02 + 2.75751584E-01 7.87862169E-02 9.31759747E-05 5.19753025E-02 + 2.76784361E-01 7.90812982E-02 9.58253685E-05 5.19753078E-02 + 2.77817139E-01 7.93763795E-02 9.85398040E-05 5.19753136E-02 + 2.78849916E-01 7.96714609E-02 1.01320631E-04 5.19753194E-02 + 2.79882694E-01 7.99665424E-02 1.04169214E-04 5.19753255E-02 + 2.80915471E-01 8.02616240E-02 1.07086951E-04 5.19753316E-02 + 2.81948249E-01 8.05567057E-02 1.10075252E-04 5.19753380E-02 + 2.82981026E-01 8.08517874E-02 1.13135556E-04 5.19753448E-02 + 2.84013803E-01 8.11468693E-02 1.16269329E-04 5.19753516E-02 + 2.85046581E-01 8.14419512E-02 1.19478055E-04 5.19753587E-02 + 2.86079358E-01 8.17370332E-02 1.22763247E-04 5.19753660E-02 + 2.87112136E-01 8.20321154E-02 1.26126440E-04 5.19753735E-02 + 2.88144913E-01 8.23271976E-02 1.29569197E-04 5.19753813E-02 + 2.89177691E-01 8.26222799E-02 1.33093104E-04 5.19753893E-02 + 2.90210468E-01 8.29173623E-02 1.36699775E-04 5.19753974E-02 + 2.91243246E-01 8.32124449E-02 1.40390846E-04 5.19754059E-02 + 2.92276023E-01 8.35075275E-02 1.44167985E-04 5.19754147E-02 + 2.93308801E-01 8.38026103E-02 1.48032884E-04 5.19754237E-02 + 2.94341578E-01 8.40976931E-02 1.51987261E-04 5.19754330E-02 + 2.95374356E-01 8.43927761E-02 1.56032863E-04 5.19754426E-02 + 2.96407133E-01 8.46878593E-02 1.60171465E-04 5.19754524E-02 + 2.97439911E-01 8.49829425E-02 1.64404869E-04 5.19754627E-02 + 2.98472688E-01 8.52780259E-02 1.68734909E-04 5.19754730E-02 + 2.99505465E-01 8.55731094E-02 1.73163441E-04 5.19754838E-02 + 3.00538243E-01 8.58681931E-02 1.77692356E-04 5.19754949E-02 + 3.01571020E-01 8.61632769E-02 1.82323573E-04 5.19755064E-02 + 3.02603798E-01 8.64583609E-02 1.87059041E-04 5.19755181E-02 + 3.03636575E-01 8.67534450E-02 1.91900738E-04 5.19755302E-02 + 3.04669353E-01 8.70485293E-02 1.96850672E-04 5.19755428E-02 + 3.05702130E-01 8.73436137E-02 2.01910888E-04 5.19755556E-02 + 3.06734908E-01 8.76386983E-02 2.07083456E-04 5.19755687E-02 + 3.07767685E-01 8.79337831E-02 2.12370478E-04 5.19755823E-02 + 3.08800463E-01 8.82288681E-02 2.17774091E-04 5.19755963E-02 + 3.09833240E-01 8.85239532E-02 2.23296462E-04 5.19756107E-02 + 3.10866018E-01 8.88190385E-02 2.28939796E-04 5.19756255E-02 + 3.11898795E-01 8.91141241E-02 2.34706325E-04 5.19756406E-02 + 3.12931573E-01 8.94092098E-02 2.40598315E-04 5.19756563E-02 + 3.13964350E-01 8.97042957E-02 2.46618073E-04 5.19756724E-02 + 3.14997127E-01 8.99993819E-02 2.52767933E-04 5.19756889E-02 + 3.16029905E-01 9.02944682E-02 2.59050265E-04 5.19757060E-02 + 3.17062682E-01 9.05895548E-02 2.65467479E-04 5.19757235E-02 + 3.18095460E-01 9.08846416E-02 2.72022017E-04 5.19757414E-02 + 3.19128237E-01 9.11797287E-02 2.78716355E-04 5.19757600E-02 + 3.20161015E-01 9.14748160E-02 2.85553011E-04 5.19757790E-02 + 3.21193792E-01 9.17699035E-02 2.92534535E-04 5.19757985E-02 + 3.22226570E-01 9.20649913E-02 2.99663518E-04 5.19758186E-02 + 3.23259347E-01 9.23600794E-02 3.06942586E-04 5.19758392E-02 + 3.24292125E-01 9.26551677E-02 3.14374404E-04 5.19758604E-02 + 3.25324902E-01 9.29502563E-02 3.21961676E-04 5.19758822E-02 + 3.26357680E-01 9.32453452E-02 3.29707146E-04 5.19759045E-02 + 3.27390457E-01 9.35404344E-02 3.37613594E-04 5.19759276E-02 + 3.28423235E-01 9.38355239E-02 3.45683845E-04 5.19759512E-02 + 3.29456012E-01 9.41306137E-02 3.53920761E-04 5.19759754E-02 + 3.30488789E-01 9.44257038E-02 3.62327245E-04 5.19760003E-02 + 3.31521567E-01 9.47207942E-02 3.70906242E-04 5.19760259E-02 + 3.32554344E-01 9.50158850E-02 3.79660737E-04 5.19760522E-02 + 3.33587122E-01 9.53109761E-02 3.88593762E-04 5.19760791E-02 + 3.34619899E-01 9.56060676E-02 3.97708385E-04 5.19761068E-02 + 3.35652677E-01 9.59011595E-02 4.07007722E-04 5.19761352E-02 + 3.36685454E-01 9.61962517E-02 4.16494932E-04 5.19761644E-02 + 3.37718232E-01 9.64913443E-02 4.26173217E-04 5.19761943E-02 + 3.38751009E-01 9.67864373E-02 4.36045821E-04 5.19762251E-02 + 3.39783787E-01 9.70815307E-02 4.46116038E-04 5.19762566E-02 + 3.40816564E-01 9.73766245E-02 4.56387204E-04 5.19762890E-02 + 3.41849342E-01 9.76717187E-02 4.66862705E-04 5.19763222E-02 + 3.42882119E-01 9.79668134E-02 4.77545966E-04 5.19763563E-02 + 3.43914897E-01 9.82619085E-02 4.88440468E-04 5.19763912E-02 + 3.44947674E-01 9.85570040E-02 4.99549732E-04 5.19764271E-02 + 3.45980451E-01 9.88521001E-02 5.10877333E-04 5.19764639E-02 + 3.47013229E-01 9.91471966E-02 5.22426889E-04 5.19765016E-02 + 3.48046006E-01 9.94422936E-02 5.34202071E-04 5.19765403E-02 + 3.49078784E-01 9.97373912E-02 5.46206597E-04 5.19765800E-02 + 3.50111561E-01 1.00032489E-01 5.58444239E-04 5.19766207E-02 + 3.51144339E-01 1.00327588E-01 5.70918814E-04 5.19766624E-02 + 3.52177116E-01 1.00622687E-01 5.83634193E-04 5.19767052E-02 + 3.53209894E-01 1.00917787E-01 5.96594300E-04 5.19767491E-02 + 3.54242671E-01 1.01212887E-01 6.09803109E-04 5.19767940E-02 + 3.55275449E-01 1.01507988E-01 6.23264647E-04 5.19768401E-02 + 3.56308226E-01 1.01803089E-01 6.36982994E-04 5.19768874E-02 + 3.57341004E-01 1.02098191E-01 6.50962287E-04 5.19769358E-02 + 3.58373781E-01 1.02393294E-01 6.65206712E-04 5.19769855E-02 + 3.59406559E-01 1.02688397E-01 6.79720513E-04 5.19770363E-02 + 3.60439336E-01 1.02983501E-01 6.94507991E-04 5.19770884E-02 + 3.61472113E-01 1.03278606E-01 7.09573499E-04 5.19771419E-02 + 3.62504891E-01 1.03573711E-01 7.24921451E-04 5.19771966E-02 + 3.63537668E-01 1.03868818E-01 7.40556314E-04 5.19772526E-02 + 3.64570446E-01 1.04163924E-01 7.56482615E-04 5.19773101E-02 + 3.65603223E-01 1.04459032E-01 7.72704940E-04 5.19773689E-02 + 3.66636001E-01 1.04754140E-01 7.89227931E-04 5.19774292E-02 + 3.67668778E-01 1.05049250E-01 8.06056293E-04 5.19774909E-02 + 3.68701556E-01 1.05344360E-01 8.23194789E-04 5.19775541E-02 + 3.69734333E-01 1.05639470E-01 8.40648243E-04 5.19776189E-02 + 3.70767111E-01 1.05934582E-01 8.58421542E-04 5.19776852E-02 + 3.71799888E-01 1.06229695E-01 8.76519630E-04 5.19777531E-02 + 3.72832666E-01 1.06524808E-01 8.94947521E-04 5.19778225E-02 + 3.73865443E-01 1.06819922E-01 9.13710285E-04 5.19778937E-02 + 3.74898221E-01 1.07115038E-01 9.32813060E-04 5.19779666E-02 + 3.75930998E-01 1.07410154E-01 9.52261047E-04 5.19780411E-02 + 3.76963775E-01 1.07705271E-01 9.72059513E-04 5.19781175E-02 + 3.77996553E-01 1.08000389E-01 9.92213789E-04 5.19781956E-02 + 3.79029330E-01 1.08295508E-01 1.01272927E-03 5.19782756E-02 + 3.80062108E-01 1.08590629E-01 1.03361143E-03 5.19783575E-02 + 3.81094885E-01 1.08885750E-01 1.05486579E-03 5.19784412E-02 + 3.82127663E-01 1.09180872E-01 1.07649796E-03 5.19785269E-02 + 3.83160440E-01 1.09475996E-01 1.09851361E-03 5.19786146E-02 + 3.84193218E-01 1.09771121E-01 1.12091847E-03 5.19787044E-02 + 3.85225995E-01 1.10066247E-01 1.14371835E-03 5.19787962E-02 + 3.86258773E-01 1.10361374E-01 1.16691915E-03 5.19788901E-02 + 3.87291550E-01 1.10656502E-01 1.19052680E-03 5.19789862E-02 + 3.88324328E-01 1.10951631E-01 1.21454733E-03 5.19790845E-02 + 3.89357105E-01 1.11246762E-01 1.23898684E-03 5.19791851E-02 + 3.90389883E-01 1.11541894E-01 1.26385149E-03 5.19792879E-02 + 3.91422660E-01 1.11837028E-01 1.28914755E-03 5.19793931E-02 + 3.92455437E-01 1.12132163E-01 1.31488131E-03 5.19795006E-02 + 3.93488215E-01 1.12427299E-01 1.34105919E-03 5.19796106E-02 + 3.94520992E-01 1.12722437E-01 1.36768765E-03 5.19797231E-02 + 3.95553770E-01 1.13017576E-01 1.39477324E-03 5.19798381E-02 + 3.96586547E-01 1.13312717E-01 1.42232259E-03 5.19799557E-02 + 3.97619325E-01 1.13607859E-01 1.45034240E-03 5.19800759E-02 + 3.98652102E-01 1.13903003E-01 1.47883946E-03 5.19801988E-02 + 3.99684880E-01 1.14198148E-01 1.50782064E-03 5.19803245E-02 + 4.00717657E-01 1.14493295E-01 1.53729287E-03 5.19804529E-02 + 4.01750435E-01 1.14788444E-01 1.56726319E-03 5.19805842E-02 + 4.02783212E-01 1.15083595E-01 1.59773872E-03 5.19807183E-02 + 4.03815990E-01 1.15378747E-01 1.62872663E-03 5.19808555E-02 + 4.04848767E-01 1.15673901E-01 1.66023420E-03 5.19809956E-02 + 4.05881545E-01 1.15969057E-01 1.69226881E-03 5.19811389E-02 + 4.06914322E-01 1.16264214E-01 1.72483788E-03 5.19812852E-02 + 4.07947099E-01 1.16559374E-01 1.75794897E-03 5.19814347E-02 + 4.08979877E-01 1.16854536E-01 1.79160968E-03 5.19815876E-02 + 4.10012654E-01 1.17149699E-01 1.82582772E-03 5.19817437E-02 + 4.11045432E-01 1.17444865E-01 1.86061090E-03 5.19819032E-02 + 4.12078209E-01 1.17740033E-01 1.89596708E-03 5.19820661E-02 + 4.13110987E-01 1.18035203E-01 1.93190426E-03 5.19822325E-02 + 4.14143764E-01 1.18330375E-01 1.96843048E-03 5.19824026E-02 + 4.15176542E-01 1.18625549E-01 2.00555393E-03 5.19825762E-02 + 4.16209319E-01 1.18920725E-01 2.04328283E-03 5.19827536E-02 + 4.17242097E-01 1.19215904E-01 2.08162554E-03 5.19829348E-02 + 4.18274874E-01 1.19511086E-01 2.12059049E-03 5.19831198E-02 + 4.19307652E-01 1.19806269E-01 2.16018622E-03 5.19833087E-02 + 4.20340429E-01 1.20101455E-01 2.20042136E-03 5.19835017E-02 + 4.21373207E-01 1.20396644E-01 2.24130462E-03 5.19836987E-02 + 4.22405984E-01 1.20691835E-01 2.28284484E-03 5.19838998E-02 + 4.23438762E-01 1.20987029E-01 2.32505093E-03 5.19841052E-02 + 4.24471539E-01 1.21282225E-01 2.36793191E-03 5.19843149E-02 + 4.25504316E-01 1.21577425E-01 2.41149692E-03 5.19845290E-02 + 4.26537094E-01 1.21872627E-01 2.45575516E-03 5.19847475E-02 + 4.27569871E-01 1.22167832E-01 2.50071596E-03 5.19849706E-02 + 4.28602649E-01 1.22463040E-01 2.54638875E-03 5.19851983E-02 + 4.29635426E-01 1.22758250E-01 2.59278306E-03 5.19854307E-02 + 4.30668204E-01 1.23053464E-01 2.63990852E-03 5.19856680E-02 + 4.31700981E-01 1.23348681E-01 2.68777488E-03 5.19859101E-02 + 4.32733759E-01 1.23643901E-01 2.73639197E-03 5.19861572E-02 + 4.33766536E-01 1.23939125E-01 2.78576977E-03 5.19864093E-02 + 4.34799314E-01 1.24234351E-01 2.83591832E-03 5.19866666E-02 + 4.35832091E-01 1.24529581E-01 2.88684781E-03 5.19869292E-02 + 4.36864869E-01 1.24824815E-01 2.93856851E-03 5.19871971E-02 + 4.37897646E-01 1.25120052E-01 2.99109081E-03 5.19874704E-02 + 4.38930424E-01 1.25415292E-01 3.04442523E-03 5.19877493E-02 + 4.39963201E-01 1.25710537E-01 3.09858237E-03 5.19880338E-02 + 4.40995978E-01 1.26005784E-01 3.15357299E-03 5.19883241E-02 + 4.42028756E-01 1.26301036E-01 3.20940791E-03 5.19886202E-02 + 4.43061533E-01 1.26596292E-01 3.26609811E-03 5.19889222E-02 + 4.44094311E-01 1.26891551E-01 3.32365466E-03 5.19892303E-02 + 4.45127088E-01 1.27186815E-01 3.38208876E-03 5.19895445E-02 + 4.46159866E-01 1.27482082E-01 3.44141174E-03 5.19898650E-02 + 4.47192643E-01 1.27777354E-01 3.50163503E-03 5.19901919E-02 + 4.48225421E-01 1.28072630E-01 3.56277019E-03 5.19905252E-02 + 4.49258198E-01 1.28367911E-01 3.62482889E-03 5.19908652E-02 + 4.50290976E-01 1.28663196E-01 3.68782295E-03 5.19912119E-02 + 4.51323753E-01 1.28958485E-01 3.75176428E-03 5.19915653E-02 + 4.52356531E-01 1.29253779E-01 3.81666495E-03 5.19919258E-02 + 4.53389308E-01 1.29549078E-01 3.88253714E-03 5.19922933E-02 + 4.54422086E-01 1.29844381E-01 3.94939314E-03 5.19926680E-02 + 4.55454863E-01 1.30139690E-01 4.01724539E-03 5.19930500E-02 + 4.56487640E-01 1.30435003E-01 4.08610646E-03 5.19934394E-02 + 4.57520418E-01 1.30730322E-01 4.15598905E-03 5.19938364E-02 + 4.58553195E-01 1.31025645E-01 4.22690597E-03 5.19942411E-02 + 4.59585973E-01 1.31320974E-01 4.29887019E-03 5.19946537E-02 + 4.60618750E-01 1.31616309E-01 4.37189480E-03 5.19950742E-02 + 4.61651528E-01 1.31911649E-01 4.44599303E-03 5.19955028E-02 + 4.62684305E-01 1.32206994E-01 4.52117824E-03 5.19959396E-02 + 4.63717083E-01 1.32502345E-01 4.59746394E-03 5.19963848E-02 + 4.64749860E-01 1.32797702E-01 4.67486375E-03 5.19968385E-02 + 4.65782638E-01 1.33093065E-01 4.75339147E-03 5.19973009E-02 + 4.66815415E-01 1.33388434E-01 4.83306100E-03 5.19977720E-02 + 4.67848193E-01 1.33683809E-01 4.91388642E-03 5.19982522E-02 + 4.68880970E-01 1.33979191E-01 4.99588192E-03 5.19987414E-02 + 4.69913748E-01 1.34274578E-01 5.07906185E-03 5.19992399E-02 + 4.70946525E-01 1.34569973E-01 5.16344071E-03 5.19997478E-02 + 4.71979302E-01 1.34865373E-01 5.24903313E-03 5.20002652E-02 + 4.73012080E-01 1.35160781E-01 5.33585391E-03 5.20007924E-02 + 4.74044857E-01 1.35456196E-01 5.42391797E-03 5.20013294E-02 + 4.75077635E-01 1.35751617E-01 5.51324041E-03 5.20018766E-02 + 4.76110412E-01 1.36047046E-01 5.60383646E-03 5.20024339E-02 + 4.77143190E-01 1.36342482E-01 5.69572152E-03 5.20030016E-02 + 4.78175967E-01 1.36637925E-01 5.78891113E-03 5.20035798E-02 + 4.79208745E-01 1.36933376E-01 5.88342099E-03 5.20041688E-02 + 4.80241522E-01 1.37228835E-01 5.97926695E-03 5.20047687E-02 + 4.81274300E-01 1.37524301E-01 6.07646502E-03 5.20053796E-02 + 4.82307077E-01 1.37819776E-01 6.17503139E-03 5.20060018E-02 + 4.83339855E-01 1.38115258E-01 6.27498239E-03 5.20066355E-02 + 4.84372632E-01 1.38410749E-01 6.37633450E-03 5.20072808E-02 + 4.85405410E-01 1.38706248E-01 6.47910438E-03 5.20079379E-02 + 4.86438187E-01 1.39001756E-01 6.58330887E-03 5.20086070E-02 + 4.87470964E-01 1.39297273E-01 6.68896493E-03 5.20092883E-02 + 4.88503742E-01 1.39592798E-01 6.79608974E-03 5.20099820E-02 + 4.89536519E-01 1.39888332E-01 6.90470061E-03 5.20106883E-02 + 4.90569297E-01 1.40183876E-01 7.01481503E-03 5.20114073E-02 + 4.91602074E-01 1.40479429E-01 7.12645067E-03 5.20121394E-02 + 4.92634852E-01 1.40774992E-01 7.23962536E-03 5.20128847E-02 + 4.93667629E-01 1.41070564E-01 7.35435711E-03 5.20136434E-02 + 4.94700407E-01 1.41366146E-01 7.47066410E-03 5.20144158E-02 + 4.95733184E-01 1.41661739E-01 7.58856471E-03 5.20152019E-02 + 4.96765962E-01 1.41957341E-01 7.70807746E-03 5.20160022E-02 + 4.97798739E-01 1.42252954E-01 7.82922107E-03 5.20168167E-02 + 4.98831517E-01 1.42548578E-01 7.95201445E-03 5.20176458E-02 + 4.99864294E-01 1.42844213E-01 8.07647668E-03 5.20184896E-02 + 5.00897072E-01 1.43139858E-01 8.20262702E-03 5.20193483E-02 + 5.01929849E-01 1.43435515E-01 8.33048493E-03 5.20202223E-02 + 5.02962626E-01 1.43731183E-01 8.46007004E-03 5.20211117E-02 + 5.03995404E-01 1.44026862E-01 8.59140219E-03 5.20220168E-02 + 5.05028181E-01 1.44322554E-01 8.72450138E-03 5.20229378E-02 + 5.06060959E-01 1.44618257E-01 8.85938783E-03 5.20238750E-02 + 5.07093736E-01 1.44913973E-01 8.99608195E-03 5.20248287E-02 + 5.08126514E-01 1.45209701E-01 9.13460431E-03 5.20257990E-02 + 5.09159291E-01 1.45505442E-01 9.27497573E-03 5.20267862E-02 + 5.10192069E-01 1.45801196E-01 9.41721718E-03 5.20277907E-02 + 5.11224846E-01 1.46096962E-01 9.56134987E-03 5.20288126E-02 + 5.12257624E-01 1.46392742E-01 9.70739518E-03 5.20298523E-02 + 5.13290401E-01 1.46688536E-01 9.85537470E-03 5.20309099E-02 + 5.14323179E-01 1.46984343E-01 1.00053102E-02 5.20319858E-02 + 5.15355956E-01 1.47280165E-01 1.01572238E-02 5.20330803E-02 + 5.16388734E-01 1.47576001E-01 1.03111376E-02 5.20341937E-02 + 5.17421511E-01 1.47871851E-01 1.04670740E-02 5.20353261E-02 + 5.18454288E-01 1.48167716E-01 1.06250557E-02 5.20364780E-02 + 5.19487066E-01 1.48463596E-01 1.07851056E-02 5.20376496E-02 + 5.20519843E-01 1.48759491E-01 1.09472466E-02 5.20388412E-02 + 5.21552621E-01 1.49055402E-01 1.11115021E-02 5.20400531E-02 + 5.22585398E-01 1.49351328E-01 1.12778955E-02 5.20412856E-02 + 5.23618176E-01 1.49647271E-01 1.14464507E-02 5.20425391E-02 + 5.24650953E-01 1.49943230E-01 1.16171914E-02 5.20438138E-02 + 5.25683731E-01 1.50239205E-01 1.17901419E-02 5.20451100E-02 + 5.26716508E-01 1.50535198E-01 1.19653265E-02 5.20464282E-02 + 5.27749286E-01 1.50831207E-01 1.21427699E-02 5.20477685E-02 + 5.28782063E-01 1.51127235E-01 1.23224970E-02 5.20491314E-02 + 5.29814841E-01 1.51423279E-01 1.25045326E-02 5.20505172E-02 + 5.30847618E-01 1.51719342E-01 1.26889023E-02 5.20519261E-02 + 5.31880396E-01 1.52015424E-01 1.28756315E-02 5.20533587E-02 + 5.32913173E-01 1.52311523E-01 1.30647460E-02 5.20548151E-02 + 5.33945950E-01 1.52607642E-01 1.32562718E-02 5.20562958E-02 + 5.34978728E-01 1.52903780E-01 1.34502351E-02 5.20578011E-02 + 5.36011505E-01 1.53199938E-01 1.36466625E-02 5.20593314E-02 + 5.37044283E-01 1.53496116E-01 1.38455807E-02 5.20608870E-02 + 5.38077060E-01 1.53792314E-01 1.40470167E-02 5.20624683E-02 + 5.39109838E-01 1.54088532E-01 1.42509977E-02 5.20640757E-02 + 5.40142615E-01 1.54384772E-01 1.44575512E-02 5.20657096E-02 + 5.41175393E-01 1.54681032E-01 1.46667050E-02 5.20673704E-02 + 5.42208170E-01 1.54977315E-01 1.48784870E-02 5.20690584E-02 + 5.43240948E-01 1.55273619E-01 1.50929255E-02 5.20707740E-02 + 5.44273725E-01 1.55569945E-01 1.53100491E-02 5.20725177E-02 + 5.45306503E-01 1.55866295E-01 1.55298864E-02 5.20742898E-02 + 5.46339280E-01 1.56162667E-01 1.57524665E-02 5.20760908E-02 + 5.47372058E-01 1.56459063E-01 1.59778187E-02 5.20779211E-02 + 5.48404835E-01 1.56755483E-01 1.62059727E-02 5.20797810E-02 + 5.49437612E-01 1.57051926E-01 1.64369581E-02 5.20816711E-02 + 5.50470390E-01 1.57348395E-01 1.66708052E-02 5.20835917E-02 + 5.51503167E-01 1.57644888E-01 1.69075443E-02 5.20855433E-02 + 5.52535945E-01 1.57941407E-01 1.71472061E-02 5.20875264E-02 + 5.53568722E-01 1.58237951E-01 1.73898215E-02 5.20895413E-02 + 5.54601500E-01 1.58534522E-01 1.76354218E-02 5.20915886E-02 + 5.55634277E-01 1.58831120E-01 1.78840384E-02 5.20936687E-02 + 5.56667055E-01 1.59127744E-01 1.81357032E-02 5.20957820E-02 + 5.57699832E-01 1.59424396E-01 1.83904483E-02 5.20979291E-02 + 5.58732610E-01 1.59721076E-01 1.86483059E-02 5.21001103E-02 + 5.59765387E-01 1.60017784E-01 1.89093088E-02 5.21023263E-02 + 5.60798165E-01 1.60314521E-01 1.91734900E-02 5.21045774E-02 + 5.61830942E-01 1.60611287E-01 1.94408827E-02 5.21068642E-02 + 5.62863720E-01 1.60908083E-01 1.97115205E-02 5.21091872E-02 + 5.63896497E-01 1.61204909E-01 1.99854372E-02 5.21115469E-02 + 5.64929274E-01 1.61501766E-01 2.02626671E-02 5.21139438E-02 + 5.65962052E-01 1.61798654E-01 2.05432446E-02 5.21163784E-02 + 5.66994829E-01 1.62095574E-01 2.08272044E-02 5.21188512E-02 + 5.68027607E-01 1.62392526E-01 2.11145819E-02 5.21213628E-02 + 5.69060384E-01 1.62689510E-01 2.14054122E-02 5.21239138E-02 + 5.70093162E-01 1.62986527E-01 2.16997313E-02 5.21265045E-02 + 5.71125939E-01 1.63283579E-01 2.19975752E-02 5.21291357E-02 + 5.72158717E-01 1.63580664E-01 2.22989802E-02 5.21318079E-02 + 5.73191494E-01 1.63877784E-01 2.26039832E-02 5.21345216E-02 + 5.74224272E-01 1.64174939E-01 2.29126211E-02 5.21372775E-02 + 5.75257049E-01 1.64472130E-01 2.32249315E-02 5.21400760E-02 + 5.76289827E-01 1.64769358E-01 2.35409519E-02 5.21429178E-02 + 5.77322604E-01 1.65066622E-01 2.38607205E-02 5.21458035E-02 + 5.78355382E-01 1.65363924E-01 2.41842757E-02 5.21487336E-02 + 5.79388159E-01 1.65661264E-01 2.45116562E-02 5.21517088E-02 + 5.80420937E-01 1.65958642E-01 2.48429013E-02 5.21547298E-02 + 5.81453714E-01 1.66256060E-01 2.51780503E-02 5.21577970E-02 + 5.82486491E-01 1.66553517E-01 2.55171430E-02 5.21609113E-02 + 5.83519269E-01 1.66851015E-01 2.58602197E-02 5.21640731E-02 + 5.84552046E-01 1.67148554E-01 2.62073210E-02 5.21672831E-02 + 5.85584824E-01 1.67446134E-01 2.65584876E-02 5.21705420E-02 + 5.86617601E-01 1.67743757E-01 2.69137609E-02 5.21738505E-02 + 5.87650379E-01 1.68041422E-01 2.72731826E-02 5.21772093E-02 + 5.88683156E-01 1.68339132E-01 2.76367946E-02 5.21806189E-02 + 5.89715934E-01 1.68636885E-01 2.80046395E-02 5.21840801E-02 + 5.90748711E-01 1.68934683E-01 2.83767599E-02 5.21875936E-02 + 5.91781489E-01 1.69232527E-01 2.87531991E-02 5.21911601E-02 + 5.92814266E-01 1.69530417E-01 2.91340006E-02 5.21947803E-02 + 5.93847044E-01 1.69828354E-01 2.95192085E-02 5.21984549E-02 + 5.94879821E-01 1.70126339E-01 2.99088669E-02 5.22021847E-02 + 5.95912599E-01 1.70424372E-01 3.03030209E-02 5.22059703E-02 + 5.96945376E-01 1.70722454E-01 3.07017153E-02 5.22098126E-02 + 5.97978153E-01 1.71020585E-01 3.11049960E-02 5.22137123E-02 + 5.99010931E-01 1.71318768E-01 3.15129088E-02 5.22176701E-02 + 6.00043708E-01 1.71617001E-01 3.19255002E-02 5.22216868E-02 + 6.01076486E-01 1.71915287E-01 3.23428170E-02 5.22257632E-02 + 6.02109263E-01 1.72213625E-01 3.27649064E-02 5.22299001E-02 + 6.03142041E-01 1.72512017E-01 3.31918161E-02 5.22340983E-02 + 6.04174818E-01 1.72810463E-01 3.36235943E-02 5.22383586E-02 + 6.05207596E-01 1.73108964E-01 3.40602895E-02 5.22426819E-02 + 6.06240373E-01 1.73407522E-01 3.45019506E-02 5.22470689E-02 + 6.07273151E-01 1.73706136E-01 3.49486272E-02 5.22515204E-02 + 6.08305928E-01 1.74004807E-01 3.54003690E-02 5.22560374E-02 + 6.09338706E-01 1.74303537E-01 3.58572265E-02 5.22606207E-02 + 6.10371483E-01 1.74602327E-01 3.63192504E-02 5.22652712E-02 + 6.11404261E-01 1.74901176E-01 3.67864920E-02 5.22699897E-02 + 6.12437038E-01 1.75200087E-01 3.72590031E-02 5.22747772E-02 + 6.13469815E-01 1.75499059E-01 3.77368358E-02 5.22796345E-02 + 6.14502593E-01 1.75798094E-01 3.82200428E-02 5.22845625E-02 + 6.15535370E-01 1.76097193E-01 3.87086772E-02 5.22895622E-02 + 6.16568148E-01 1.76396357E-01 3.92027928E-02 5.22946345E-02 + 6.17600925E-01 1.76695586E-01 3.97024437E-02 5.22997803E-02 + 6.18633703E-01 1.76994881E-01 4.02076845E-02 5.23050006E-02 + 6.19666480E-01 1.77294244E-01 4.07185703E-02 5.23102964E-02 + 6.20699258E-01 1.77593676E-01 4.12351568E-02 5.23156686E-02 + 6.21732035E-01 1.77893176E-01 4.17575002E-02 5.23211182E-02 + 6.22764813E-01 1.78192747E-01 4.22856571E-02 5.23266462E-02 + 6.23797590E-01 1.78492390E-01 4.28196846E-02 5.23322537E-02 + 6.24830368E-01 1.78792104E-01 4.33596407E-02 5.23379416E-02 + 6.25863145E-01 1.79091893E-01 4.39055834E-02 5.23437111E-02 + 6.26895923E-01 1.79391755E-01 4.44575717E-02 5.23495630E-02 + 6.27928700E-01 1.79691693E-01 4.50156648E-02 5.23554985E-02 + 6.28961477E-01 1.79991708E-01 4.55799226E-02 5.23615187E-02 + 6.29994255E-01 1.80291800E-01 4.61504056E-02 5.23676247E-02 + 6.31027032E-01 1.80591971E-01 4.67271748E-02 5.23738174E-02 + 6.32059810E-01 1.80892222E-01 4.73102917E-02 5.23800982E-02 + 6.33092587E-01 1.81192553E-01 4.78998186E-02 5.23864679E-02 + 6.34125365E-01 1.81492967E-01 4.84958182E-02 5.23929279E-02 + 6.35158142E-01 1.81793464E-01 4.90983537E-02 5.23994793E-02 + 6.36190920E-01 1.82094046E-01 4.97074892E-02 5.24061231E-02 + 6.37223697E-01 1.82394713E-01 5.03232890E-02 5.24128607E-02 + 6.38256475E-01 1.82695466E-01 5.09458183E-02 5.24196931E-02 + 6.39289252E-01 1.82996308E-01 5.15751429E-02 5.24266216E-02 + 6.40322030E-01 1.83297239E-01 5.22113291E-02 5.24336473E-02 + 6.41354807E-01 1.83598260E-01 5.28544439E-02 5.24407716E-02 + 6.42387585E-01 1.83899373E-01 5.35045548E-02 5.24479957E-02 + 6.43420362E-01 1.84200578E-01 5.41617302E-02 5.24553208E-02 + 6.44453139E-01 1.84501878E-01 5.48260389E-02 5.24627481E-02 + 6.45485917E-01 1.84803274E-01 5.54975504E-02 5.24702791E-02 + 6.46518694E-01 1.85104766E-01 5.61763350E-02 5.24779149E-02 + 6.47551472E-01 1.85406356E-01 5.68624636E-02 5.24856569E-02 + 6.48584249E-01 1.85708046E-01 5.75560076E-02 5.24935065E-02 + 6.49617027E-01 1.86009836E-01 5.82570395E-02 5.25014649E-02 + 6.50649804E-01 1.86311729E-01 5.89656319E-02 5.25095336E-02 + 6.51682582E-01 1.86613726E-01 5.96818587E-02 5.25177139E-02 + 6.52715359E-01 1.86915827E-01 6.04057942E-02 5.25260072E-02 + 6.53748137E-01 1.87218035E-01 6.11375133E-02 5.25344149E-02 + 6.54780914E-01 1.87520350E-01 6.18770919E-02 5.25429385E-02 + 6.55813692E-01 1.87822775E-01 6.26246065E-02 5.25515793E-02 + 6.56846469E-01 1.88125311E-01 6.33801343E-02 5.25603390E-02 + 6.57879247E-01 1.88427959E-01 6.41437533E-02 5.25692188E-02 + 6.58912024E-01 1.88730721E-01 6.49155424E-02 5.25782204E-02 + 6.59944801E-01 1.89033598E-01 6.56955810E-02 5.25873452E-02 + 6.60977579E-01 1.89336592E-01 6.64839494E-02 5.25965948E-02 + 6.62010356E-01 1.89639704E-01 6.72807287E-02 5.26059707E-02 + 6.63043134E-01 1.89942937E-01 6.80860009E-02 5.26154744E-02 + 6.64075911E-01 1.90246291E-01 6.88998486E-02 5.26251077E-02 + 6.65108689E-01 1.90549768E-01 6.97223553E-02 5.26348719E-02 + 6.66141466E-01 1.90853370E-01 7.05536054E-02 5.26447689E-02 + 6.67174244E-01 1.91157099E-01 7.13936839E-02 5.26548001E-02 + 6.68207021E-01 1.91460956E-01 7.22426771E-02 5.26649674E-02 + 6.69239799E-01 1.91764943E-01 7.31006716E-02 5.26752722E-02 + 6.70272576E-01 1.92069061E-01 7.39677553E-02 5.26857164E-02 + 6.71305354E-01 1.92373313E-01 7.48440167E-02 5.26963017E-02 + 6.72338131E-01 1.92677700E-01 7.57295454E-02 5.27070297E-02 + 6.73370909E-01 1.92982224E-01 7.66244317E-02 5.27179023E-02 + 6.74403686E-01 1.93286887E-01 7.75287670E-02 5.27289212E-02 + 6.75436463E-01 1.93591690E-01 7.84426435E-02 5.27400882E-02 + 6.76469241E-01 1.93896636E-01 7.93661543E-02 5.27514051E-02 + 6.77502018E-01 1.94201726E-01 8.02993936E-02 5.27628738E-02 + 6.78534796E-01 1.94506962E-01 8.12424564E-02 5.27744960E-02 + 6.79567573E-01 1.94812346E-01 8.21954388E-02 5.27862738E-02 + 6.80600351E-01 1.95117880E-01 8.31584378E-02 5.27982090E-02 + 6.81633128E-01 1.95423566E-01 8.41315513E-02 5.28103035E-02 + 6.82665906E-01 1.95729406E-01 8.51148784E-02 5.28225592E-02 + 6.83698683E-01 1.96035402E-01 8.61085192E-02 5.28349782E-02 + 6.84731461E-01 1.96341556E-01 8.71125747E-02 5.28475624E-02 + 6.85764238E-01 1.96647869E-01 8.81271471E-02 5.28603138E-02 + 6.86797016E-01 1.96954345E-01 8.91523394E-02 5.28732345E-02 + 6.87829793E-01 1.97260985E-01 9.01882560E-02 5.28863265E-02 + 6.88862571E-01 1.97567791E-01 9.12350022E-02 5.28995920E-02 + 6.89895348E-01 1.97874765E-01 9.22926845E-02 5.29130329E-02 + 6.90928125E-01 1.98181910E-01 9.33614104E-02 5.29266515E-02 + 6.91960903E-01 1.98489228E-01 9.44412885E-02 5.29404500E-02 + 6.92993680E-01 1.98796721E-01 9.55324289E-02 5.29544304E-02 + 6.94026458E-01 1.99104390E-01 9.66349424E-02 5.29685950E-02 + 6.95059235E-01 1.99412239E-01 9.77489412E-02 5.29829460E-02 + 6.96092013E-01 1.99720270E-01 9.88745388E-02 5.29974858E-02 + 6.97124790E-01 2.00028485E-01 1.00011850E-01 5.30122165E-02 + 6.98157568E-01 2.00336886E-01 1.01160990E-01 5.30271405E-02 + 6.99190345E-01 2.00645476E-01 1.02322076E-01 5.30422601E-02 + 7.00223123E-01 2.00954257E-01 1.03495227E-01 5.30575778E-02 + 7.01255900E-01 2.01263232E-01 1.04680562E-01 5.30730958E-02 + 7.02288678E-01 2.01572402E-01 1.05878202E-01 5.30888167E-02 + 7.03321455E-01 2.01881771E-01 1.07088270E-01 5.31047428E-02 + 7.04354233E-01 2.02191341E-01 1.08310888E-01 5.31208767E-02 + 7.05387010E-01 2.02501115E-01 1.09546183E-01 5.31372208E-02 + 7.06419787E-01 2.02811094E-01 1.10794279E-01 5.31537777E-02 + 7.07452565E-01 2.03121282E-01 1.12055305E-01 5.31705500E-02 + 7.08485342E-01 2.03431681E-01 1.13329390E-01 5.31875403E-02 + 7.09518120E-01 2.03742294E-01 1.14616665E-01 5.32047511E-02 + 7.10550897E-01 2.04053124E-01 1.15917260E-01 5.32221852E-02 + 7.11583675E-01 2.04364173E-01 1.17231311E-01 5.32398453E-02 + 7.12616452E-01 2.04675444E-01 1.18558952E-01 5.32577340E-02 + 7.13649230E-01 2.04986939E-01 1.19900318E-01 5.32758541E-02 + 7.14682007E-01 2.05298662E-01 1.21255550E-01 5.32942085E-02 + 7.15714785E-01 2.05610615E-01 1.22624784E-01 5.33127999E-02 + 7.16747562E-01 2.05922802E-01 1.24008164E-01 5.33316312E-02 + 7.17780340E-01 2.06235224E-01 1.25405832E-01 5.33507052E-02 + 7.18813117E-01 2.06547886E-01 1.26817932E-01 5.33700250E-02 + 7.19845895E-01 2.06860789E-01 1.28244610E-01 5.33895934E-02 + 7.20878672E-01 2.07173937E-01 1.29686014E-01 5.34094135E-02 + 7.21911449E-01 2.07487333E-01 1.31142294E-01 5.34294883E-02 + 7.22944227E-01 2.07800980E-01 1.32613600E-01 5.34498208E-02 + 7.23977004E-01 2.08114881E-01 1.34100085E-01 5.34704142E-02 + 7.25009782E-01 2.08429039E-01 1.35601905E-01 5.34912716E-02 + 7.26042559E-01 2.08743457E-01 1.37119216E-01 5.35123961E-02 + 7.27075337E-01 2.09058139E-01 1.38652175E-01 5.35337911E-02 + 7.28108114E-01 2.09373088E-01 1.40200944E-01 5.35554596E-02 + 7.29140892E-01 2.09688306E-01 1.41765684E-01 5.35774051E-02 + 7.30173669E-01 2.10003797E-01 1.43346560E-01 5.35996309E-02 + 7.31206447E-01 2.10319565E-01 1.44943737E-01 5.36221403E-02 + 7.32239224E-01 2.10635612E-01 1.46557384E-01 5.36449368E-02 + 7.33272002E-01 2.10951943E-01 1.48187670E-01 5.36680238E-02 + 7.34304779E-01 2.11268560E-01 1.49834768E-01 5.36914047E-02 + 7.35337557E-01 2.11585468E-01 1.51498852E-01 5.37150833E-02 + 7.36370334E-01 2.11902669E-01 1.53180097E-01 5.37390630E-02 + 7.37403111E-01 2.12220167E-01 1.54878683E-01 5.37633474E-02 + 7.38435889E-01 2.12537965E-01 1.56594789E-01 5.37879403E-02 + 7.39468666E-01 2.12856068E-01 1.58328599E-01 5.38128453E-02 + 7.40501444E-01 2.13174479E-01 1.60080298E-01 5.38380662E-02 + 7.41534221E-01 2.13493201E-01 1.61850073E-01 5.38636069E-02 + 7.42566999E-01 2.13812239E-01 1.63638114E-01 5.38894711E-02 + 7.43599776E-01 2.14131596E-01 1.65444612E-01 5.39156628E-02 + 7.44632554E-01 2.14451275E-01 1.67269762E-01 5.39421859E-02 + 7.45665331E-01 2.14771281E-01 1.69113761E-01 5.39690445E-02 + 7.46698109E-01 2.15091618E-01 1.70976809E-01 5.39962425E-02 + 7.47730886E-01 2.15412289E-01 1.72859106E-01 5.40237841E-02 + 7.48763664E-01 2.15733299E-01 1.74760858E-01 5.40516735E-02 + 7.49796441E-01 2.16054651E-01 1.76682271E-01 5.40799148E-02 + 7.50829219E-01 2.16376349E-01 1.78623555E-01 5.41085122E-02 + 7.51861996E-01 2.16698398E-01 1.80584923E-01 5.41374702E-02 + 7.52894774E-01 2.17020802E-01 1.82566589E-01 5.41667930E-02 + 7.53927551E-01 2.17343564E-01 1.84568771E-01 5.41964851E-02 + 7.54960328E-01 2.17666689E-01 1.86591690E-01 5.42265509E-02 + 7.55993106E-01 2.17990182E-01 1.88635569E-01 5.42569950E-02 + 7.57025883E-01 2.18314046E-01 1.90700635E-01 5.42878220E-02 + 7.58058661E-01 2.18638287E-01 1.92787117E-01 5.43190365E-02 + 7.59091438E-01 2.18962907E-01 1.94895248E-01 5.43506432E-02 + 7.60124216E-01 2.19287913E-01 1.97025263E-01 5.43826468E-02 + 7.61156993E-01 2.19613307E-01 1.99177401E-01 5.44150523E-02 + 7.62189771E-01 2.19939095E-01 2.01351903E-01 5.44478644E-02 + 7.63222548E-01 2.20265282E-01 2.03549015E-01 5.44810882E-02 + 7.64255326E-01 2.20591871E-01 2.05768985E-01 5.45147286E-02 + 7.65288103E-01 2.20918868E-01 2.08012064E-01 5.45487907E-02 + 7.66320881E-01 2.21246278E-01 2.10278508E-01 5.45832796E-02 + 7.67353658E-01 2.21574104E-01 2.12568575E-01 5.46182006E-02 + 7.68386436E-01 2.21902352E-01 2.14882527E-01 5.46535590E-02 + 7.69419213E-01 2.22231027E-01 2.17220629E-01 5.46893600E-02 + 7.70451990E-01 2.22560133E-01 2.19583152E-01 5.47256091E-02 + 7.71484768E-01 2.22889676E-01 2.21970368E-01 5.47623117E-02 + 7.72517545E-01 2.23219660E-01 2.24382553E-01 5.47994735E-02 + 7.73550323E-01 2.23550091E-01 2.26819988E-01 5.48371000E-02 + 7.74583100E-01 2.23880974E-01 2.29282959E-01 5.48751969E-02 + 7.75615878E-01 2.24212313E-01 2.31771752E-01 5.49137701E-02 + 7.76648655E-01 2.24544115E-01 2.34286661E-01 5.49528253E-02 + 7.77681433E-01 2.24876383E-01 2.36827983E-01 5.49923686E-02 + 7.78714210E-01 2.25209125E-01 2.39396018E-01 5.50324058E-02 + 7.79746988E-01 2.25542344E-01 2.41991071E-01 5.50729431E-02 + 7.80779765E-01 2.25876046E-01 2.44613452E-01 5.51139867E-02 + 7.81812543E-01 2.26210238E-01 2.47263475E-01 5.51555427E-02 + 7.82845320E-01 2.26544923E-01 2.49941458E-01 5.51976176E-02 + 7.83878098E-01 2.26880108E-01 2.52647724E-01 5.52402177E-02 + 7.84910875E-01 2.27215799E-01 2.55382600E-01 5.52833496E-02 + 7.85943652E-01 2.27552001E-01 2.58146421E-01 5.53270198E-02 + 7.86976430E-01 2.27888720E-01 2.60939521E-01 5.53712350E-02 + 7.88009207E-01 2.28225962E-01 2.63762245E-01 5.54160020E-02 + 7.89041985E-01 2.28563732E-01 2.66614938E-01 5.54613276E-02 + 7.90074762E-01 2.28902036E-01 2.69497955E-01 5.55072188E-02 + 7.91107540E-01 2.29240881E-01 2.72411651E-01 5.55536826E-02 + 7.92140317E-01 2.29580272E-01 2.75356390E-01 5.56007263E-02 + 7.93173095E-01 2.29920216E-01 2.78332541E-01 5.56483569E-02 + 7.94205872E-01 2.30260718E-01 2.81340477E-01 5.56965820E-02 + 7.95238650E-01 2.30601785E-01 2.84380579E-01 5.57454088E-02 + 7.96271427E-01 2.30943423E-01 2.87453230E-01 5.57948450E-02 + 7.97304205E-01 2.31285638E-01 2.90558823E-01 5.58448982E-02 + 7.98336982E-01 2.31628437E-01 2.93697754E-01 5.58955761E-02 + 7.99369760E-01 2.31971826E-01 2.96870426E-01 5.59468866E-02 + 8.00402537E-01 2.32315812E-01 3.00077249E-01 5.59988378E-02 + 8.01435314E-01 2.32660401E-01 3.03318639E-01 5.60514376E-02 + 8.02468092E-01 2.33005600E-01 3.06595018E-01 5.61046943E-02 + 8.03500869E-01 2.33351415E-01 3.09906813E-01 5.61586161E-02 + 8.04533647E-01 2.33697853E-01 3.13254462E-01 5.62132116E-02 + 8.05566424E-01 2.34044921E-01 3.16638405E-01 5.62684892E-02 + 8.06599202E-01 2.34392626E-01 3.20059091E-01 5.63244577E-02 + 8.07631979E-01 2.34740975E-01 3.23516978E-01 5.63811258E-02 + 8.08664757E-01 2.35089974E-01 3.27012528E-01 5.64385024E-02 + 8.09697534E-01 2.35439631E-01 3.30546212E-01 5.64965966E-02 + 8.10730312E-01 2.35789953E-01 3.34118508E-01 5.65554176E-02 + 8.11763089E-01 2.36140947E-01 3.37729902E-01 5.66149746E-02 + 8.12795867E-01 2.36492621E-01 3.41380889E-01 5.66752771E-02 + 8.13828644E-01 2.36844981E-01 3.45071969E-01 5.67363348E-02 + 8.14861422E-01 2.37198035E-01 3.48803653E-01 5.67981572E-02 + 8.15894199E-01 2.37551791E-01 3.52576459E-01 5.68607542E-02 + 8.16926976E-01 2.37906255E-01 3.56390914E-01 5.69241360E-02 + 8.17959754E-01 2.38261436E-01 3.60247551E-01 5.69883125E-02 + 8.18992531E-01 2.38617342E-01 3.64146917E-01 5.70532942E-02 + 8.20025309E-01 2.38973979E-01 3.68089564E-01 5.71190913E-02 + 8.21058086E-01 2.39331356E-01 3.72076054E-01 5.71857147E-02 + 8.22090864E-01 2.39689480E-01 3.76106958E-01 5.72531749E-02 + 8.23123641E-01 2.40048360E-01 3.80182858E-01 5.73214830E-02 + 8.24156419E-01 2.40408004E-01 3.84304346E-01 5.73906500E-02 + 8.25189196E-01 2.40768419E-01 3.88472021E-01 5.74606871E-02 + 8.26221974E-01 2.41129614E-01 3.92686495E-01 5.75316058E-02 + 8.27254751E-01 2.41491596E-01 3.96948389E-01 5.76034177E-02 + 8.28287529E-01 2.41854375E-01 4.01258335E-01 5.76761345E-02 + 8.29320306E-01 2.42217958E-01 4.05616977E-01 5.77497681E-02 + 8.30353084E-01 2.42582354E-01 4.10024968E-01 5.78243307E-02 + 8.31385861E-01 2.42947572E-01 4.14482973E-01 5.78998346E-02 + 8.32418638E-01 2.43313620E-01 4.18991670E-01 5.79762923E-02 + 8.33451416E-01 2.43680506E-01 4.23551746E-01 5.80537164E-02 + 8.34484193E-01 2.44048240E-01 4.28163901E-01 5.81321198E-02 + 8.35516971E-01 2.44416830E-01 4.32828850E-01 5.82115156E-02 + 8.36549748E-01 2.44786285E-01 4.37547317E-01 5.82919171E-02 + 8.37582526E-01 2.45156614E-01 4.42320040E-01 5.83733378E-02 + 8.38615303E-01 2.45527826E-01 4.47147771E-01 5.84557913E-02 + 8.39648081E-01 2.45899930E-01 4.52031274E-01 5.85392916E-02 + 8.40680858E-01 2.46272935E-01 4.56971327E-01 5.86238527E-02 + 8.41713636E-01 2.46646851E-01 4.61968723E-01 5.87094891E-02 + 8.42746413E-01 2.47021686E-01 4.67024268E-01 5.87962153E-02 + 8.43779191E-01 2.47397451E-01 4.72138782E-01 5.88840461E-02 + 8.44811968E-01 2.47774154E-01 4.77313103E-01 5.89729965E-02 + 8.45844746E-01 2.48151806E-01 4.82548081E-01 5.90630818E-02 + 8.46877523E-01 2.48530415E-01 4.87844583E-01 5.91543175E-02 + 8.47910300E-01 2.48909992E-01 4.93203492E-01 5.92467194E-02 + 8.48943078E-01 2.49290546E-01 4.98625706E-01 5.93403035E-02 + 8.49975855E-01 2.49672088E-01 5.04112141E-01 5.94350861E-02 + 8.51008633E-01 2.50054626E-01 5.09663730E-01 5.95310837E-02 + 8.52041410E-01 2.50438172E-01 5.15281422E-01 5.96283132E-02 + 8.53074188E-01 2.50822734E-01 5.20966186E-01 5.97267915E-02 + 8.54106965E-01 2.51208324E-01 5.26719006E-01 5.98265361E-02 + 8.55139743E-01 2.51594952E-01 5.32540889E-01 5.99275645E-02 + 8.56172520E-01 2.51982627E-01 5.38432857E-01 6.00298948E-02 + 8.57205298E-01 2.52371361E-01 5.44395953E-01 6.01335452E-02 + 8.58238075E-01 2.52761164E-01 5.50431240E-01 6.02385342E-02 + 8.59270853E-01 2.53152046E-01 5.56539802E-01 6.03448805E-02 + 8.60303630E-01 2.53544018E-01 5.62722742E-01 6.04526034E-02 + 8.61336408E-01 2.53937090E-01 5.68981186E-01 6.05617224E-02 + 8.62369185E-01 2.54331274E-01 5.75316282E-01 6.06722572E-02 + 8.63401962E-01 2.54726581E-01 5.81729198E-01 6.07842279E-02 + 8.64434740E-01 2.55123021E-01 5.88221128E-01 6.08976550E-02 + 8.65467517E-01 2.55520605E-01 5.94793286E-01 6.10125594E-02 + 8.66500295E-01 2.55919344E-01 6.01446914E-01 6.11289621E-02 + 8.67533072E-01 2.56319251E-01 6.08183274E-01 6.12468848E-02 + 8.68565850E-01 2.56720335E-01 6.15003657E-01 6.13663492E-02 + 8.69598627E-01 2.57122608E-01 6.21909377E-01 6.14873778E-02 + 8.70631405E-01 2.57526082E-01 6.28901776E-01 6.16099930E-02 + 8.71664182E-01 2.57930769E-01 6.35982222E-01 6.17342180E-02 + 8.72696960E-01 2.58336679E-01 6.43152111E-01 6.18600761E-02 + 8.73729737E-01 2.58743824E-01 6.50412867E-01 6.19875914E-02 + 8.74762515E-01 2.59152216E-01 6.57765943E-01 6.21167879E-02 + 8.75795292E-01 2.59561868E-01 6.65212822E-01 6.22476904E-02 + 8.76828070E-01 2.59972790E-01 6.72755017E-01 6.23803240E-02 + 8.77860847E-01 2.60384995E-01 6.80394071E-01 6.25147143E-02 + 8.78893624E-01 2.60798495E-01 6.88131561E-01 6.26508872E-02 + 8.79926402E-01 2.61213302E-01 6.95969096E-01 6.27888693E-02 + 8.80959179E-01 2.61629428E-01 7.03908317E-01 6.29286875E-02 + 8.81991957E-01 2.62046885E-01 7.11950901E-01 6.30703692E-02 + 8.83024734E-01 2.62465687E-01 7.20098560E-01 6.32139424E-02 + 8.84057512E-01 2.62885844E-01 7.28353040E-01 6.33594354E-02 + 8.85090289E-01 2.63307370E-01 7.36716127E-01 6.35068773E-02 + 8.86123067E-01 2.63730277E-01 7.45189644E-01 6.36562974E-02 + 8.87155844E-01 2.64154578E-01 7.53775450E-01 6.38077257E-02 + 8.88188622E-01 2.64580285E-01 7.62475447E-01 6.39611928E-02 + 8.89221399E-01 2.65007412E-01 7.71291577E-01 6.41167298E-02 + 8.90254177E-01 2.65435971E-01 7.80225823E-01 6.42743683E-02 + 8.91286954E-01 2.65865975E-01 7.89280212E-01 6.44341407E-02 + 8.92319732E-01 2.66297436E-01 7.98456814E-01 6.45960797E-02 + 8.93352509E-01 2.66730369E-01 8.07757746E-01 6.47602188E-02 + 8.94385286E-01 2.67164787E-01 8.17185169E-01 6.49265921E-02 + 8.95418064E-01 2.67600701E-01 8.26741293E-01 6.50952343E-02 + 8.96450841E-01 2.68038126E-01 8.36428376E-01 6.52661808E-02 + 8.97483619E-01 2.68477075E-01 8.46248726E-01 6.54394676E-02 + 8.98516396E-01 2.68917561E-01 8.56204704E-01 6.56151314E-02 + 8.99549174E-01 2.69359598E-01 8.66298721E-01 6.57932097E-02 + 9.00581951E-01 2.69803200E-01 8.76533245E-01 6.59737405E-02 + 9.01614729E-01 2.70248378E-01 8.86910798E-01 6.61567628E-02 + 9.02647506E-01 2.70695149E-01 8.97433958E-01 6.63423161E-02 + 9.03680284E-01 2.71143524E-01 9.08105364E-01 6.65304408E-02 + 9.04713061E-01 2.71593518E-01 9.18927713E-01 6.67211780E-02 + 9.05745839E-01 2.72045144E-01 9.29903765E-01 6.69145697E-02 + 9.06778616E-01 2.72498417E-01 9.41036343E-01 6.71106585E-02 + 9.07811394E-01 2.72953350E-01 9.52328336E-01 6.73094882E-02 + 9.08844171E-01 2.73409958E-01 9.63782697E-01 6.75111031E-02 + 9.09876949E-01 2.73868253E-01 9.75402452E-01 6.77155486E-02 + 9.10909726E-01 2.74328250E-01 9.87190694E-01 6.79228708E-02 + 9.11942503E-01 2.74789964E-01 9.99150590E-01 6.81331170E-02 + 9.12975281E-01 2.75253408E-01 1.01128538E+00 6.83463351E-02 + 9.14008058E-01 2.75718596E-01 1.02359839E+00 6.85625741E-02 + 9.15040836E-01 2.76185543E-01 1.03609301E+00 6.87818842E-02 + 9.16073613E-01 2.76654263E-01 1.04877272E+00 6.90043162E-02 + 9.17106391E-01 2.77124770E-01 1.06164107E+00 6.92299223E-02 + 9.18139168E-01 2.77597078E-01 1.07470173E+00 6.94587555E-02 + 9.19171946E-01 2.78071203E-01 1.08795842E+00 6.96908700E-02 + 9.20204723E-01 2.78547157E-01 1.10141496E+00 6.99263210E-02 + 9.21237501E-01 2.79024955E-01 1.11507529E+00 7.01651651E-02 + 9.22270278E-01 2.79504613E-01 1.12894340E+00 7.04074598E-02 + 9.23303056E-01 2.79986143E-01 1.14302342E+00 7.06532638E-02 + 9.24335833E-01 2.80469562E-01 1.15731955E+00 7.09026371E-02 + 9.25368611E-01 2.80954882E-01 1.17183612E+00 7.11556409E-02 + 9.26401388E-01 2.81442120E-01 1.18657756E+00 7.14123378E-02 + 9.27434165E-01 2.81931288E-01 1.20154839E+00 7.16727917E-02 + 9.28466943E-01 2.82422402E-01 1.21675327E+00 7.19370675E-02 + 9.29499720E-01 2.82915476E-01 1.23219696E+00 7.22052320E-02 + 9.30532498E-01 2.83410524E-01 1.24788436E+00 7.24773530E-02 + 9.31565275E-01 2.83907561E-01 1.26382048E+00 7.27534999E-02 + 9.32598053E-01 2.84406602E-01 1.28001044E+00 7.30337437E-02 + 9.33630830E-01 2.84907661E-01 1.29645954E+00 7.33181568E-02 + 9.34663608E-01 2.85410753E-01 1.31317316E+00 7.36068131E-02 + 9.35696385E-01 2.85915891E-01 1.33015686E+00 7.38997882E-02 + 9.36729163E-01 2.86423091E-01 1.34741634E+00 7.41971594E-02 + 9.37761940E-01 2.86932367E-01 1.36495741E+00 7.44990055E-02 + 9.38794718E-01 2.87443733E-01 1.38278609E+00 7.48054071E-02 + 9.39827495E-01 2.87957203E-01 1.40090851E+00 7.51164467E-02 + 9.40860273E-01 2.88472792E-01 1.41933098E+00 7.54322085E-02 + 9.41893050E-01 2.88990514E-01 1.43805999E+00 7.57527787E-02 + 9.42925827E-01 2.89510384E-01 1.45710219E+00 7.60782451E-02 + 9.43958605E-01 2.90032416E-01 1.47646440E+00 7.64086978E-02 + 9.44991382E-01 2.90556623E-01 1.49615363E+00 7.67442289E-02 + 9.46024160E-01 2.91083020E-01 1.51617709E+00 7.70849323E-02 + 9.47056937E-01 2.91611621E-01 1.53654217E+00 7.74309043E-02 + 9.48089715E-01 2.92142441E-01 1.55725648E+00 7.77822434E-02 + 9.49122492E-01 2.92675492E-01 1.57832780E+00 7.81390500E-02 + 9.50155270E-01 2.93210789E-01 1.59976417E+00 7.85014273E-02 + 9.51188047E-01 2.93748346E-01 1.62157382E+00 7.88694805E-02 + 9.52220825E-01 2.94288176E-01 1.64376523E+00 7.92433175E-02 + 9.53253602E-01 2.94830293E-01 1.66634710E+00 7.96230483E-02 + 9.54286380E-01 2.95374711E-01 1.68932837E+00 8.00087861E-02 + 9.55319157E-01 2.95921442E-01 1.71271825E+00 8.04006461E-02 + 9.56351935E-01 2.96470501E-01 1.73652620E+00 8.07987467E-02 + 9.57384712E-01 2.97021901E-01 1.76076194E+00 8.12032087E-02 + 9.58417489E-01 2.97575655E-01 1.78543548E+00 8.16141562E-02 + 9.59450267E-01 2.98131775E-01 1.81055712E+00 8.20317160E-02 + 9.60483044E-01 2.98690276E-01 1.83613743E+00 8.24560178E-02 + 9.61515822E-01 2.99251169E-01 1.86218731E+00 8.28871948E-02 + 9.62548599E-01 2.99814467E-01 1.88871798E+00 8.33253831E-02 + 9.63581377E-01 3.00380184E-01 1.91574096E+00 8.37707223E-02 + 9.64614154E-01 3.00948330E-01 1.94326813E+00 8.42233554E-02 + 9.65646932E-01 3.01518920E-01 1.97131172E+00 8.46834286E-02 + 9.66679709E-01 3.02091964E-01 1.99988431E+00 8.51510922E-02 + 9.67712487E-01 3.02667475E-01 2.02899886E+00 8.56264997E-02 + 9.68745264E-01 3.03245465E-01 2.05866872E+00 8.61098090E-02 + 9.69778042E-01 3.03825945E-01 2.08890763E+00 8.66011814E-02 + 9.70810819E-01 3.04408926E-01 2.11972976E+00 8.71007825E-02 + 9.71843597E-01 3.04994421E-01 2.15114970E+00 8.76087820E-02 + 9.72876374E-01 3.05582441E-01 2.18318249E+00 8.81253541E-02 + 9.73909151E-01 3.06172995E-01 2.21584361E+00 8.86506772E-02 + 9.74941929E-01 3.06766096E-01 2.24914905E+00 8.91849343E-02 + 9.75974706E-01 3.07361753E-01 2.28311527E+00 8.97283132E-02 + 9.77007484E-01 3.07959977E-01 2.31775925E+00 9.02810066E-02 + 9.78040261E-01 3.08560779E-01 2.35309849E+00 9.08432119E-02 + 9.79073039E-01 3.09164167E-01 2.38915105E+00 9.14151320E-02 + 9.80105816E-01 3.09770153E-01 2.42593557E+00 9.19969749E-02 + 9.81138594E-01 3.10378745E-01 2.46347126E+00 9.25889543E-02 + 9.82171371E-01 3.10989952E-01 2.50177794E+00 9.31912892E-02 + 9.83204149E-01 3.11603784E-01 2.54087609E+00 9.38042048E-02 + 9.84236926E-01 3.12220250E-01 2.58078683E+00 9.44279322E-02 + 9.85269704E-01 3.12839358E-01 2.62153197E+00 9.50627086E-02 + 9.86302481E-01 3.13461116E-01 2.66313403E+00 9.57087778E-02 + 9.87335259E-01 3.14085533E-01 2.70561625E+00 9.63663901E-02 + 9.88368036E-01 3.14712616E-01 2.74900266E+00 9.70358026E-02 + 9.89400813E-01 3.15342373E-01 2.79331808E+00 9.77172796E-02 + 9.90433591E-01 3.15974811E-01 2.83858814E+00 9.84110927E-02 + 9.91466368E-01 3.16609937E-01 2.88483933E+00 9.91175208E-02 + 9.92499146E-01 3.17247757E-01 2.93209904E+00 9.98368509E-02 + 9.93531923E-01 3.17888279E-01 2.98039557E+00 1.00569378E-01 + 9.94564701E-01 3.18531507E-01 3.02975821E+00 1.01315405E-01 + 9.95597478E-01 3.19177449E-01 3.08021721E+00 1.02075244E-01 + 9.96630256E-01 3.19826109E-01 3.13180390E+00 1.02849216E-01 + 9.97663033E-01 3.20477492E-01 3.18455065E+00 1.03637650E-01 + 9.98695811E-01 3.21131604E-01 3.23849099E+00 1.04440886E-01 + 9.99728588E-01 3.21788449E-01 3.29365959E+00 1.05259274E-01 + 1.00076137E+00 3.22448031E-01 3.35009238E+00 1.06093173E-01 + 1.00179414E+00 3.23110354E-01 3.40782650E+00 1.06942952E-01 + 1.00282692E+00 3.23775422E-01 3.46690047E+00 1.07808994E-01 + 1.00385970E+00 3.24443237E-01 3.52735414E+00 1.08691689E-01 + 1.00489248E+00 3.25113803E-01 3.58922882E+00 1.09591443E-01 + 1.00592525E+00 3.25787122E-01 3.65256729E+00 1.10508671E-01 + 1.00695803E+00 3.26463196E-01 3.71741390E+00 1.11443802E-01 + 1.00799081E+00 3.27142027E-01 3.78381463E+00 1.12397278E-01 + 1.00902359E+00 3.27823617E-01 3.85181713E+00 1.13369554E-01 + 1.01005636E+00 3.28507966E-01 3.92147083E+00 1.14361098E-01 + 1.01108914E+00 3.29195075E-01 3.99282700E+00 1.15372396E-01 + 1.01212192E+00 3.29884945E-01 4.06593880E+00 1.16403946E-01 + 1.01315470E+00 3.30577575E-01 4.14086144E+00 1.17456261E-01 + 1.01418747E+00 3.31272966E-01 4.21765219E+00 1.18529874E-01 + 1.01522025E+00 3.31971116E-01 4.29637052E+00 1.19625331E-01 + 1.01625303E+00 3.32672023E-01 4.37707817E+00 1.20743198E-01 + 1.01728581E+00 3.33375687E-01 4.45983928E+00 1.21884057E-01 + 1.01831858E+00 3.34082106E-01 4.54472047E+00 1.23048510E-01 + 1.01935136E+00 3.34791277E-01 4.63179097E+00 1.24237180E-01 + 1.02038414E+00 3.35503198E-01 4.72112274E+00 1.25450707E-01 + 1.02141691E+00 3.36217864E-01 4.81279059E+00 1.26689756E-01 + 1.02244969E+00 3.36935274E-01 4.90687229E+00 1.27955011E-01 + 1.02348247E+00 3.37655422E-01 5.00344877E+00 1.29247180E-01 + 1.02451525E+00 3.38378304E-01 5.10260419E+00 1.30566994E-01 + 1.02554802E+00 3.39103917E-01 5.20442617E+00 1.31915212E-01 + 1.02658080E+00 3.39832254E-01 5.30900588E+00 1.33292614E-01 + 1.02761358E+00 3.40563310E-01 5.41643826E+00 1.34700010E-01 + 1.02864636E+00 3.41297079E-01 5.52682221E+00 1.36138236E-01 + 1.02967913E+00 3.42033555E-01 5.64026072E+00 1.37608160E-01 + 1.03071191E+00 3.42772732E-01 5.75686114E+00 1.39110678E-01 + 1.03174469E+00 3.43514601E-01 5.87673535E+00 1.40646717E-01 + 1.03277747E+00 3.44259156E-01 6.00000000E+00 1.42217240E-01 diff --git a/sedovSolutionModLong.dat b/sedovSolutionModLong.dat new file mode 100644 index 0000000..51f8acd --- /dev/null +++ b/sedovSolutionModLong.dat @@ -0,0 +1,10017 @@ +# SEDOV SOLUTION ASSUMING E=1, rho_up=1, t=1 +# +# In general, you can define S = [rho_up / (E*t^2)]^(1/5), and scale +# the solution using r -> r/S, v -> v / (S*t), rho -> rho * rho_up, +# and P -> P * rho_up / (S*t)^2. +# +# Gamma = 1.40000000E+00 +# r_0 (shock location) = 1.03277747E+00 +# +# Number of sample points = 10000 +# COLUMNS: +# 1 = r +# 2 = v +# 3 = rho +# 4 = P +# +# SOLUTION WITH DENSITY FLOOR: + 1.03277747E-04 2.95079276E-05 1.000000000E-03 5.19751502E-02 + 2.06555493E-04 5.90158553E-05 1.000000000E-03 5.19751502E-02 + 3.09833240E-04 8.85237829E-05 1.000000000E-03 5.19751502E-02 + 4.13110987E-04 1.18031711E-04 1.000000000E-03 5.19751502E-02 + 5.16388734E-04 1.47539638E-04 1.000000000E-03 5.19751502E-02 + 6.19666480E-04 1.77047566E-04 1.000000000E-03 5.19751502E-02 + 7.22944227E-04 2.06555493E-04 1.000000000E-03 5.19751502E-02 + 8.26221974E-04 2.36063421E-04 1.000000000E-03 5.19751502E-02 + 9.29499720E-04 2.65571349E-04 1.000000000E-03 5.19751502E-02 + 1.03277747E-03 2.95079276E-04 1.000000000E-03 5.19751502E-02 + 1.13605521E-03 3.24587204E-04 1.000000000E-03 5.19751502E-02 + 1.23933296E-03 3.54095132E-04 1.000000000E-03 5.19751502E-02 + 1.34261071E-03 3.83603059E-04 1.000000000E-03 5.19751502E-02 + 1.44588845E-03 4.13110987E-04 1.000000000E-03 5.19751502E-02 + 1.54916620E-03 4.42618914E-04 1.000000000E-03 5.19751502E-02 + 1.65244395E-03 4.72126842E-04 1.000000000E-03 5.19751502E-02 + 1.75572169E-03 5.01634770E-04 1.000000000E-03 5.19751502E-02 + 1.85899944E-03 5.31142697E-04 1.000000000E-03 5.19751502E-02 + 1.96227719E-03 5.60650625E-04 1.000000000E-03 5.19751502E-02 + 2.06555493E-03 5.90158553E-04 1.000000000E-03 5.19751502E-02 + 2.16883268E-03 6.19666480E-04 1.000000000E-03 5.19751502E-02 + 2.27211043E-03 6.49174408E-04 1.000000000E-03 5.19751502E-02 + 2.37538817E-03 6.78682336E-04 1.000000000E-03 5.19751502E-02 + 2.47866592E-03 7.08190263E-04 1.000000000E-03 5.19751502E-02 + 2.58194367E-03 7.37698191E-04 1.000000000E-03 5.19751502E-02 + 2.68522141E-03 7.67206118E-04 1.000000000E-03 5.19751502E-02 + 2.78849916E-03 7.96714046E-04 1.000000000E-03 5.19751502E-02 + 2.89177691E-03 8.26221974E-04 1.000000000E-03 5.19751502E-02 + 2.99505465E-03 8.55729901E-04 1.000000000E-03 5.19751502E-02 + 3.09833240E-03 8.85237829E-04 1.000000000E-03 5.19751502E-02 + 3.20161015E-03 9.14745757E-04 1.000000000E-03 5.19751502E-02 + 3.30488789E-03 9.44253684E-04 1.000000000E-03 5.19751502E-02 + 3.40816564E-03 9.73761612E-04 1.000000000E-03 5.19751502E-02 + 3.51144339E-03 1.00326954E-03 1.000000000E-03 5.19751502E-02 + 3.61472113E-03 1.03277747E-03 1.000000000E-03 5.19751502E-02 + 3.71799888E-03 1.06228539E-03 1.000000000E-03 5.19751502E-02 + 3.82127663E-03 1.09179332E-03 1.000000000E-03 5.19751502E-02 + 3.92455437E-03 1.12130125E-03 1.000000000E-03 5.19751502E-02 + 4.02783212E-03 1.15080918E-03 1.000000000E-03 5.19751502E-02 + 4.13110987E-03 1.18031711E-03 1.000000000E-03 5.19751502E-02 + 4.23438762E-03 1.20982503E-03 1.000000000E-03 5.19751502E-02 + 4.33766536E-03 1.23933296E-03 1.000000000E-03 5.19751502E-02 + 4.44094311E-03 1.26884089E-03 1.000000000E-03 5.19751502E-02 + 4.54422086E-03 1.29834882E-03 1.000000000E-03 5.19751502E-02 + 4.64749860E-03 1.32785674E-03 1.000000000E-03 5.19751502E-02 + 4.75077635E-03 1.35736467E-03 1.000000000E-03 5.19751502E-02 + 4.85405410E-03 1.38687260E-03 1.000000000E-03 5.19751502E-02 + 4.95733184E-03 1.41638053E-03 1.000000000E-03 5.19751502E-02 + 5.06060959E-03 1.44588845E-03 1.000000000E-03 5.19751502E-02 + 5.16388734E-03 1.47539638E-03 1.000000000E-03 5.19751502E-02 + 5.26716508E-03 1.50490431E-03 1.000000000E-03 5.19751502E-02 + 5.37044283E-03 1.53441224E-03 1.000000000E-03 5.19751502E-02 + 5.47372058E-03 1.56392016E-03 1.000000000E-03 5.19751502E-02 + 5.57699832E-03 1.59342809E-03 1.000000000E-03 5.19751502E-02 + 5.68027607E-03 1.62293602E-03 1.000000000E-03 5.19751502E-02 + 5.78355382E-03 1.65244395E-03 1.000000000E-03 5.19751502E-02 + 5.88683156E-03 1.68195187E-03 1.000000000E-03 5.19751502E-02 + 5.99010931E-03 1.71145980E-03 1.000000000E-03 5.19751502E-02 + 6.09338706E-03 1.74096773E-03 1.000000000E-03 5.19751502E-02 + 6.19666480E-03 1.77047566E-03 1.000000000E-03 5.19751502E-02 + 6.29994255E-03 1.79998359E-03 1.000000000E-03 5.19751502E-02 + 6.40322030E-03 1.82949151E-03 1.000000000E-03 5.19751502E-02 + 6.50649804E-03 1.85899944E-03 1.000000000E-03 5.19751502E-02 + 6.60977579E-03 1.88850737E-03 1.000000000E-03 5.19751502E-02 + 6.71305354E-03 1.91801530E-03 1.000000000E-03 5.19751502E-02 + 6.81633128E-03 1.94752322E-03 1.000000000E-03 5.19751502E-02 + 6.91960903E-03 1.97703115E-03 1.000000000E-03 5.19751502E-02 + 7.02288678E-03 2.00653908E-03 1.000000000E-03 5.19751502E-02 + 7.12616452E-03 2.03604701E-03 1.000000000E-03 5.19751502E-02 + 7.22944227E-03 2.06555493E-03 1.000000000E-03 5.19751502E-02 + 7.33272002E-03 2.09506286E-03 1.000000000E-03 5.19751502E-02 + 7.43599776E-03 2.12457079E-03 1.000000000E-03 5.19751502E-02 + 7.53927551E-03 2.15407872E-03 1.000000000E-03 5.19751502E-02 + 7.64255326E-03 2.18358664E-03 1.000000000E-03 5.19751502E-02 + 7.74583100E-03 2.21309457E-03 1.000000000E-03 5.19751502E-02 + 7.84910875E-03 2.24260250E-03 1.000000000E-03 5.19751502E-02 + 7.95238650E-03 2.27211043E-03 1.000000000E-03 5.19751502E-02 + 8.05566424E-03 2.30161836E-03 1.000000000E-03 5.19751502E-02 + 8.15894199E-03 2.33112628E-03 1.000000000E-03 5.19751502E-02 + 8.26221974E-03 2.36063421E-03 1.000000000E-03 5.19751502E-02 + 8.36549748E-03 2.39014214E-03 1.000000000E-03 5.19751502E-02 + 8.46877523E-03 2.41965007E-03 1.000000000E-03 5.19751502E-02 + 8.57205298E-03 2.44915799E-03 1.000000000E-03 5.19751502E-02 + 8.67533072E-03 2.47866592E-03 1.000000000E-03 5.19751502E-02 + 8.77860847E-03 2.50817385E-03 1.000000000E-03 5.19751502E-02 + 8.88188622E-03 2.53768178E-03 1.000000000E-03 5.19751502E-02 + 8.98516396E-03 2.56718970E-03 1.000000000E-03 5.19751502E-02 + 9.08844171E-03 2.59669763E-03 1.000000000E-03 5.19751502E-02 + 9.19171946E-03 2.62620556E-03 1.000000000E-03 5.19751502E-02 + 9.29499720E-03 2.65571349E-03 1.000000000E-03 5.19751502E-02 + 9.39827495E-03 2.68522141E-03 1.000000000E-03 5.19751502E-02 + 9.50155270E-03 2.71472934E-03 1.000000000E-03 5.19751502E-02 + 9.60483044E-03 2.74423727E-03 1.000000000E-03 5.19751502E-02 + 9.70810819E-03 2.77374520E-03 1.000000000E-03 5.19751502E-02 + 9.81138594E-03 2.80325312E-03 1.000000000E-03 5.19751502E-02 + 9.91466368E-03 2.83276105E-03 1.000000000E-03 5.19751502E-02 + 1.00179414E-02 2.86226898E-03 1.000000000E-03 5.19751502E-02 + 1.01212192E-02 2.89177691E-03 1.000000000E-03 5.19751502E-02 + 1.02244969E-02 2.92128484E-03 1.000000000E-03 5.19751502E-02 + 1.03277747E-02 2.95079276E-03 1.000000000E-03 5.19751502E-02 + 1.04310524E-02 2.98030069E-03 1.000000000E-03 5.19751502E-02 + 1.05343302E-02 3.00980862E-03 1.000000000E-03 5.19751502E-02 + 1.06376079E-02 3.03931655E-03 1.000000000E-03 5.19751502E-02 + 1.07408857E-02 3.06882447E-03 1.000000000E-03 5.19751502E-02 + 1.08441634E-02 3.09833240E-03 1.000000000E-03 5.19751502E-02 + 1.09474412E-02 3.12784033E-03 1.000000000E-03 5.19751502E-02 + 1.10507189E-02 3.15734826E-03 1.000000000E-03 5.19751502E-02 + 1.11539966E-02 3.18685618E-03 1.000000000E-03 5.19751502E-02 + 1.12572744E-02 3.21636411E-03 1.000000000E-03 5.19751502E-02 + 1.13605521E-02 3.24587204E-03 1.000000000E-03 5.19751502E-02 + 1.14638299E-02 3.27537997E-03 1.000000000E-03 5.19751502E-02 + 1.15671076E-02 3.30488789E-03 1.000000000E-03 5.19751502E-02 + 1.16703854E-02 3.33439582E-03 1.000000000E-03 5.19751502E-02 + 1.17736631E-02 3.36390375E-03 1.000000000E-03 5.19751502E-02 + 1.18769409E-02 3.39341168E-03 1.000000000E-03 5.19751502E-02 + 1.19802186E-02 3.42291961E-03 1.000000000E-03 5.19751502E-02 + 1.20834964E-02 3.45242753E-03 1.000000000E-03 5.19751502E-02 + 1.21867741E-02 3.48193546E-03 1.000000000E-03 5.19751502E-02 + 1.22900519E-02 3.51144339E-03 1.000000000E-03 5.19751502E-02 + 1.23933296E-02 3.54095132E-03 1.000000000E-03 5.19751502E-02 + 1.24966074E-02 3.57045924E-03 1.000000000E-03 5.19751502E-02 + 1.25998851E-02 3.59996717E-03 1.000000000E-03 5.19751502E-02 + 1.27031628E-02 3.62947510E-03 1.000000000E-03 5.19751502E-02 + 1.28064406E-02 3.65898303E-03 1.000000000E-03 5.19751502E-02 + 1.29097183E-02 3.68849095E-03 1.000000000E-03 5.19751502E-02 + 1.30129961E-02 3.71799888E-03 1.000000000E-03 5.19751502E-02 + 1.31162738E-02 3.74750681E-03 1.000000000E-03 5.19751502E-02 + 1.32195516E-02 3.77701474E-03 1.000000000E-03 5.19751502E-02 + 1.33228293E-02 3.80652266E-03 1.000000000E-03 5.19751502E-02 + 1.34261071E-02 3.83603059E-03 1.000000000E-03 5.19751502E-02 + 1.35293848E-02 3.86553852E-03 1.000000000E-03 5.19751502E-02 + 1.36326626E-02 3.89504645E-03 1.000000000E-03 5.19751502E-02 + 1.37359403E-02 3.92455437E-03 1.000000000E-03 5.19751502E-02 + 1.38392181E-02 3.95406230E-03 1.000000000E-03 5.19751502E-02 + 1.39424958E-02 3.98357023E-03 1.000000000E-03 5.19751502E-02 + 1.40457736E-02 4.01307816E-03 1.000000000E-03 5.19751502E-02 + 1.41490513E-02 4.04258609E-03 1.000000000E-03 5.19751502E-02 + 1.42523290E-02 4.07209401E-03 1.000000000E-03 5.19751502E-02 + 1.43556068E-02 4.10160194E-03 1.000000000E-03 5.19751502E-02 + 1.44588845E-02 4.13110987E-03 1.000000000E-03 5.19751502E-02 + 1.45621623E-02 4.16061780E-03 1.000000000E-03 5.19751502E-02 + 1.46654400E-02 4.19012572E-03 1.000000000E-03 5.19751502E-02 + 1.47687178E-02 4.21963365E-03 1.000000000E-03 5.19751502E-02 + 1.48719955E-02 4.24914158E-03 1.000000000E-03 5.19751502E-02 + 1.49752733E-02 4.27864951E-03 1.000000000E-03 5.19751502E-02 + 1.50785510E-02 4.30815743E-03 1.000000000E-03 5.19751502E-02 + 1.51818288E-02 4.33766536E-03 1.000000000E-03 5.19751502E-02 + 1.52851065E-02 4.36717329E-03 1.000000000E-03 5.19751502E-02 + 1.53883843E-02 4.39668122E-03 1.000000000E-03 5.19751502E-02 + 1.54916620E-02 4.42618914E-03 1.000000000E-03 5.19751502E-02 + 1.55949398E-02 4.45569707E-03 1.000000000E-03 5.19751502E-02 + 1.56982175E-02 4.48520500E-03 1.000000000E-03 5.19751502E-02 + 1.58014952E-02 4.51471293E-03 1.000000000E-03 5.19751502E-02 + 1.59047730E-02 4.54422086E-03 1.000000000E-03 5.19751502E-02 + 1.60080507E-02 4.57372878E-03 1.000000000E-03 5.19751502E-02 + 1.61113285E-02 4.60323671E-03 1.000000000E-03 5.19751502E-02 + 1.62146062E-02 4.63274464E-03 1.000000000E-03 5.19751502E-02 + 1.63178840E-02 4.66225257E-03 1.000000000E-03 5.19751502E-02 + 1.64211617E-02 4.69176049E-03 1.000000000E-03 5.19751502E-02 + 1.65244395E-02 4.72126842E-03 1.000000000E-03 5.19751502E-02 + 1.66277172E-02 4.75077635E-03 1.000000000E-03 5.19751502E-02 + 1.67309950E-02 4.78028428E-03 1.000000000E-03 5.19751502E-02 + 1.68342727E-02 4.80979220E-03 1.000000000E-03 5.19751502E-02 + 1.69375505E-02 4.83930013E-03 1.000000000E-03 5.19751502E-02 + 1.70408282E-02 4.86880806E-03 1.000000000E-03 5.19751502E-02 + 1.71441060E-02 4.89831599E-03 1.000000000E-03 5.19751502E-02 + 1.72473837E-02 4.92782391E-03 1.000000000E-03 5.19751502E-02 + 1.73506614E-02 4.95733184E-03 1.000000000E-03 5.19751502E-02 + 1.74539392E-02 4.98683977E-03 1.000000000E-03 5.19751502E-02 + 1.75572169E-02 5.01634770E-03 1.000000000E-03 5.19751502E-02 + 1.76604947E-02 5.04585562E-03 1.000000000E-03 5.19751502E-02 + 1.77637724E-02 5.07536355E-03 1.000000000E-03 5.19751502E-02 + 1.78670502E-02 5.10487148E-03 1.000000000E-03 5.19751502E-02 + 1.79703279E-02 5.13437941E-03 1.000000000E-03 5.19751502E-02 + 1.80736057E-02 5.16388734E-03 1.000000000E-03 5.19751502E-02 + 1.81768834E-02 5.19339526E-03 1.000000000E-03 5.19751502E-02 + 1.82801612E-02 5.22290319E-03 1.000000000E-03 5.19751502E-02 + 1.83834389E-02 5.25241112E-03 1.000000000E-03 5.19751502E-02 + 1.84867167E-02 5.28191905E-03 1.000000000E-03 5.19751502E-02 + 1.85899944E-02 5.31142697E-03 1.000000000E-03 5.19751502E-02 + 1.86932722E-02 5.34093490E-03 1.000000000E-03 5.19751502E-02 + 1.87965499E-02 5.37044283E-03 1.000000000E-03 5.19751502E-02 + 1.88998276E-02 5.39995076E-03 1.000000000E-03 5.19751502E-02 + 1.90031054E-02 5.42945868E-03 1.000000000E-03 5.19751502E-02 + 1.91063831E-02 5.45896661E-03 1.000000000E-03 5.19751502E-02 + 1.92096609E-02 5.48847454E-03 1.000000000E-03 5.19751502E-02 + 1.93129386E-02 5.51798247E-03 1.000000000E-03 5.19751502E-02 + 1.94162164E-02 5.54749039E-03 1.000000000E-03 5.19751502E-02 + 1.95194941E-02 5.57699832E-03 1.000000000E-03 5.19751502E-02 + 1.96227719E-02 5.60650625E-03 1.000000000E-03 5.19751502E-02 + 1.97260496E-02 5.63601418E-03 1.000000000E-03 5.19751502E-02 + 1.98293274E-02 5.66552211E-03 1.000000000E-03 5.19751502E-02 + 1.99326051E-02 5.69503003E-03 1.000000000E-03 5.19751502E-02 + 2.00358829E-02 5.72453796E-03 1.000000000E-03 5.19751502E-02 + 2.01391606E-02 5.75404589E-03 1.000000000E-03 5.19751502E-02 + 2.02424384E-02 5.78355382E-03 1.000000000E-03 5.19751502E-02 + 2.03457161E-02 5.81306174E-03 1.000000000E-03 5.19751502E-02 + 2.04489938E-02 5.84256967E-03 1.000000000E-03 5.19751502E-02 + 2.05522716E-02 5.87207760E-03 1.000000000E-03 5.19751502E-02 + 2.06555493E-02 5.90158553E-03 1.000000000E-03 5.19751502E-02 + 2.07588271E-02 5.93109345E-03 1.000000000E-03 5.19751502E-02 + 2.08621048E-02 5.96060138E-03 1.000000000E-03 5.19751502E-02 + 2.09653826E-02 5.99010931E-03 1.000000000E-03 5.19751502E-02 + 2.10686603E-02 6.01961724E-03 1.000000000E-03 5.19751502E-02 + 2.11719381E-02 6.04912516E-03 1.000000000E-03 5.19751502E-02 + 2.12752158E-02 6.07863309E-03 1.000000000E-03 5.19751502E-02 + 2.13784936E-02 6.10814102E-03 1.000000000E-03 5.19751502E-02 + 2.14817713E-02 6.13764895E-03 1.000000000E-03 5.19751502E-02 + 2.15850491E-02 6.16715687E-03 1.000000000E-03 5.19751502E-02 + 2.16883268E-02 6.19666480E-03 1.000000000E-03 5.19751502E-02 + 2.17916046E-02 6.22617273E-03 1.000000000E-03 5.19751502E-02 + 2.18948823E-02 6.25568066E-03 1.000000000E-03 5.19751502E-02 + 2.19981600E-02 6.28518859E-03 1.000000000E-03 5.19751502E-02 + 2.21014378E-02 6.31469651E-03 1.000000000E-03 5.19751502E-02 + 2.22047155E-02 6.34420444E-03 1.000000000E-03 5.19751502E-02 + 2.23079933E-02 6.37371237E-03 1.000000000E-03 5.19751502E-02 + 2.24112710E-02 6.40322030E-03 1.000000000E-03 5.19751502E-02 + 2.25145488E-02 6.43272822E-03 1.000000000E-03 5.19751502E-02 + 2.26178265E-02 6.46223615E-03 1.000000000E-03 5.19751502E-02 + 2.27211043E-02 6.49174408E-03 1.000000000E-03 5.19751502E-02 + 2.28243820E-02 6.52125201E-03 1.000000000E-03 5.19751502E-02 + 2.29276598E-02 6.55075993E-03 1.000000000E-03 5.19751502E-02 + 2.30309375E-02 6.58026786E-03 1.000000000E-03 5.19751502E-02 + 2.31342153E-02 6.60977579E-03 1.000000000E-03 5.19751502E-02 + 2.32374930E-02 6.63928372E-03 1.000000000E-03 5.19751502E-02 + 2.33407708E-02 6.66879164E-03 1.000000000E-03 5.19751502E-02 + 2.34440485E-02 6.69829957E-03 1.000000000E-03 5.19751502E-02 + 2.35473262E-02 6.72780750E-03 1.000000000E-03 5.19751502E-02 + 2.36506040E-02 6.75731543E-03 1.000000000E-03 5.19751502E-02 + 2.37538817E-02 6.78682336E-03 1.000000000E-03 5.19751502E-02 + 2.38571595E-02 6.81633128E-03 1.000000000E-03 5.19751502E-02 + 2.39604372E-02 6.84583921E-03 1.000000000E-03 5.19751502E-02 + 2.40637150E-02 6.87534714E-03 1.000000000E-03 5.19751502E-02 + 2.41669927E-02 6.90485507E-03 1.000000000E-03 5.19751502E-02 + 2.42702705E-02 6.93436299E-03 1.000000000E-03 5.19751502E-02 + 2.43735482E-02 6.96387092E-03 1.000000000E-03 5.19751502E-02 + 2.44768260E-02 6.99337885E-03 1.000000000E-03 5.19751502E-02 + 2.45801037E-02 7.02288678E-03 1.000000000E-03 5.19751502E-02 + 2.46833815E-02 7.05239470E-03 1.000000000E-03 5.19751502E-02 + 2.47866592E-02 7.08190263E-03 1.000000000E-03 5.19751502E-02 + 2.48899370E-02 7.11141056E-03 1.000000000E-03 5.19751502E-02 + 2.49932147E-02 7.14091849E-03 1.000000000E-03 5.19751502E-02 + 2.50964925E-02 7.17042641E-03 1.000000000E-03 5.19751502E-02 + 2.51997702E-02 7.19993434E-03 1.000000000E-03 5.19751502E-02 + 2.53030479E-02 7.22944227E-03 1.000000000E-03 5.19751502E-02 + 2.54063257E-02 7.25895020E-03 1.000000000E-03 5.19751502E-02 + 2.55096034E-02 7.28845812E-03 1.000000000E-03 5.19751502E-02 + 2.56128812E-02 7.31796605E-03 1.000000000E-03 5.19751502E-02 + 2.57161589E-02 7.34747398E-03 1.000000000E-03 5.19751502E-02 + 2.58194367E-02 7.37698191E-03 1.000000000E-03 5.19751502E-02 + 2.59227144E-02 7.40648984E-03 1.000000000E-03 5.19751502E-02 + 2.60259922E-02 7.43599776E-03 1.000000000E-03 5.19751502E-02 + 2.61292699E-02 7.46550569E-03 1.000000000E-03 5.19751502E-02 + 2.62325477E-02 7.49501362E-03 1.000000000E-03 5.19751502E-02 + 2.63358254E-02 7.52452155E-03 1.000000000E-03 5.19751502E-02 + 2.64391032E-02 7.55402947E-03 1.000000000E-03 5.19751502E-02 + 2.65423809E-02 7.58353740E-03 1.000000000E-03 5.19751502E-02 + 2.66456587E-02 7.61304533E-03 1.000000000E-03 5.19751502E-02 + 2.67489364E-02 7.64255326E-03 1.000000000E-03 5.19751502E-02 + 2.68522141E-02 7.67206118E-03 1.000000000E-03 5.19751502E-02 + 2.69554919E-02 7.70156911E-03 1.000000000E-03 5.19751502E-02 + 2.70587696E-02 7.73107704E-03 1.000000000E-03 5.19751502E-02 + 2.71620474E-02 7.76058497E-03 1.000000000E-03 5.19751502E-02 + 2.72653251E-02 7.79009289E-03 1.000000000E-03 5.19751502E-02 + 2.73686029E-02 7.81960082E-03 1.000000000E-03 5.19751502E-02 + 2.74718806E-02 7.84910875E-03 1.000000000E-03 5.19751502E-02 + 2.75751584E-02 7.87861668E-03 1.000000000E-03 5.19751502E-02 + 2.76784361E-02 7.90812461E-03 1.000000000E-03 5.19751502E-02 + 2.77817139E-02 7.93763253E-03 1.000000000E-03 5.19751502E-02 + 2.78849916E-02 7.96714046E-03 1.000000000E-03 5.19751502E-02 + 2.79882694E-02 7.99664839E-03 1.000000000E-03 5.19751502E-02 + 2.80915471E-02 8.02615632E-03 1.000000000E-03 5.19751502E-02 + 2.81948249E-02 8.05566424E-03 1.000000000E-03 5.19751502E-02 + 2.82981026E-02 8.08517217E-03 1.000000000E-03 5.19751502E-02 + 2.84013803E-02 8.11468010E-03 1.000000000E-03 5.19751502E-02 + 2.85046581E-02 8.14418803E-03 1.000000000E-03 5.19751502E-02 + 2.86079358E-02 8.17369595E-03 1.000000000E-03 5.19751502E-02 + 2.87112136E-02 8.20320388E-03 1.000000000E-03 5.19751502E-02 + 2.88144913E-02 8.23271181E-03 1.000000000E-03 5.19751502E-02 + 2.89177691E-02 8.26221974E-03 1.000000000E-03 5.19751502E-02 + 2.90210468E-02 8.29172766E-03 1.000000000E-03 5.19751502E-02 + 2.91243246E-02 8.32123559E-03 1.000000000E-03 5.19751502E-02 + 2.92276023E-02 8.35074352E-03 1.000000000E-03 5.19751502E-02 + 2.93308801E-02 8.38025145E-03 1.000000000E-03 5.19751502E-02 + 2.94341578E-02 8.40975937E-03 1.000000000E-03 5.19751502E-02 + 2.95374356E-02 8.43926730E-03 1.000000000E-03 5.19751502E-02 + 2.96407133E-02 8.46877523E-03 1.000000000E-03 5.19751502E-02 + 2.97439911E-02 8.49828316E-03 1.000000000E-03 5.19751502E-02 + 2.98472688E-02 8.52779109E-03 1.000000000E-03 5.19751502E-02 + 2.99505465E-02 8.55729901E-03 1.000000000E-03 5.19751502E-02 + 3.00538243E-02 8.58680694E-03 1.000000000E-03 5.19751502E-02 + 3.01571020E-02 8.61631487E-03 1.000000000E-03 5.19751502E-02 + 3.02603798E-02 8.64582280E-03 1.000000000E-03 5.19751502E-02 + 3.03636575E-02 8.67533072E-03 1.000000000E-03 5.19751502E-02 + 3.04669353E-02 8.70483865E-03 1.000000000E-03 5.19751502E-02 + 3.05702130E-02 8.73434658E-03 1.000000000E-03 5.19751502E-02 + 3.06734908E-02 8.76385451E-03 1.000000000E-03 5.19751502E-02 + 3.07767685E-02 8.79336243E-03 1.000000000E-03 5.19751502E-02 + 3.08800463E-02 8.82287036E-03 1.000000000E-03 5.19751502E-02 + 3.09833240E-02 8.85237829E-03 1.000000000E-03 5.19751502E-02 + 3.10866018E-02 8.88188622E-03 1.000000000E-03 5.19751502E-02 + 3.11898795E-02 8.91139414E-03 1.000000000E-03 5.19751502E-02 + 3.12931573E-02 8.94090207E-03 1.000000000E-03 5.19751502E-02 + 3.13964350E-02 8.97041000E-03 1.000000000E-03 5.19751502E-02 + 3.14997127E-02 8.99991793E-03 1.000000000E-03 5.19751502E-02 + 3.16029905E-02 9.02942586E-03 1.000000000E-03 5.19751502E-02 + 3.17062682E-02 9.05893378E-03 1.000000000E-03 5.19751502E-02 + 3.18095460E-02 9.08844171E-03 1.000000000E-03 5.19751502E-02 + 3.19128237E-02 9.11794964E-03 1.000000000E-03 5.19751502E-02 + 3.20161015E-02 9.14745757E-03 1.000000000E-03 5.19751502E-02 + 3.21193792E-02 9.17696549E-03 1.000000000E-03 5.19751502E-02 + 3.22226570E-02 9.20647342E-03 1.000000000E-03 5.19751502E-02 + 3.23259347E-02 9.23598135E-03 1.000000000E-03 5.19751502E-02 + 3.24292125E-02 9.26548928E-03 1.000000000E-03 5.19751502E-02 + 3.25324902E-02 9.29499720E-03 1.000000000E-03 5.19751502E-02 + 3.26357680E-02 9.32450513E-03 1.000000000E-03 5.19751502E-02 + 3.27390457E-02 9.35401306E-03 1.000000000E-03 5.19751502E-02 + 3.28423235E-02 9.38352099E-03 1.000000000E-03 5.19751502E-02 + 3.29456012E-02 9.41302891E-03 1.000000000E-03 5.19751502E-02 + 3.30488789E-02 9.44253684E-03 1.000000000E-03 5.19751502E-02 + 3.31521567E-02 9.47204477E-03 1.000000000E-03 5.19751502E-02 + 3.32554344E-02 9.50155270E-03 1.000000000E-03 5.19751502E-02 + 3.33587122E-02 9.53106062E-03 1.000000000E-03 5.19751502E-02 + 3.34619899E-02 9.56056855E-03 1.000000000E-03 5.19751502E-02 + 3.35652677E-02 9.59007648E-03 1.000000000E-03 5.19751502E-02 + 3.36685454E-02 9.61958441E-03 1.000000000E-03 5.19751502E-02 + 3.37718232E-02 9.64909234E-03 1.000000000E-03 5.19751502E-02 + 3.38751009E-02 9.67860026E-03 1.000000000E-03 5.19751502E-02 + 3.39783787E-02 9.70810819E-03 1.000000000E-03 5.19751502E-02 + 3.40816564E-02 9.73761612E-03 1.000000000E-03 5.19751502E-02 + 3.41849342E-02 9.76712405E-03 1.000000000E-03 5.19751502E-02 + 3.42882119E-02 9.79663197E-03 1.000000000E-03 5.19751502E-02 + 3.43914897E-02 9.82613990E-03 1.000000000E-03 5.19751502E-02 + 3.44947674E-02 9.85564783E-03 1.000000000E-03 5.19751502E-02 + 3.45980451E-02 9.88515576E-03 1.000000000E-03 5.19751502E-02 + 3.47013229E-02 9.91466368E-03 1.000000000E-03 5.19751502E-02 + 3.48046006E-02 9.94417161E-03 1.000000000E-03 5.19751502E-02 + 3.49078784E-02 9.97367954E-03 1.000000000E-03 5.19751502E-02 + 3.50111561E-02 1.00031875E-02 1.000000000E-03 5.19751502E-02 + 3.51144339E-02 1.00326954E-02 1.000000000E-03 5.19751502E-02 + 3.52177116E-02 1.00622033E-02 1.000000000E-03 5.19751502E-02 + 3.53209894E-02 1.00917112E-02 1.000000000E-03 5.19751502E-02 + 3.54242671E-02 1.01212192E-02 1.000000000E-03 5.19751502E-02 + 3.55275449E-02 1.01507271E-02 1.000000000E-03 5.19751502E-02 + 3.56308226E-02 1.01802350E-02 1.000000000E-03 5.19751502E-02 + 3.57341004E-02 1.02097430E-02 1.000000000E-03 5.19751502E-02 + 3.58373781E-02 1.02392509E-02 1.000000000E-03 5.19751502E-02 + 3.59406559E-02 1.02687588E-02 1.000000000E-03 5.19751502E-02 + 3.60439336E-02 1.02982667E-02 1.000000000E-03 5.19751502E-02 + 3.61472113E-02 1.03277747E-02 1.000000000E-03 5.19751502E-02 + 3.62504891E-02 1.03572826E-02 1.000000000E-03 5.19751502E-02 + 3.63537668E-02 1.03867905E-02 1.000000000E-03 5.19751502E-02 + 3.64570446E-02 1.04162985E-02 1.000000000E-03 5.19751502E-02 + 3.65603223E-02 1.04458064E-02 1.000000000E-03 5.19751502E-02 + 3.66636001E-02 1.04753143E-02 1.000000000E-03 5.19751502E-02 + 3.67668778E-02 1.05048222E-02 1.000000000E-03 5.19751502E-02 + 3.68701556E-02 1.05343302E-02 1.000000000E-03 5.19751502E-02 + 3.69734333E-02 1.05638381E-02 1.000000000E-03 5.19751502E-02 + 3.70767111E-02 1.05933460E-02 1.000000000E-03 5.19751502E-02 + 3.71799888E-02 1.06228539E-02 1.000000000E-03 5.19751502E-02 + 3.72832666E-02 1.06523619E-02 1.000000000E-03 5.19751502E-02 + 3.73865443E-02 1.06818698E-02 1.000000000E-03 5.19751502E-02 + 3.74898221E-02 1.07113777E-02 1.000000000E-03 5.19751502E-02 + 3.75930998E-02 1.07408857E-02 1.000000000E-03 5.19751502E-02 + 3.76963775E-02 1.07703936E-02 1.000000000E-03 5.19751502E-02 + 3.77996553E-02 1.07999015E-02 1.000000000E-03 5.19751502E-02 + 3.79029330E-02 1.08294094E-02 1.000000000E-03 5.19751502E-02 + 3.80062108E-02 1.08589174E-02 1.000000000E-03 5.19751502E-02 + 3.81094885E-02 1.08884253E-02 1.000000000E-03 5.19751502E-02 + 3.82127663E-02 1.09179332E-02 1.000000000E-03 5.19751502E-02 + 3.83160440E-02 1.09474412E-02 1.000000000E-03 5.19751502E-02 + 3.84193218E-02 1.09769491E-02 1.000000000E-03 5.19751502E-02 + 3.85225995E-02 1.10064570E-02 1.000000000E-03 5.19751502E-02 + 3.86258773E-02 1.10359649E-02 1.000000000E-03 5.19751502E-02 + 3.87291550E-02 1.10654729E-02 1.000000000E-03 5.19751502E-02 + 3.88324328E-02 1.10949808E-02 1.000000000E-03 5.19751502E-02 + 3.89357105E-02 1.11244887E-02 1.000000000E-03 5.19751502E-02 + 3.90389883E-02 1.11539966E-02 1.000000000E-03 5.19751502E-02 + 3.91422660E-02 1.11835046E-02 1.000000000E-03 5.19751502E-02 + 3.92455437E-02 1.12130125E-02 1.000000000E-03 5.19751502E-02 + 3.93488215E-02 1.12425204E-02 1.000000000E-03 5.19751502E-02 + 3.94520992E-02 1.12720284E-02 1.000000000E-03 5.19751502E-02 + 3.95553770E-02 1.13015363E-02 1.000000000E-03 5.19751502E-02 + 3.96586547E-02 1.13310442E-02 1.000000000E-03 5.19751502E-02 + 3.97619325E-02 1.13605521E-02 1.000000000E-03 5.19751502E-02 + 3.98652102E-02 1.13900601E-02 1.000000000E-03 5.19751502E-02 + 3.99684880E-02 1.14195680E-02 1.000000000E-03 5.19751502E-02 + 4.00717657E-02 1.14490759E-02 1.000000000E-03 5.19751502E-02 + 4.01750435E-02 1.14785838E-02 1.000000000E-03 5.19751502E-02 + 4.02783212E-02 1.15080918E-02 1.000000000E-03 5.19751502E-02 + 4.03815990E-02 1.15375997E-02 1.000000000E-03 5.19751502E-02 + 4.04848767E-02 1.15671076E-02 1.000000000E-03 5.19751502E-02 + 4.05881545E-02 1.15966156E-02 1.000000000E-03 5.19751502E-02 + 4.06914322E-02 1.16261235E-02 1.000000000E-03 5.19751502E-02 + 4.07947099E-02 1.16556314E-02 1.000000000E-03 5.19751502E-02 + 4.08979877E-02 1.16851393E-02 1.000000000E-03 5.19751502E-02 + 4.10012654E-02 1.17146473E-02 1.000000000E-03 5.19751502E-02 + 4.11045432E-02 1.17441552E-02 1.000000000E-03 5.19751502E-02 + 4.12078209E-02 1.17736631E-02 1.000000000E-03 5.19751502E-02 + 4.13110987E-02 1.18031711E-02 1.000000000E-03 5.19751502E-02 + 4.14143764E-02 1.18326790E-02 1.000000000E-03 5.19751502E-02 + 4.15176542E-02 1.18621869E-02 1.000000000E-03 5.19751502E-02 + 4.16209319E-02 1.18916948E-02 1.000000000E-03 5.19751502E-02 + 4.17242097E-02 1.19212028E-02 1.000000000E-03 5.19751502E-02 + 4.18274874E-02 1.19507107E-02 1.000000000E-03 5.19751502E-02 + 4.19307652E-02 1.19802186E-02 1.000000000E-03 5.19751502E-02 + 4.20340429E-02 1.20097265E-02 1.000000000E-03 5.19751502E-02 + 4.21373207E-02 1.20392345E-02 1.000000000E-03 5.19751502E-02 + 4.22405984E-02 1.20687424E-02 1.000000000E-03 5.19751502E-02 + 4.23438762E-02 1.20982503E-02 1.000000000E-03 5.19751502E-02 + 4.24471539E-02 1.21277583E-02 1.000000000E-03 5.19751502E-02 + 4.25504316E-02 1.21572662E-02 1.000000000E-03 5.19751502E-02 + 4.26537094E-02 1.21867741E-02 1.000000000E-03 5.19751502E-02 + 4.27569871E-02 1.22162820E-02 1.000000000E-03 5.19751502E-02 + 4.28602649E-02 1.22457900E-02 1.000000000E-03 5.19751502E-02 + 4.29635426E-02 1.22752979E-02 1.000000000E-03 5.19751502E-02 + 4.30668204E-02 1.23048058E-02 1.000000000E-03 5.19751502E-02 + 4.31700981E-02 1.23343137E-02 1.000000000E-03 5.19751502E-02 + 4.32733759E-02 1.23638217E-02 1.000000000E-03 5.19751502E-02 + 4.33766536E-02 1.23933296E-02 1.000000000E-03 5.19751502E-02 + 4.34799314E-02 1.24228375E-02 1.000000000E-03 5.19751502E-02 + 4.35832091E-02 1.24523455E-02 1.000000000E-03 5.19751502E-02 + 4.36864869E-02 1.24818534E-02 1.000000000E-03 5.19751502E-02 + 4.37897646E-02 1.25113613E-02 1.000000000E-03 5.19751502E-02 + 4.38930424E-02 1.25408692E-02 1.000000000E-03 5.19751502E-02 + 4.39963201E-02 1.25703772E-02 1.000000000E-03 5.19751502E-02 + 4.40995978E-02 1.25998851E-02 1.000000000E-03 5.19751502E-02 + 4.42028756E-02 1.26293930E-02 1.000000000E-03 5.19751502E-02 + 4.43061533E-02 1.26589010E-02 1.000000000E-03 5.19751502E-02 + 4.44094311E-02 1.26884089E-02 1.000000000E-03 5.19751502E-02 + 4.45127088E-02 1.27179168E-02 1.000000000E-03 5.19751502E-02 + 4.46159866E-02 1.27474247E-02 1.000000000E-03 5.19751502E-02 + 4.47192643E-02 1.27769327E-02 1.000000000E-03 5.19751502E-02 + 4.48225421E-02 1.28064406E-02 1.000000000E-03 5.19751502E-02 + 4.49258198E-02 1.28359485E-02 1.000000000E-03 5.19751502E-02 + 4.50290976E-02 1.28654564E-02 1.000000000E-03 5.19751502E-02 + 4.51323753E-02 1.28949644E-02 1.000000000E-03 5.19751502E-02 + 4.52356531E-02 1.29244723E-02 1.000000000E-03 5.19751502E-02 + 4.53389308E-02 1.29539802E-02 1.000000000E-03 5.19751502E-02 + 4.54422086E-02 1.29834882E-02 1.000000000E-03 5.19751502E-02 + 4.55454863E-02 1.30129961E-02 1.000000000E-03 5.19751502E-02 + 4.56487640E-02 1.30425040E-02 1.000000000E-03 5.19751502E-02 + 4.57520418E-02 1.30720119E-02 1.000000000E-03 5.19751502E-02 + 4.58553195E-02 1.31015199E-02 1.000000000E-03 5.19751502E-02 + 4.59585973E-02 1.31310278E-02 1.000000000E-03 5.19751502E-02 + 4.60618750E-02 1.31605357E-02 1.000000000E-03 5.19751502E-02 + 4.61651528E-02 1.31900437E-02 1.000000000E-03 5.19751502E-02 + 4.62684305E-02 1.32195516E-02 1.000000000E-03 5.19751502E-02 + 4.63717083E-02 1.32490595E-02 1.000000000E-03 5.19751502E-02 + 4.64749860E-02 1.32785674E-02 1.000000000E-03 5.19751502E-02 + 4.65782638E-02 1.33080754E-02 1.000000000E-03 5.19751502E-02 + 4.66815415E-02 1.33375833E-02 1.000000000E-03 5.19751502E-02 + 4.67848193E-02 1.33670912E-02 1.000000000E-03 5.19751502E-02 + 4.68880970E-02 1.33965991E-02 1.000000000E-03 5.19751502E-02 + 4.69913748E-02 1.34261071E-02 1.000000000E-03 5.19751502E-02 + 4.70946525E-02 1.34556150E-02 1.000000000E-03 5.19751502E-02 + 4.71979302E-02 1.34851229E-02 1.000000000E-03 5.19751502E-02 + 4.73012080E-02 1.35146309E-02 1.000000000E-03 5.19751502E-02 + 4.74044857E-02 1.35441388E-02 1.000000000E-03 5.19751502E-02 + 4.75077635E-02 1.35736467E-02 1.000000000E-03 5.19751502E-02 + 4.76110412E-02 1.36031546E-02 1.000000000E-03 5.19751502E-02 + 4.77143190E-02 1.36326626E-02 1.000000000E-03 5.19751502E-02 + 4.78175967E-02 1.36621705E-02 1.000000000E-03 5.19751502E-02 + 4.79208745E-02 1.36916784E-02 1.000000000E-03 5.19751502E-02 + 4.80241522E-02 1.37211863E-02 1.000000000E-03 5.19751502E-02 + 4.81274300E-02 1.37506943E-02 1.000000000E-03 5.19751502E-02 + 4.82307077E-02 1.37802022E-02 1.000000000E-03 5.19751502E-02 + 4.83339855E-02 1.38097101E-02 1.000000000E-03 5.19751502E-02 + 4.84372632E-02 1.38392181E-02 1.000000000E-03 5.19751502E-02 + 4.85405410E-02 1.38687260E-02 1.000000000E-03 5.19751502E-02 + 4.86438187E-02 1.38982339E-02 1.000000000E-03 5.19751502E-02 + 4.87470964E-02 1.39277418E-02 1.000000000E-03 5.19751502E-02 + 4.88503742E-02 1.39572498E-02 1.000000000E-03 5.19751502E-02 + 4.89536519E-02 1.39867577E-02 1.000000000E-03 5.19751502E-02 + 4.90569297E-02 1.40162656E-02 1.000000000E-03 5.19751502E-02 + 4.91602074E-02 1.40457736E-02 1.000000000E-03 5.19751502E-02 + 4.92634852E-02 1.40752815E-02 1.000000000E-03 5.19751502E-02 + 4.93667629E-02 1.41047894E-02 1.000000000E-03 5.19751502E-02 + 4.94700407E-02 1.41342973E-02 1.000000000E-03 5.19751502E-02 + 4.95733184E-02 1.41638053E-02 1.000000000E-03 5.19751502E-02 + 4.96765962E-02 1.41933132E-02 1.000000000E-03 5.19751502E-02 + 4.97798739E-02 1.42228211E-02 1.000000000E-03 5.19751502E-02 + 4.98831517E-02 1.42523290E-02 1.000000000E-03 5.19751502E-02 + 4.99864294E-02 1.42818370E-02 1.000000000E-03 5.19751502E-02 + 5.00897072E-02 1.43113449E-02 1.000000000E-03 5.19751502E-02 + 5.01929849E-02 1.43408528E-02 1.000000000E-03 5.19751502E-02 + 5.02962626E-02 1.43703608E-02 1.000000000E-03 5.19751502E-02 + 5.03995404E-02 1.43998687E-02 1.000000000E-03 5.19751502E-02 + 5.05028181E-02 1.44293766E-02 1.000000000E-03 5.19751502E-02 + 5.06060959E-02 1.44588845E-02 1.000000000E-03 5.19751502E-02 + 5.07093736E-02 1.44883925E-02 1.000000000E-03 5.19751502E-02 + 5.08126514E-02 1.45179004E-02 1.000000000E-03 5.19751502E-02 + 5.09159291E-02 1.45474083E-02 1.000000000E-03 5.19751502E-02 + 5.10192069E-02 1.45769162E-02 1.000000000E-03 5.19751502E-02 + 5.11224846E-02 1.46064242E-02 1.000000000E-03 5.19751502E-02 + 5.12257624E-02 1.46359321E-02 1.000000000E-03 5.19751502E-02 + 5.13290401E-02 1.46654400E-02 1.000000000E-03 5.19751502E-02 + 5.14323179E-02 1.46949480E-02 1.000000000E-03 5.19751502E-02 + 5.15355956E-02 1.47244559E-02 1.000000000E-03 5.19751502E-02 + 5.16388734E-02 1.47539638E-02 1.000000000E-03 5.19751502E-02 + 5.17421511E-02 1.47834717E-02 1.000000000E-03 5.19751502E-02 + 5.18454288E-02 1.48129797E-02 1.000000000E-03 5.19751502E-02 + 5.19487066E-02 1.48424876E-02 1.000000000E-03 5.19751502E-02 + 5.20519843E-02 1.48719955E-02 1.000000000E-03 5.19751502E-02 + 5.21552621E-02 1.49015035E-02 1.000000000E-03 5.19751502E-02 + 5.22585398E-02 1.49310114E-02 1.000000000E-03 5.19751502E-02 + 5.23618176E-02 1.49605193E-02 1.000000000E-03 5.19751502E-02 + 5.24650953E-02 1.49900272E-02 1.000000000E-03 5.19751502E-02 + 5.25683731E-02 1.50195352E-02 1.000000000E-03 5.19751502E-02 + 5.26716508E-02 1.50490431E-02 1.000000000E-03 5.19751502E-02 + 5.27749286E-02 1.50785510E-02 1.000000000E-03 5.19751502E-02 + 5.28782063E-02 1.51080589E-02 1.000000000E-03 5.19751502E-02 + 5.29814841E-02 1.51375669E-02 1.000000000E-03 5.19751502E-02 + 5.30847618E-02 1.51670748E-02 1.000000000E-03 5.19751502E-02 + 5.31880396E-02 1.51965827E-02 1.000000000E-03 5.19751502E-02 + 5.32913173E-02 1.52260907E-02 1.000000000E-03 5.19751502E-02 + 5.33945950E-02 1.52555986E-02 1.000000000E-03 5.19751502E-02 + 5.34978728E-02 1.52851065E-02 1.000000000E-03 5.19751502E-02 + 5.36011505E-02 1.53146144E-02 1.000000000E-03 5.19751502E-02 + 5.37044283E-02 1.53441224E-02 1.000000000E-03 5.19751502E-02 + 5.38077060E-02 1.53736303E-02 1.000000000E-03 5.19751502E-02 + 5.39109838E-02 1.54031382E-02 1.000000000E-03 5.19751502E-02 + 5.40142615E-02 1.54326462E-02 1.000000000E-03 5.19751502E-02 + 5.41175393E-02 1.54621541E-02 1.000000000E-03 5.19751502E-02 + 5.42208170E-02 1.54916620E-02 1.000000000E-03 5.19751502E-02 + 5.43240948E-02 1.55211699E-02 1.000000000E-03 5.19751502E-02 + 5.44273725E-02 1.55506779E-02 1.000000000E-03 5.19751502E-02 + 5.45306503E-02 1.55801858E-02 1.000000000E-03 5.19751502E-02 + 5.46339280E-02 1.56096937E-02 1.000000000E-03 5.19751502E-02 + 5.47372058E-02 1.56392016E-02 1.000000000E-03 5.19751502E-02 + 5.48404835E-02 1.56687096E-02 1.000000000E-03 5.19751502E-02 + 5.49437612E-02 1.56982175E-02 1.000000000E-03 5.19751502E-02 + 5.50470390E-02 1.57277254E-02 1.000000000E-03 5.19751502E-02 + 5.51503167E-02 1.57572334E-02 1.000000000E-03 5.19751502E-02 + 5.52535945E-02 1.57867413E-02 1.000000000E-03 5.19751502E-02 + 5.53568722E-02 1.58162492E-02 1.000000000E-03 5.19751502E-02 + 5.54601500E-02 1.58457571E-02 1.000000000E-03 5.19751502E-02 + 5.55634277E-02 1.58752651E-02 1.000000000E-03 5.19751502E-02 + 5.56667055E-02 1.59047730E-02 1.000000000E-03 5.19751502E-02 + 5.57699832E-02 1.59342809E-02 1.000000000E-03 5.19751502E-02 + 5.58732610E-02 1.59637888E-02 1.000000000E-03 5.19751502E-02 + 5.59765387E-02 1.59932968E-02 1.000000000E-03 5.19751502E-02 + 5.60798165E-02 1.60228047E-02 1.000000000E-03 5.19751502E-02 + 5.61830942E-02 1.60523126E-02 1.000000000E-03 5.19751502E-02 + 5.62863720E-02 1.60818206E-02 1.000000000E-03 5.19751502E-02 + 5.63896497E-02 1.61113285E-02 1.000000000E-03 5.19751502E-02 + 5.64929274E-02 1.61408364E-02 1.000000000E-03 5.19751502E-02 + 5.65962052E-02 1.61703443E-02 1.000000000E-03 5.19751502E-02 + 5.66994829E-02 1.61998523E-02 1.000000000E-03 5.19751502E-02 + 5.68027607E-02 1.62293602E-02 1.000000000E-03 5.19751502E-02 + 5.69060384E-02 1.62588681E-02 1.000000000E-03 5.19751502E-02 + 5.70093162E-02 1.62883761E-02 1.000000000E-03 5.19751502E-02 + 5.71125939E-02 1.63178840E-02 1.000000000E-03 5.19751502E-02 + 5.72158717E-02 1.63473919E-02 1.000000000E-03 5.19751502E-02 + 5.73191494E-02 1.63768998E-02 1.000000000E-03 5.19751502E-02 + 5.74224272E-02 1.64064078E-02 1.000000000E-03 5.19751502E-02 + 5.75257049E-02 1.64359157E-02 1.000000000E-03 5.19751502E-02 + 5.76289827E-02 1.64654236E-02 1.000000000E-03 5.19751502E-02 + 5.77322604E-02 1.64949315E-02 1.000000000E-03 5.19751502E-02 + 5.78355382E-02 1.65244395E-02 1.000000000E-03 5.19751502E-02 + 5.79388159E-02 1.65539474E-02 1.000000000E-03 5.19751502E-02 + 5.80420937E-02 1.65834553E-02 1.000000000E-03 5.19751502E-02 + 5.81453714E-02 1.66129633E-02 1.000000000E-03 5.19751502E-02 + 5.82486491E-02 1.66424712E-02 1.000000000E-03 5.19751502E-02 + 5.83519269E-02 1.66719791E-02 1.000000000E-03 5.19751502E-02 + 5.84552046E-02 1.67014870E-02 1.000000000E-03 5.19751502E-02 + 5.85584824E-02 1.67309950E-02 1.000000000E-03 5.19751502E-02 + 5.86617601E-02 1.67605029E-02 1.000000000E-03 5.19751502E-02 + 5.87650379E-02 1.67900108E-02 1.000000000E-03 5.19751502E-02 + 5.88683156E-02 1.68195187E-02 1.000000000E-03 5.19751502E-02 + 5.89715934E-02 1.68490267E-02 1.000000000E-03 5.19751502E-02 + 5.90748711E-02 1.68785346E-02 1.000000000E-03 5.19751502E-02 + 5.91781489E-02 1.69080425E-02 1.000000000E-03 5.19751502E-02 + 5.92814266E-02 1.69375505E-02 1.000000000E-03 5.19751502E-02 + 5.93847044E-02 1.69670584E-02 1.000000000E-03 5.19751502E-02 + 5.94879821E-02 1.69965663E-02 1.000000000E-03 5.19751502E-02 + 5.95912599E-02 1.70260742E-02 1.000000000E-03 5.19751502E-02 + 5.96945376E-02 1.70555822E-02 1.000000000E-03 5.19751502E-02 + 5.97978153E-02 1.70850901E-02 1.000000000E-03 5.19751502E-02 + 5.99010931E-02 1.71145980E-02 1.000000000E-03 5.19751502E-02 + 6.00043708E-02 1.71441060E-02 1.000000000E-03 5.19751502E-02 + 6.01076486E-02 1.71736139E-02 1.000000000E-03 5.19751502E-02 + 6.02109263E-02 1.72031218E-02 1.000000000E-03 5.19751502E-02 + 6.03142041E-02 1.72326297E-02 1.000000000E-03 5.19751502E-02 + 6.04174818E-02 1.72621377E-02 1.000000000E-03 5.19751502E-02 + 6.05207596E-02 1.72916456E-02 1.000000000E-03 5.19751502E-02 + 6.06240373E-02 1.73211535E-02 1.000000000E-03 5.19751502E-02 + 6.07273151E-02 1.73506614E-02 1.000000000E-03 5.19751502E-02 + 6.08305928E-02 1.73801694E-02 1.000000000E-03 5.19751502E-02 + 6.09338706E-02 1.74096773E-02 1.000000000E-03 5.19751502E-02 + 6.10371483E-02 1.74391852E-02 1.000000000E-03 5.19751502E-02 + 6.11404261E-02 1.74686932E-02 1.000000000E-03 5.19751502E-02 + 6.12437038E-02 1.74982011E-02 1.000000000E-03 5.19751502E-02 + 6.13469815E-02 1.75277090E-02 1.000000000E-03 5.19751502E-02 + 6.14502593E-02 1.75572169E-02 1.000000000E-03 5.19751502E-02 + 6.15535370E-02 1.75867249E-02 1.000000000E-03 5.19751502E-02 + 6.16568148E-02 1.76162328E-02 1.000000000E-03 5.19751502E-02 + 6.17600925E-02 1.76457407E-02 1.000000000E-03 5.19751502E-02 + 6.18633703E-02 1.76752487E-02 1.000000000E-03 5.19751502E-02 + 6.19666480E-02 1.77047566E-02 1.000000000E-03 5.19751502E-02 + 6.20699258E-02 1.77342645E-02 1.000000000E-03 5.19751502E-02 + 6.21732035E-02 1.77637724E-02 1.000000000E-03 5.19751502E-02 + 6.22764813E-02 1.77932804E-02 1.000000000E-03 5.19751502E-02 + 6.23797590E-02 1.78227883E-02 1.000000000E-03 5.19751502E-02 + 6.24830368E-02 1.78522962E-02 1.000000000E-03 5.19751502E-02 + 6.25863145E-02 1.78818041E-02 1.000000000E-03 5.19751502E-02 + 6.26895923E-02 1.79113121E-02 1.000000000E-03 5.19751502E-02 + 6.27928700E-02 1.79408200E-02 1.000000000E-03 5.19751502E-02 + 6.28961477E-02 1.79703279E-02 1.000000000E-03 5.19751502E-02 + 6.29994255E-02 1.79998359E-02 1.000000000E-03 5.19751502E-02 + 6.31027032E-02 1.80293438E-02 1.000000000E-03 5.19751502E-02 + 6.32059810E-02 1.80588517E-02 1.000000000E-03 5.19751502E-02 + 6.33092587E-02 1.80883596E-02 1.000000000E-03 5.19751502E-02 + 6.34125365E-02 1.81178676E-02 1.000000000E-03 5.19751502E-02 + 6.35158142E-02 1.81473755E-02 1.000000000E-03 5.19751502E-02 + 6.36190920E-02 1.81768834E-02 1.000000000E-03 5.19751502E-02 + 6.37223697E-02 1.82063913E-02 1.000000000E-03 5.19751502E-02 + 6.38256475E-02 1.82358993E-02 1.000000000E-03 5.19751502E-02 + 6.39289252E-02 1.82654072E-02 1.000000000E-03 5.19751502E-02 + 6.40322030E-02 1.82949151E-02 1.000000000E-03 5.19751502E-02 + 6.41354807E-02 1.83244231E-02 1.000000000E-03 5.19751502E-02 + 6.42387585E-02 1.83539310E-02 1.000000000E-03 5.19751502E-02 + 6.43420362E-02 1.83834389E-02 1.000000000E-03 5.19751502E-02 + 6.44453139E-02 1.84129468E-02 1.000000000E-03 5.19751502E-02 + 6.45485917E-02 1.84424548E-02 1.000000000E-03 5.19751502E-02 + 6.46518694E-02 1.84719627E-02 1.000000000E-03 5.19751502E-02 + 6.47551472E-02 1.85014706E-02 1.000000000E-03 5.19751502E-02 + 6.48584249E-02 1.85309786E-02 1.000000000E-03 5.19751502E-02 + 6.49617027E-02 1.85604865E-02 1.000000000E-03 5.19751502E-02 + 6.50649804E-02 1.85899944E-02 1.000000000E-03 5.19751502E-02 + 6.51682582E-02 1.86195023E-02 1.000000000E-03 5.19751502E-02 + 6.52715359E-02 1.86490103E-02 1.000000000E-03 5.19751502E-02 + 6.53748137E-02 1.86785182E-02 1.000000000E-03 5.19751502E-02 + 6.54780914E-02 1.87080261E-02 1.000000000E-03 5.19751502E-02 + 6.55813692E-02 1.87375340E-02 1.000000000E-03 5.19751502E-02 + 6.56846469E-02 1.87670420E-02 1.000000000E-03 5.19751502E-02 + 6.57879247E-02 1.87965499E-02 1.000000000E-03 5.19751502E-02 + 6.58912024E-02 1.88260578E-02 1.000000000E-03 5.19751502E-02 + 6.59944801E-02 1.88555658E-02 1.000000000E-03 5.19751502E-02 + 6.60977579E-02 1.88850737E-02 1.000000000E-03 5.19751502E-02 + 6.62010356E-02 1.89145816E-02 1.000000000E-03 5.19751502E-02 + 6.63043134E-02 1.89440895E-02 1.000000000E-03 5.19751502E-02 + 6.64075911E-02 1.89735975E-02 1.000000000E-03 5.19751502E-02 + 6.65108689E-02 1.90031054E-02 1.000000000E-03 5.19751502E-02 + 6.66141466E-02 1.90326133E-02 1.000000000E-03 5.19751502E-02 + 6.67174244E-02 1.90621212E-02 1.000000000E-03 5.19751502E-02 + 6.68207021E-02 1.90916292E-02 1.000000000E-03 5.19751502E-02 + 6.69239799E-02 1.91211371E-02 1.000000000E-03 5.19751502E-02 + 6.70272576E-02 1.91506450E-02 1.000000000E-03 5.19751502E-02 + 6.71305354E-02 1.91801530E-02 1.000000000E-03 5.19751502E-02 + 6.72338131E-02 1.92096609E-02 1.000000000E-03 5.19751502E-02 + 6.73370909E-02 1.92391688E-02 1.000000000E-03 5.19751502E-02 + 6.74403686E-02 1.92686767E-02 1.000000000E-03 5.19751502E-02 + 6.75436463E-02 1.92981847E-02 1.000000000E-03 5.19751502E-02 + 6.76469241E-02 1.93276926E-02 1.000000000E-03 5.19751502E-02 + 6.77502018E-02 1.93572005E-02 1.000000000E-03 5.19751502E-02 + 6.78534796E-02 1.93867085E-02 1.000000000E-03 5.19751502E-02 + 6.79567573E-02 1.94162164E-02 1.000000000E-03 5.19751502E-02 + 6.80600351E-02 1.94457243E-02 1.000000000E-03 5.19751502E-02 + 6.81633128E-02 1.94752322E-02 1.000000000E-03 5.19751502E-02 + 6.82665906E-02 1.95047402E-02 1.000000000E-03 5.19751502E-02 + 6.83698683E-02 1.95342481E-02 1.000000000E-03 5.19751502E-02 + 6.84731461E-02 1.95637560E-02 1.000000000E-03 5.19751502E-02 + 6.85764238E-02 1.95932639E-02 1.000000000E-03 5.19751502E-02 + 6.86797016E-02 1.96227719E-02 1.000000000E-03 5.19751502E-02 + 6.87829793E-02 1.96522798E-02 1.000000000E-03 5.19751502E-02 + 6.88862571E-02 1.96817877E-02 1.000000000E-03 5.19751502E-02 + 6.89895348E-02 1.97112957E-02 1.000000000E-03 5.19751502E-02 + 6.90928125E-02 1.97408036E-02 1.000000000E-03 5.19751502E-02 + 6.91960903E-02 1.97703115E-02 1.000000000E-03 5.19751502E-02 + 6.92993680E-02 1.97998194E-02 1.000000000E-03 5.19751502E-02 + 6.94026458E-02 1.98293274E-02 1.000000000E-03 5.19751502E-02 + 6.95059235E-02 1.98588353E-02 1.000000000E-03 5.19751502E-02 + 6.96092013E-02 1.98883432E-02 1.000000000E-03 5.19751502E-02 + 6.97124790E-02 1.99178512E-02 1.000000000E-03 5.19751502E-02 + 6.98157568E-02 1.99473591E-02 1.000000000E-03 5.19751502E-02 + 6.99190345E-02 1.99768670E-02 1.000000000E-03 5.19751502E-02 + 7.00223123E-02 2.00063749E-02 1.000000000E-03 5.19751502E-02 + 7.01255900E-02 2.00358829E-02 1.000000000E-03 5.19751502E-02 + 7.02288678E-02 2.00653908E-02 1.000000000E-03 5.19751502E-02 + 7.03321455E-02 2.00948987E-02 1.000000000E-03 5.19751502E-02 + 7.04354233E-02 2.01244066E-02 1.000000000E-03 5.19751502E-02 + 7.05387010E-02 2.01539146E-02 1.000000000E-03 5.19751502E-02 + 7.06419787E-02 2.01834225E-02 1.000000000E-03 5.19751502E-02 + 7.07452565E-02 2.02129304E-02 1.000000000E-03 5.19751502E-02 + 7.08485342E-02 2.02424384E-02 1.000000000E-03 5.19751502E-02 + 7.09518120E-02 2.02719463E-02 1.000000000E-03 5.19751502E-02 + 7.10550897E-02 2.03014542E-02 1.000000000E-03 5.19751502E-02 + 7.11583675E-02 2.03309621E-02 1.000000000E-03 5.19751502E-02 + 7.12616452E-02 2.03604701E-02 1.000000000E-03 5.19751502E-02 + 7.13649230E-02 2.03899780E-02 1.000000000E-03 5.19751502E-02 + 7.14682007E-02 2.04194859E-02 1.000000000E-03 5.19751502E-02 + 7.15714785E-02 2.04489938E-02 1.000000000E-03 5.19751502E-02 + 7.16747562E-02 2.04785018E-02 1.000000000E-03 5.19751502E-02 + 7.17780340E-02 2.05080097E-02 1.000000000E-03 5.19751502E-02 + 7.18813117E-02 2.05375176E-02 1.000000000E-03 5.19751502E-02 + 7.19845895E-02 2.05670256E-02 1.000000000E-03 5.19751502E-02 + 7.20878672E-02 2.05965335E-02 1.000000000E-03 5.19751502E-02 + 7.21911449E-02 2.06260414E-02 1.000000000E-03 5.19751502E-02 + 7.22944227E-02 2.06555493E-02 1.000000000E-03 5.19751502E-02 + 7.23977004E-02 2.06850573E-02 1.000000000E-03 5.19751502E-02 + 7.25009782E-02 2.07145652E-02 1.000000000E-03 5.19751502E-02 + 7.26042559E-02 2.07440731E-02 1.000000000E-03 5.19751502E-02 + 7.27075337E-02 2.07735811E-02 1.000000000E-03 5.19751502E-02 + 7.28108114E-02 2.08030890E-02 1.000000000E-03 5.19751502E-02 + 7.29140892E-02 2.08325969E-02 1.000000000E-03 5.19751502E-02 + 7.30173669E-02 2.08621048E-02 1.000000000E-03 5.19751502E-02 + 7.31206447E-02 2.08916128E-02 1.000000000E-03 5.19751502E-02 + 7.32239224E-02 2.09211207E-02 1.000000000E-03 5.19751502E-02 + 7.33272002E-02 2.09506286E-02 1.000000000E-03 5.19751502E-02 + 7.34304779E-02 2.09801365E-02 1.000000000E-03 5.19751502E-02 + 7.35337557E-02 2.10096445E-02 1.000000000E-03 5.19751502E-02 + 7.36370334E-02 2.10391524E-02 1.000000000E-03 5.19751502E-02 + 7.37403111E-02 2.10686603E-02 1.000000000E-03 5.19751502E-02 + 7.38435889E-02 2.10981683E-02 1.000000000E-03 5.19751502E-02 + 7.39468666E-02 2.11276762E-02 1.000000000E-03 5.19751502E-02 + 7.40501444E-02 2.11571841E-02 1.000000000E-03 5.19751502E-02 + 7.41534221E-02 2.11866920E-02 1.000000000E-03 5.19751502E-02 + 7.42566999E-02 2.12162000E-02 1.000000000E-03 5.19751502E-02 + 7.43599776E-02 2.12457079E-02 1.000000000E-03 5.19751502E-02 + 7.44632554E-02 2.12752158E-02 1.000000000E-03 5.19751502E-02 + 7.45665331E-02 2.13047237E-02 1.000000000E-03 5.19751502E-02 + 7.46698109E-02 2.13342317E-02 1.000000000E-03 5.19751502E-02 + 7.47730886E-02 2.13637396E-02 1.000000000E-03 5.19751502E-02 + 7.48763664E-02 2.13932475E-02 1.000000000E-03 5.19751502E-02 + 7.49796441E-02 2.14227555E-02 1.000000000E-03 5.19751502E-02 + 7.50829219E-02 2.14522634E-02 1.000000000E-03 5.19751502E-02 + 7.51861996E-02 2.14817713E-02 1.000000000E-03 5.19751502E-02 + 7.52894774E-02 2.15112792E-02 1.000000000E-03 5.19751502E-02 + 7.53927551E-02 2.15407872E-02 1.000000000E-03 5.19751502E-02 + 7.54960328E-02 2.15702951E-02 1.000000000E-03 5.19751502E-02 + 7.55993106E-02 2.15998030E-02 1.000000000E-03 5.19751502E-02 + 7.57025883E-02 2.16293110E-02 1.000000000E-03 5.19751502E-02 + 7.58058661E-02 2.16588189E-02 1.000000000E-03 5.19751502E-02 + 7.59091438E-02 2.16883268E-02 1.000000000E-03 5.19751502E-02 + 7.60124216E-02 2.17178347E-02 1.000000000E-03 5.19751502E-02 + 7.61156993E-02 2.17473427E-02 1.000000000E-03 5.19751502E-02 + 7.62189771E-02 2.17768506E-02 1.000000000E-03 5.19751502E-02 + 7.63222548E-02 2.18063585E-02 1.000000000E-03 5.19751502E-02 + 7.64255326E-02 2.18358664E-02 1.000000000E-03 5.19751502E-02 + 7.65288103E-02 2.18653744E-02 1.000000000E-03 5.19751502E-02 + 7.66320881E-02 2.18948823E-02 1.000000000E-03 5.19751502E-02 + 7.67353658E-02 2.19243902E-02 1.000000000E-03 5.19751502E-02 + 7.68386436E-02 2.19538982E-02 1.000000000E-03 5.19751502E-02 + 7.69419213E-02 2.19834061E-02 1.000000000E-03 5.19751502E-02 + 7.70451990E-02 2.20129140E-02 1.000000000E-03 5.19751502E-02 + 7.71484768E-02 2.20424219E-02 1.000000000E-03 5.19751502E-02 + 7.72517545E-02 2.20719299E-02 1.000000000E-03 5.19751502E-02 + 7.73550323E-02 2.21014378E-02 1.000000000E-03 5.19751502E-02 + 7.74583100E-02 2.21309457E-02 1.000000000E-03 5.19751502E-02 + 7.75615878E-02 2.21604537E-02 1.000000000E-03 5.19751502E-02 + 7.76648655E-02 2.21899616E-02 1.000000000E-03 5.19751502E-02 + 7.77681433E-02 2.22194695E-02 1.000000000E-03 5.19751502E-02 + 7.78714210E-02 2.22489774E-02 1.000000000E-03 5.19751502E-02 + 7.79746988E-02 2.22784854E-02 1.000000000E-03 5.19751502E-02 + 7.80779765E-02 2.23079933E-02 1.000000000E-03 5.19751502E-02 + 7.81812543E-02 2.23375012E-02 1.000000000E-03 5.19751502E-02 + 7.82845320E-02 2.23670091E-02 1.000000000E-03 5.19751502E-02 + 7.83878098E-02 2.23965171E-02 1.000000000E-03 5.19751502E-02 + 7.84910875E-02 2.24260250E-02 1.000000000E-03 5.19751502E-02 + 7.85943652E-02 2.24555329E-02 1.000000000E-03 5.19751502E-02 + 7.86976430E-02 2.24850409E-02 1.000000000E-03 5.19751502E-02 + 7.88009207E-02 2.25145488E-02 1.000000000E-03 5.19751502E-02 + 7.89041985E-02 2.25440567E-02 1.000000000E-03 5.19751502E-02 + 7.90074762E-02 2.25735646E-02 1.000000000E-03 5.19751502E-02 + 7.91107540E-02 2.26030726E-02 1.000000000E-03 5.19751502E-02 + 7.92140317E-02 2.26325805E-02 1.000000000E-03 5.19751502E-02 + 7.93173095E-02 2.26620884E-02 1.000000000E-03 5.19751502E-02 + 7.94205872E-02 2.26915963E-02 1.000000000E-03 5.19751502E-02 + 7.95238650E-02 2.27211043E-02 1.000000000E-03 5.19751502E-02 + 7.96271427E-02 2.27506122E-02 1.000000000E-03 5.19751502E-02 + 7.97304205E-02 2.27801201E-02 1.000000000E-03 5.19751502E-02 + 7.98336982E-02 2.28096281E-02 1.000000000E-03 5.19751502E-02 + 7.99369760E-02 2.28391360E-02 1.000000000E-03 5.19751502E-02 + 8.00402537E-02 2.28686439E-02 1.000000000E-03 5.19751502E-02 + 8.01435314E-02 2.28981518E-02 1.000000000E-03 5.19751502E-02 + 8.02468092E-02 2.29276598E-02 1.000000000E-03 5.19751502E-02 + 8.03500869E-02 2.29571677E-02 1.000000000E-03 5.19751502E-02 + 8.04533647E-02 2.29866756E-02 1.000000000E-03 5.19751502E-02 + 8.05566424E-02 2.30161836E-02 1.000000000E-03 5.19751502E-02 + 8.06599202E-02 2.30456915E-02 1.000000000E-03 5.19751502E-02 + 8.07631979E-02 2.30751994E-02 1.000000000E-03 5.19751502E-02 + 8.08664757E-02 2.31047073E-02 1.000000000E-03 5.19751502E-02 + 8.09697534E-02 2.31342153E-02 1.000000000E-03 5.19751502E-02 + 8.10730312E-02 2.31637232E-02 1.000000000E-03 5.19751502E-02 + 8.11763089E-02 2.31932311E-02 1.000000000E-03 5.19751502E-02 + 8.12795867E-02 2.32227390E-02 1.000000000E-03 5.19751502E-02 + 8.13828644E-02 2.32522470E-02 1.000000000E-03 5.19751502E-02 + 8.14861422E-02 2.32817549E-02 1.000000000E-03 5.19751502E-02 + 8.15894199E-02 2.33112628E-02 1.000000000E-03 5.19751502E-02 + 8.16926976E-02 2.33407708E-02 1.000000000E-03 5.19751502E-02 + 8.17959754E-02 2.33702787E-02 1.000000000E-03 5.19751502E-02 + 8.18992531E-02 2.33997866E-02 1.000000000E-03 5.19751502E-02 + 8.20025309E-02 2.34292945E-02 1.000000000E-03 5.19751502E-02 + 8.21058086E-02 2.34588025E-02 1.000000000E-03 5.19751502E-02 + 8.22090864E-02 2.34883104E-02 1.000000000E-03 5.19751502E-02 + 8.23123641E-02 2.35178183E-02 1.000000000E-03 5.19751502E-02 + 8.24156419E-02 2.35473262E-02 1.000000000E-03 5.19751502E-02 + 8.25189196E-02 2.35768342E-02 1.000000000E-03 5.19751502E-02 + 8.26221974E-02 2.36063421E-02 1.000000000E-03 5.19751502E-02 + 8.27254751E-02 2.36358500E-02 1.000000000E-03 5.19751502E-02 + 8.28287529E-02 2.36653580E-02 1.000000000E-03 5.19751502E-02 + 8.29320306E-02 2.36948659E-02 1.000000000E-03 5.19751502E-02 + 8.30353084E-02 2.37243738E-02 1.000000000E-03 5.19751502E-02 + 8.31385861E-02 2.37538817E-02 1.000000000E-03 5.19751502E-02 + 8.32418638E-02 2.37833897E-02 1.000000000E-03 5.19751502E-02 + 8.33451416E-02 2.38128976E-02 1.000000000E-03 5.19751502E-02 + 8.34484193E-02 2.38424055E-02 1.000000000E-03 5.19751502E-02 + 8.35516971E-02 2.38719135E-02 1.000000000E-03 5.19751502E-02 + 8.36549748E-02 2.39014214E-02 1.000000000E-03 5.19751502E-02 + 8.37582526E-02 2.39309293E-02 1.000000000E-03 5.19751502E-02 + 8.38615303E-02 2.39604372E-02 1.000000000E-03 5.19751502E-02 + 8.39648081E-02 2.39899452E-02 1.000000000E-03 5.19751502E-02 + 8.40680858E-02 2.40194531E-02 1.000000000E-03 5.19751502E-02 + 8.41713636E-02 2.40489610E-02 1.000000000E-03 5.19751502E-02 + 8.42746413E-02 2.40784689E-02 1.000000000E-03 5.19751502E-02 + 8.43779191E-02 2.41079769E-02 1.000000000E-03 5.19751502E-02 + 8.44811968E-02 2.41374848E-02 1.000000000E-03 5.19751502E-02 + 8.45844746E-02 2.41669927E-02 1.000000000E-03 5.19751502E-02 + 8.46877523E-02 2.41965007E-02 1.000000000E-03 5.19751502E-02 + 8.47910300E-02 2.42260086E-02 1.000000000E-03 5.19751502E-02 + 8.48943078E-02 2.42555165E-02 1.000000000E-03 5.19751502E-02 + 8.49975855E-02 2.42850244E-02 1.000000000E-03 5.19751502E-02 + 8.51008633E-02 2.43145324E-02 1.000000000E-03 5.19751502E-02 + 8.52041410E-02 2.43440403E-02 1.000000000E-03 5.19751502E-02 + 8.53074188E-02 2.43735482E-02 1.000000000E-03 5.19751502E-02 + 8.54106965E-02 2.44030562E-02 1.000000000E-03 5.19751502E-02 + 8.55139743E-02 2.44325641E-02 1.000000000E-03 5.19751502E-02 + 8.56172520E-02 2.44620720E-02 1.000000000E-03 5.19751502E-02 + 8.57205298E-02 2.44915799E-02 1.000000000E-03 5.19751502E-02 + 8.58238075E-02 2.45210879E-02 1.000000000E-03 5.19751502E-02 + 8.59270853E-02 2.45505958E-02 1.000000000E-03 5.19751502E-02 + 8.60303630E-02 2.45801037E-02 1.000000000E-03 5.19751502E-02 + 8.61336408E-02 2.46096116E-02 1.000000000E-03 5.19751502E-02 + 8.62369185E-02 2.46391196E-02 1.000000000E-03 5.19751502E-02 + 8.63401962E-02 2.46686275E-02 1.000000000E-03 5.19751502E-02 + 8.64434740E-02 2.46981354E-02 1.000000000E-03 5.19751502E-02 + 8.65467517E-02 2.47276434E-02 1.000000000E-03 5.19751502E-02 + 8.66500295E-02 2.47571513E-02 1.000000000E-03 5.19751502E-02 + 8.67533072E-02 2.47866592E-02 1.000000000E-03 5.19751502E-02 + 8.68565850E-02 2.48161671E-02 1.000000000E-03 5.19751502E-02 + 8.69598627E-02 2.48456751E-02 1.000000000E-03 5.19751502E-02 + 8.70631405E-02 2.48751830E-02 1.000000000E-03 5.19751502E-02 + 8.71664182E-02 2.49046909E-02 1.000000000E-03 5.19751502E-02 + 8.72696960E-02 2.49341988E-02 1.000000000E-03 5.19751502E-02 + 8.73729737E-02 2.49637068E-02 1.000000000E-03 5.19751502E-02 + 8.74762515E-02 2.49932147E-02 1.000000000E-03 5.19751502E-02 + 8.75795292E-02 2.50227226E-02 1.000000000E-03 5.19751502E-02 + 8.76828070E-02 2.50522306E-02 1.000000000E-03 5.19751502E-02 + 8.77860847E-02 2.50817385E-02 1.000000000E-03 5.19751502E-02 + 8.78893624E-02 2.51112464E-02 1.000000000E-03 5.19751502E-02 + 8.79926402E-02 2.51407543E-02 1.000000000E-03 5.19751502E-02 + 8.80959179E-02 2.51702623E-02 1.000000000E-03 5.19751502E-02 + 8.81991957E-02 2.51997702E-02 1.000000000E-03 5.19751502E-02 + 8.83024734E-02 2.52292781E-02 1.000000000E-03 5.19751502E-02 + 8.84057512E-02 2.52587861E-02 1.000000000E-03 5.19751502E-02 + 8.85090289E-02 2.52882940E-02 1.000000000E-03 5.19751502E-02 + 8.86123067E-02 2.53178019E-02 1.000000000E-03 5.19751502E-02 + 8.87155844E-02 2.53473098E-02 1.000000000E-03 5.19751502E-02 + 8.88188622E-02 2.53768178E-02 1.000000000E-03 5.19751502E-02 + 8.89221399E-02 2.54063257E-02 1.000000000E-03 5.19751502E-02 + 8.90254177E-02 2.54358336E-02 1.000000000E-03 5.19751502E-02 + 8.91286954E-02 2.54653415E-02 1.000000000E-03 5.19751502E-02 + 8.92319732E-02 2.54948495E-02 1.000000000E-03 5.19751502E-02 + 8.93352509E-02 2.55243574E-02 1.000000000E-03 5.19751502E-02 + 8.94385286E-02 2.55538653E-02 1.000000000E-03 5.19751502E-02 + 8.95418064E-02 2.55833733E-02 1.000000000E-03 5.19751502E-02 + 8.96450841E-02 2.56128812E-02 1.000000000E-03 5.19751502E-02 + 8.97483619E-02 2.56423891E-02 1.000000000E-03 5.19751502E-02 + 8.98516396E-02 2.56718970E-02 1.000000000E-03 5.19751502E-02 + 8.99549174E-02 2.57014050E-02 1.000000000E-03 5.19751502E-02 + 9.00581951E-02 2.57309129E-02 1.000000000E-03 5.19751502E-02 + 9.01614729E-02 2.57604208E-02 1.000000000E-03 5.19751502E-02 + 9.02647506E-02 2.57899287E-02 1.000000000E-03 5.19751502E-02 + 9.03680284E-02 2.58194367E-02 1.000000000E-03 5.19751502E-02 + 9.04713061E-02 2.58489446E-02 1.000000000E-03 5.19751502E-02 + 9.05745839E-02 2.58784525E-02 1.000000000E-03 5.19751502E-02 + 9.06778616E-02 2.59079605E-02 1.000000000E-03 5.19751502E-02 + 9.07811394E-02 2.59374684E-02 1.000000000E-03 5.19751502E-02 + 9.08844171E-02 2.59669763E-02 1.000000000E-03 5.19751502E-02 + 9.09876949E-02 2.59964842E-02 1.000000000E-03 5.19751502E-02 + 9.10909726E-02 2.60259922E-02 1.000000000E-03 5.19751502E-02 + 9.11942503E-02 2.60555001E-02 1.000000000E-03 5.19751502E-02 + 9.12975281E-02 2.60850080E-02 1.000000000E-03 5.19751502E-02 + 9.14008058E-02 2.61145160E-02 1.000000000E-03 5.19751502E-02 + 9.15040836E-02 2.61440239E-02 1.000000000E-03 5.19751502E-02 + 9.16073613E-02 2.61735318E-02 1.000000000E-03 5.19751502E-02 + 9.17106391E-02 2.62030397E-02 1.000000000E-03 5.19751502E-02 + 9.18139168E-02 2.62325477E-02 1.000000000E-03 5.19751502E-02 + 9.19171946E-02 2.62620556E-02 1.000000000E-03 5.19751502E-02 + 9.20204723E-02 2.62915635E-02 1.000000000E-03 5.19751502E-02 + 9.21237501E-02 2.63210714E-02 1.000000000E-03 5.19751502E-02 + 9.22270278E-02 2.63505794E-02 1.000000000E-03 5.19751502E-02 + 9.23303056E-02 2.63800873E-02 1.000000000E-03 5.19751502E-02 + 9.24335833E-02 2.64095952E-02 1.000000000E-03 5.19751502E-02 + 9.25368611E-02 2.64391032E-02 1.000000000E-03 5.19751502E-02 + 9.26401388E-02 2.64686111E-02 1.000000000E-03 5.19751502E-02 + 9.27434165E-02 2.64981190E-02 1.000000000E-03 5.19751502E-02 + 9.28466943E-02 2.65276269E-02 1.000000000E-03 5.19751502E-02 + 9.29499720E-02 2.65571349E-02 1.000000000E-03 5.19751502E-02 + 9.30532498E-02 2.65866428E-02 1.000000000E-03 5.19751502E-02 + 9.31565275E-02 2.66161507E-02 1.000000000E-03 5.19751502E-02 + 9.32598053E-02 2.66456587E-02 1.000000000E-03 5.19751502E-02 + 9.33630830E-02 2.66751666E-02 1.000000000E-03 5.19751502E-02 + 9.34663608E-02 2.67046745E-02 1.000000000E-03 5.19751502E-02 + 9.35696385E-02 2.67341824E-02 1.000000000E-03 5.19751502E-02 + 9.36729163E-02 2.67636904E-02 1.000000000E-03 5.19751502E-02 + 9.37761940E-02 2.67931983E-02 1.000000000E-03 5.19751502E-02 + 9.38794718E-02 2.68227062E-02 1.000000000E-03 5.19751502E-02 + 9.39827495E-02 2.68522141E-02 1.000000000E-03 5.19751502E-02 + 9.40860273E-02 2.68817221E-02 1.000000000E-03 5.19751502E-02 + 9.41893050E-02 2.69112300E-02 1.000000000E-03 5.19751502E-02 + 9.42925827E-02 2.69407379E-02 1.000000000E-03 5.19751502E-02 + 9.43958605E-02 2.69702459E-02 1.000000000E-03 5.19751502E-02 + 9.44991382E-02 2.69997538E-02 1.000000000E-03 5.19751502E-02 + 9.46024160E-02 2.70292617E-02 1.000000000E-03 5.19751502E-02 + 9.47056937E-02 2.70587696E-02 1.000000000E-03 5.19751502E-02 + 9.48089715E-02 2.70882776E-02 1.000000000E-03 5.19751502E-02 + 9.49122492E-02 2.71177855E-02 1.000000000E-03 5.19751502E-02 + 9.50155270E-02 2.71472934E-02 1.000000000E-03 5.19751502E-02 + 9.51188047E-02 2.71768013E-02 1.000000000E-03 5.19751502E-02 + 9.52220825E-02 2.72063093E-02 1.000000000E-03 5.19751502E-02 + 9.53253602E-02 2.72358172E-02 1.000000000E-03 5.19751502E-02 + 9.54286380E-02 2.72653251E-02 1.000000000E-03 5.19751502E-02 + 9.55319157E-02 2.72948331E-02 1.000000000E-03 5.19751502E-02 + 9.56351935E-02 2.73243410E-02 1.000000000E-03 5.19751502E-02 + 9.57384712E-02 2.73538489E-02 1.000000000E-03 5.19751502E-02 + 9.58417489E-02 2.73833568E-02 1.000000000E-03 5.19751502E-02 + 9.59450267E-02 2.74128648E-02 1.000000000E-03 5.19751502E-02 + 9.60483044E-02 2.74423727E-02 1.000000000E-03 5.19751502E-02 + 9.61515822E-02 2.74718806E-02 1.000000000E-03 5.19751502E-02 + 9.62548599E-02 2.75013886E-02 1.000000000E-03 5.19751502E-02 + 9.63581377E-02 2.75308965E-02 1.000000000E-03 5.19751502E-02 + 9.64614154E-02 2.75604044E-02 1.000000000E-03 5.19751502E-02 + 9.65646932E-02 2.75899123E-02 1.000000000E-03 5.19751502E-02 + 9.66679709E-02 2.76194203E-02 1.000000000E-03 5.19751502E-02 + 9.67712487E-02 2.76489282E-02 1.000000000E-03 5.19751502E-02 + 9.68745264E-02 2.76784361E-02 1.000000000E-03 5.19751502E-02 + 9.69778042E-02 2.77079440E-02 1.000000000E-03 5.19751502E-02 + 9.70810819E-02 2.77374520E-02 1.000000000E-03 5.19751502E-02 + 9.71843597E-02 2.77669599E-02 1.000000000E-03 5.19751502E-02 + 9.72876374E-02 2.77964678E-02 1.000000000E-03 5.19751502E-02 + 9.73909151E-02 2.78259758E-02 1.000000000E-03 5.19751502E-02 + 9.74941929E-02 2.78554837E-02 1.000000000E-03 5.19751502E-02 + 9.75974706E-02 2.78849916E-02 1.000000000E-03 5.19751502E-02 + 9.77007484E-02 2.79144995E-02 1.000000000E-03 5.19751502E-02 + 9.78040261E-02 2.79440075E-02 1.000000000E-03 5.19751502E-02 + 9.79073039E-02 2.79735154E-02 1.000000000E-03 5.19751502E-02 + 9.80105816E-02 2.80030233E-02 1.000000000E-03 5.19751502E-02 + 9.81138594E-02 2.80325312E-02 1.000000000E-03 5.19751502E-02 + 9.82171371E-02 2.80620392E-02 1.000000000E-03 5.19751502E-02 + 9.83204149E-02 2.80915471E-02 1.000000000E-03 5.19751502E-02 + 9.84236926E-02 2.81210550E-02 1.000000000E-03 5.19751502E-02 + 9.85269704E-02 2.81505630E-02 1.000000000E-03 5.19751502E-02 + 9.86302481E-02 2.81800709E-02 1.000000000E-03 5.19751502E-02 + 9.87335259E-02 2.82095788E-02 1.000000000E-03 5.19751502E-02 + 9.88368036E-02 2.82390867E-02 1.000000000E-03 5.19751502E-02 + 9.89400813E-02 2.82685947E-02 1.000000000E-03 5.19751502E-02 + 9.90433591E-02 2.82981026E-02 1.000000000E-03 5.19751502E-02 + 9.91466368E-02 2.83276105E-02 1.000000000E-03 5.19751502E-02 + 9.92499146E-02 2.83571185E-02 1.000000000E-03 5.19751502E-02 + 9.93531923E-02 2.83866264E-02 1.000000000E-03 5.19751502E-02 + 9.94564701E-02 2.84161343E-02 1.000000000E-03 5.19751502E-02 + 9.95597478E-02 2.84456422E-02 1.000000000E-03 5.19751502E-02 + 9.96630256E-02 2.84751502E-02 1.000000000E-03 5.19751502E-02 + 9.97663033E-02 2.85046581E-02 1.000000000E-03 5.19751502E-02 + 9.98695811E-02 2.85341660E-02 1.000000000E-03 5.19751502E-02 + 9.99728588E-02 2.85636739E-02 1.000000000E-03 5.19751502E-02 + 1.00076137E-01 2.85931819E-02 1.000000000E-03 5.19751502E-02 + 1.00179414E-01 2.86226898E-02 1.000000000E-03 5.19751502E-02 + 1.00282692E-01 2.86521977E-02 1.000000000E-03 5.19751502E-02 + 1.00385970E-01 2.86817057E-02 1.000000000E-03 5.19751502E-02 + 1.00489248E-01 2.87112136E-02 1.000000000E-03 5.19751502E-02 + 1.00592525E-01 2.87407215E-02 1.000000000E-03 5.19751502E-02 + 1.00695803E-01 2.87702294E-02 1.000000000E-03 5.19751502E-02 + 1.00799081E-01 2.87997374E-02 1.000000000E-03 5.19751502E-02 + 1.00902359E-01 2.88292453E-02 1.000000000E-03 5.19751502E-02 + 1.01005636E-01 2.88587532E-02 1.000000000E-03 5.19751502E-02 + 1.01108914E-01 2.88882612E-02 1.000000000E-03 5.19751502E-02 + 1.01212192E-01 2.89177691E-02 1.000000000E-03 5.19751502E-02 + 1.01315470E-01 2.89472770E-02 1.000000000E-03 5.19751502E-02 + 1.01418747E-01 2.89767849E-02 1.000000000E-03 5.19751502E-02 + 1.01522025E-01 2.90062929E-02 1.000000000E-03 5.19751502E-02 + 1.01625303E-01 2.90358008E-02 1.000000000E-03 5.19751502E-02 + 1.01728581E-01 2.90653087E-02 1.000000000E-03 5.19751502E-02 + 1.01831858E-01 2.90948166E-02 1.000000000E-03 5.19751502E-02 + 1.01935136E-01 2.91243246E-02 1.000000000E-03 5.19751502E-02 + 1.02038414E-01 2.91538325E-02 1.000000000E-03 5.19751502E-02 + 1.02141691E-01 2.91833404E-02 1.000000000E-03 5.19751502E-02 + 1.02244969E-01 2.92128484E-02 1.000000000E-03 5.19751502E-02 + 1.02348247E-01 2.92423563E-02 1.000000000E-03 5.19751502E-02 + 1.02451525E-01 2.92718642E-02 1.000000000E-03 5.19751502E-02 + 1.02554802E-01 2.93013721E-02 1.000000000E-03 5.19751502E-02 + 1.02658080E-01 2.93308801E-02 1.000000000E-03 5.19751502E-02 + 1.02761358E-01 2.93603880E-02 1.000000000E-03 5.19751502E-02 + 1.02864636E-01 2.93898959E-02 1.000000000E-03 5.19751502E-02 + 1.02967913E-01 2.94194038E-02 1.000000000E-03 5.19751502E-02 + 1.03071191E-01 2.94489118E-02 1.000000000E-03 5.19751502E-02 + 1.03174469E-01 2.94784197E-02 1.000000000E-03 5.19751502E-02 + 1.03277747E-01 2.95079276E-02 1.000000000E-03 5.19751502E-02 + 1.03381024E-01 2.95374356E-02 1.000000000E-03 5.19751502E-02 + 1.03484302E-01 2.95669435E-02 1.000000000E-03 5.19751502E-02 + 1.03587580E-01 2.95964514E-02 1.000000000E-03 5.19751502E-02 + 1.03690858E-01 2.96259593E-02 1.000000000E-03 5.19751502E-02 + 1.03794135E-01 2.96554673E-02 1.000000000E-03 5.19751502E-02 + 1.03897413E-01 2.96849752E-02 1.000000000E-03 5.19751502E-02 + 1.04000691E-01 2.97144831E-02 1.000000000E-03 5.19751502E-02 + 1.04103969E-01 2.97439911E-02 1.000000000E-03 5.19751502E-02 + 1.04207246E-01 2.97734990E-02 1.000000000E-03 5.19751502E-02 + 1.04310524E-01 2.98030069E-02 1.000000000E-03 5.19751502E-02 + 1.04413802E-01 2.98325148E-02 1.000000000E-03 5.19751502E-02 + 1.04517080E-01 2.98620228E-02 1.000000000E-03 5.19751502E-02 + 1.04620357E-01 2.98915307E-02 1.000000000E-03 5.19751502E-02 + 1.04723635E-01 2.99210386E-02 1.000000000E-03 5.19751502E-02 + 1.04826913E-01 2.99505465E-02 1.000000000E-03 5.19751502E-02 + 1.04930191E-01 2.99800545E-02 1.000000000E-03 5.19751502E-02 + 1.05033468E-01 3.00095624E-02 1.000000000E-03 5.19751502E-02 + 1.05136746E-01 3.00390703E-02 1.000000000E-03 5.19751502E-02 + 1.05240024E-01 3.00685783E-02 1.000000000E-03 5.19751502E-02 + 1.05343302E-01 3.00980862E-02 1.000000000E-03 5.19751502E-02 + 1.05446579E-01 3.01275941E-02 1.000000000E-03 5.19751502E-02 + 1.05549857E-01 3.01571020E-02 1.000000000E-03 5.19751502E-02 + 1.05653135E-01 3.01866100E-02 1.000000000E-03 5.19751502E-02 + 1.05756413E-01 3.02161179E-02 1.000000000E-03 5.19751502E-02 + 1.05859690E-01 3.02456258E-02 1.000000000E-03 5.19751502E-02 + 1.05962968E-01 3.02751337E-02 1.000000000E-03 5.19751502E-02 + 1.06066246E-01 3.03046417E-02 1.000000000E-03 5.19751502E-02 + 1.06169524E-01 3.03341496E-02 1.000000000E-03 5.19751502E-02 + 1.06272801E-01 3.03636575E-02 1.000000000E-03 5.19751502E-02 + 1.06376079E-01 3.03931655E-02 1.000000000E-03 5.19751502E-02 + 1.06479357E-01 3.04226734E-02 1.000000000E-03 5.19751502E-02 + 1.06582635E-01 3.04521813E-02 1.000000000E-03 5.19751502E-02 + 1.06685912E-01 3.04816892E-02 1.000000000E-03 5.19751502E-02 + 1.06789190E-01 3.05111972E-02 1.000000000E-03 5.19751502E-02 + 1.06892468E-01 3.05407051E-02 1.000000000E-03 5.19751502E-02 + 1.06995746E-01 3.05702130E-02 1.000000000E-03 5.19751502E-02 + 1.07099023E-01 3.05997210E-02 1.000000000E-03 5.19751502E-02 + 1.07202301E-01 3.06292289E-02 1.000000000E-03 5.19751502E-02 + 1.07305579E-01 3.06587368E-02 1.000000000E-03 5.19751502E-02 + 1.07408857E-01 3.06882447E-02 1.000000000E-03 5.19751502E-02 + 1.07512134E-01 3.07177527E-02 1.000000000E-03 5.19751502E-02 + 1.07615412E-01 3.07472606E-02 1.000000000E-03 5.19751502E-02 + 1.07718690E-01 3.07767685E-02 1.000000000E-03 5.19751502E-02 + 1.07821968E-01 3.08062764E-02 1.000000000E-03 5.19751502E-02 + 1.07925245E-01 3.08357844E-02 1.000000000E-03 5.19751502E-02 + 1.08028523E-01 3.08652923E-02 1.000000000E-03 5.19751502E-02 + 1.08131801E-01 3.08948002E-02 1.000000000E-03 5.19751502E-02 + 1.08235079E-01 3.09243082E-02 1.000000000E-03 5.19751502E-02 + 1.08338356E-01 3.09538161E-02 1.000000000E-03 5.19751502E-02 + 1.08441634E-01 3.09833240E-02 1.000000000E-03 5.19751502E-02 + 1.08544912E-01 3.10128319E-02 1.000000000E-03 5.19751502E-02 + 1.08648190E-01 3.10423399E-02 1.000000000E-03 5.19751502E-02 + 1.08751467E-01 3.10718478E-02 1.000000000E-03 5.19751502E-02 + 1.08854745E-01 3.11013557E-02 1.000000000E-03 5.19751502E-02 + 1.08958023E-01 3.11308637E-02 1.000000000E-03 5.19751502E-02 + 1.09061301E-01 3.11603716E-02 1.000000000E-03 5.19751502E-02 + 1.09164578E-01 3.11898795E-02 1.000000000E-03 5.19751502E-02 + 1.09267856E-01 3.12193874E-02 1.000000000E-03 5.19751502E-02 + 1.09371134E-01 3.12488954E-02 1.000000000E-03 5.19751502E-02 + 1.09474412E-01 3.12784033E-02 1.000000000E-03 5.19751502E-02 + 1.09577689E-01 3.13079112E-02 1.000000000E-03 5.19751502E-02 + 1.09680967E-01 3.13374191E-02 1.000000000E-03 5.19751502E-02 + 1.09784245E-01 3.13669271E-02 1.000000000E-03 5.19754586E-02 + 1.09887522E-01 3.13964350E-02 1.000000000E-03 5.19749442E-02 + 1.09990800E-01 3.14259429E-02 1.000000000E-03 5.19752125E-02 + 1.10094078E-01 3.14554509E-02 1.000000000E-03 5.19742540E-02 + 1.10197356E-01 3.14849588E-02 1.000000000E-03 5.19760403E-02 + 1.10300633E-01 3.15144667E-02 1.000000000E-03 5.19746462E-02 + 1.10403911E-01 3.15439746E-02 1.000000000E-03 5.19759862E-02 + 1.10507189E-01 3.15734826E-02 1.000000000E-03 5.19742200E-02 + 1.10610467E-01 3.16029905E-02 1.000000000E-03 5.19751573E-02 + 1.10713744E-01 3.16324984E-02 1.000000000E-03 5.19749325E-02 + 1.10817022E-01 3.16620064E-02 1.000000000E-03 5.19755106E-02 + 1.10920300E-01 3.16915143E-02 1.000000000E-03 5.19749453E-02 + 1.11023578E-01 3.17210222E-02 1.000000000E-03 5.19751672E-02 + 1.11126855E-01 3.17505301E-02 1.000000000E-03 5.19742825E-02 + 1.11230133E-01 3.17800381E-02 1.000000000E-03 5.19759964E-02 + 1.11333411E-01 3.18095460E-02 1.000000000E-03 5.19748493E-02 + 1.11436689E-01 3.18390539E-02 1.000000000E-03 5.19744586E-02 + 1.11539966E-01 3.18685618E-02 1.000000000E-03 5.19748270E-02 + 1.11643244E-01 3.18980698E-02 1.000000000E-03 5.19759400E-02 + 1.11746522E-01 3.19275777E-02 1.000000000E-03 5.19743210E-02 + 1.11849800E-01 3.19570856E-02 1.000000000E-03 5.19751943E-02 + 1.11953077E-01 3.19865936E-02 1.000000000E-03 5.19750983E-02 + 1.12056355E-01 3.20161015E-02 1.000000000E-03 5.19757493E-02 + 1.12159633E-01 3.20456094E-02 1.000000000E-03 5.19754289E-02 + 1.12262911E-01 3.20751173E-02 1.000000000E-03 5.19758892E-02 + 1.12366188E-01 3.21046253E-02 1.000000000E-03 5.19754081E-02 + 1.12469466E-01 3.21341332E-02 1.000000000E-03 5.19756913E-02 + 1.12572744E-01 3.21636411E-02 1.000000000E-03 5.19750942E-02 + 1.12676022E-01 3.21931490E-02 1.000000000E-03 5.19752289E-02 + 1.12779299E-01 3.22226570E-02 1.000000000E-03 5.19745266E-02 + 1.12882577E-01 3.22521649E-02 1.000000000E-03 5.19745402E-02 + 1.12985855E-01 3.22816728E-02 1.000000000E-03 5.19753021E-02 + 1.13089133E-01 3.23111808E-02 1.000000000E-03 5.19752224E-02 + 1.13192410E-01 3.23406887E-02 1.000000000E-03 5.19758895E-02 + 1.13295688E-01 3.23701966E-02 1.000000000E-03 5.19757407E-02 + 1.13398966E-01 3.23997045E-02 1.000000000E-03 5.19748167E-02 + 1.13502244E-01 3.24292125E-02 1.000000000E-03 5.19746352E-02 + 1.13605521E-01 3.24587204E-02 1.000000000E-03 5.19751820E-02 + 1.13708799E-01 3.24882283E-02 1.000000000E-03 5.19749475E-02 + 1.13812077E-01 3.25177363E-02 1.000000000E-03 5.19754683E-02 + 1.13915355E-01 3.25472442E-02 1.000000000E-03 5.19752452E-02 + 1.14018632E-01 3.25767521E-02 1.000000000E-03 5.19757460E-02 + 1.14121910E-01 3.26062600E-02 1.000000000E-03 5.19755395E-02 + 1.14225188E-01 3.26357680E-02 1.000000000E-03 5.19746349E-02 + 1.14328466E-01 3.26652759E-02 1.000000000E-03 5.19744618E-02 + 1.14431743E-01 3.26947838E-02 1.000000000E-03 5.19750066E-02 + 1.14535021E-01 3.27242917E-02 1.000000000E-03 5.19748861E-02 + 1.14638299E-01 3.27537997E-02 1.000000000E-03 5.19754800E-02 + 1.14741577E-01 3.27833076E-02 1.000000000E-03 5.19754152E-02 + 1.14844854E-01 3.28128155E-02 1.000000000E-03 5.19747264E-02 + 1.14948132E-01 3.28423235E-02 1.000000000E-03 5.19747577E-02 + 1.15051410E-01 3.28718314E-02 1.000000000E-03 5.19755086E-02 + 1.15154688E-01 3.29013393E-02 1.000000000E-03 5.19756260E-02 + 1.15257965E-01 3.29308472E-02 1.000000000E-03 5.19751559E-02 + 1.15361243E-01 3.29603552E-02 1.000000000E-03 5.19754098E-02 + 1.15464521E-01 3.29898631E-02 1.000000000E-03 5.19750807E-02 + 1.15567799E-01 3.30193710E-02 1.000000000E-03 5.19754458E-02 + 1.15671076E-01 3.30488790E-02 1.000000000E-03 5.19752573E-02 + 1.15774354E-01 3.30783869E-02 1.000000000E-03 5.19745461E-02 + 1.15877632E-01 3.31078948E-02 1.000000000E-03 5.19757581E-02 + 1.15980910E-01 3.31374027E-02 1.000000000E-03 5.19752023E-02 + 1.16084187E-01 3.31669107E-02 1.000000000E-03 5.19753623E-02 + 1.16187465E-01 3.31964186E-02 1.000000000E-03 5.19750178E-02 + 1.16290743E-01 3.32259265E-02 1.000000000E-03 5.19753481E-02 + 1.16394021E-01 3.32554344E-02 1.000000000E-03 5.19752000E-02 + 1.16497298E-01 3.32849424E-02 1.000000000E-03 5.19745788E-02 + 1.16600576E-01 3.33144503E-02 1.000000000E-03 5.19746565E-02 + 1.16703854E-01 3.33439582E-02 1.000000000E-03 5.19754092E-02 + 1.16807132E-01 3.33734662E-02 1.000000000E-03 5.19756990E-02 + 1.16910409E-01 3.34029741E-02 1.000000000E-03 5.19755309E-02 + 1.17013687E-01 3.34324820E-02 1.000000000E-03 5.19749318E-02 + 1.17116965E-01 3.34619899E-02 1.000000000E-03 5.19750361E-02 + 1.17220243E-01 3.34914979E-02 1.000000000E-03 5.19747104E-02 + 1.17323520E-01 3.35210058E-02 1.000000000E-03 5.19750702E-02 + 1.17426798E-01 3.35505137E-02 1.000000000E-03 5.19750223E-02 + 1.17530076E-01 3.35800217E-02 1.000000000E-03 5.19756319E-02 + 1.17633354E-01 3.36095296E-02 1.000000000E-03 5.19747928E-02 + 1.17736631E-01 3.36390375E-02 1.000000000E-03 5.19746430E-02 + 1.17839909E-01 3.36685454E-02 1.000000000E-03 5.19751700E-02 + 1.17943187E-01 3.36980534E-02 1.000000000E-03 5.19753145E-02 + 1.18046464E-01 3.37275613E-02 1.000000000E-03 5.19751005E-02 + 1.18149742E-01 3.37570692E-02 1.000000000E-03 5.19755607E-02 + 1.18253020E-01 3.37865771E-02 1.000000000E-03 5.19756520E-02 + 1.18356298E-01 3.38160851E-02 1.000000000E-03 5.19754270E-02 + 1.18459575E-01 3.38455930E-02 1.000000000E-03 5.19748688E-02 + 1.18562853E-01 3.38751009E-02 1.000000000E-03 5.19749664E-02 + 1.18666131E-01 3.39046089E-02 1.000000000E-03 5.19747588E-02 + 1.18769409E-01 3.39341168E-02 1.000000000E-03 5.19752279E-02 + 1.18872686E-01 3.39636247E-02 1.000000000E-03 5.19753804E-02 + 1.18975964E-01 3.39931326E-02 1.000000000E-03 5.19752283E-02 + 1.19079242E-01 3.40226406E-02 1.000000000E-03 5.19747926E-02 + 1.19182520E-01 3.40521485E-02 1.000000000E-03 5.19750232E-02 + 1.19285797E-01 3.40816564E-02 1.000000000E-03 5.19749771E-02 + 1.19389075E-01 3.41111643E-02 1.000000000E-03 5.19755798E-02 + 1.19492353E-01 3.41406723E-02 1.000000000E-03 5.19749968E-02 + 1.19595631E-01 3.41701802E-02 1.000000000E-03 5.19750779E-02 + 1.19698908E-01 3.41996881E-02 1.000000000E-03 5.19749016E-02 + 1.19802186E-01 3.42291961E-02 1.000000000E-03 5.19753806E-02 + 1.19905464E-01 3.42587040E-02 1.000000000E-03 5.19747220E-02 + 1.20008742E-01 3.42882119E-02 1.000000000E-03 5.19747415E-02 + 1.20112019E-01 3.43177198E-02 1.000000000E-03 5.19753926E-02 + 1.20215297E-01 3.43472278E-02 1.000000000E-03 5.19749601E-02 + 1.20318575E-01 3.43767357E-02 1.000000000E-03 5.19751646E-02 + 1.20421853E-01 3.44062436E-02 1.000000000E-03 5.19751525E-02 + 1.20525130E-01 3.44357516E-02 1.000000000E-03 5.19749578E-02 + 1.20628408E-01 3.44652595E-02 1.000000000E-03 5.19754016E-02 + 1.20731686E-01 3.44947674E-02 1.000000000E-03 5.19748202E-02 + 1.20834964E-01 3.45242753E-02 1.000000000E-03 5.19748734E-02 + 1.20938241E-01 3.45537833E-02 1.000000000E-03 5.19747651E-02 + 1.21041519E-01 3.45832912E-02 1.000000000E-03 5.19752818E-02 + 1.21144797E-01 3.46127991E-02 1.000000000E-03 5.19748287E-02 + 1.21248075E-01 3.46423070E-02 1.000000000E-03 5.19750120E-02 + 1.21351352E-01 3.46718150E-02 1.000000000E-03 5.19750298E-02 + 1.21454630E-01 3.47013229E-02 1.000000000E-03 5.19748976E-02 + 1.21557908E-01 3.47308308E-02 1.000000000E-03 5.19754090E-02 + 1.21661186E-01 3.47603388E-02 1.000000000E-03 5.19749934E-02 + 1.21764463E-01 3.47898467E-02 1.000000000E-03 5.19752086E-02 + 1.21867741E-01 3.48193546E-02 1.000000000E-03 5.19752839E-02 + 1.21971019E-01 3.48488625E-02 1.000000000E-03 5.19752413E-02 + 1.22074297E-01 3.48783705E-02 1.000000000E-03 5.19750804E-02 + 1.22177574E-01 3.49078784E-02 1.000000000E-03 5.19748008E-02 + 1.22280852E-01 3.49373863E-02 1.000000000E-03 5.19751446E-02 + 1.22384130E-01 3.49668943E-02 1.000000000E-03 5.19753786E-02 + 1.22487408E-01 3.49964022E-02 1.000000000E-03 5.19755164E-02 + 1.22590685E-01 3.50259101E-02 1.000000000E-03 5.19748248E-02 + 1.22693963E-01 3.50554180E-02 1.000000000E-03 5.19754787E-02 + 1.22797241E-01 3.50849260E-02 1.000000000E-03 5.19753300E-02 + 1.22900519E-01 3.51144339E-02 1.000000000E-03 5.19750956E-02 + 1.23003796E-01 3.51439418E-02 1.000000000E-03 5.19754909E-02 + 1.23107074E-01 3.51734497E-02 1.000000000E-03 5.19751111E-02 + 1.23210352E-01 3.52029577E-02 1.000000000E-03 5.19753408E-02 + 1.23313630E-01 3.52324656E-02 1.000000000E-03 5.19748313E-02 + 1.23416907E-01 3.52619735E-02 1.000000000E-03 5.19749447E-02 + 1.23520185E-01 3.52914815E-02 1.000000000E-03 5.19749954E-02 + 1.23623463E-01 3.53209894E-02 1.000000000E-03 5.19750014E-02 + 1.23726741E-01 3.53504973E-02 1.000000000E-03 5.19749485E-02 + 1.23830018E-01 3.53800052E-02 1.000000000E-03 5.19748610E-02 + 1.23933296E-01 3.54095132E-02 1.000000000E-03 5.19753783E-02 + 1.24036574E-01 3.54390211E-02 1.000000000E-03 5.19752051E-02 + 1.24139852E-01 3.54685290E-02 1.000000000E-03 5.19750051E-02 + 1.24243129E-01 3.54980370E-02 1.000000000E-03 5.19754150E-02 + 1.24346407E-01 3.55275449E-02 1.000000000E-03 5.19751634E-02 + 1.24449685E-01 3.55570528E-02 1.000000000E-03 5.19749042E-02 + 1.24552963E-01 3.55865607E-02 1.000000000E-03 5.19752467E-02 + 1.24656240E-01 3.56160687E-02 1.000000000E-03 5.19749492E-02 + 1.24759518E-01 3.56455766E-02 1.000000000E-03 5.19752641E-02 + 1.24862796E-01 3.56750845E-02 1.000000000E-03 5.19749686E-02 + 1.24966074E-01 3.57045924E-02 1.000000000E-03 5.19752658E-02 + 1.25069351E-01 3.57341004E-02 1.000000000E-03 5.19749754E-02 + 1.25172629E-01 3.57636083E-02 1.000000000E-03 5.19752817E-02 + 1.25275907E-01 3.57931162E-02 1.000000000E-03 5.19750052E-02 + 1.25379185E-01 3.58226242E-02 1.000000000E-03 5.19753403E-02 + 1.25482462E-01 3.58521321E-02 1.000000000E-03 5.19750973E-02 + 1.25585740E-01 3.58816400E-02 1.000000000E-03 5.19748754E-02 + 1.25689018E-01 3.59111479E-02 1.000000000E-03 5.19752666E-02 + 1.25792295E-01 3.59406559E-02 1.000000000E-03 5.19751029E-02 + 1.25895573E-01 3.59701638E-02 1.000000000E-03 5.19749750E-02 + 1.25998851E-01 3.59996717E-02 1.000000000E-03 5.19748911E-02 + 1.26102129E-01 3.60291797E-02 1.000000000E-03 5.19753868E-02 + 1.26205406E-01 3.60586876E-02 1.000000000E-03 5.19753733E-02 + 1.26308684E-01 3.60881955E-02 1.000000000E-03 5.19754064E-02 + 1.26411962E-01 3.61177034E-02 1.000000000E-03 5.19749470E-02 + 1.26515240E-01 3.61472114E-02 1.000000000E-03 5.19750747E-02 + 1.26618517E-01 3.61767193E-02 1.000000000E-03 5.19752565E-02 + 1.26721795E-01 3.62062272E-02 1.000000000E-03 5.19749757E-02 + 1.26825073E-01 3.62357351E-02 1.000000000E-03 5.19752715E-02 + 1.26928351E-01 3.62652431E-02 1.000000000E-03 5.19751119E-02 + 1.27031628E-01 3.62947510E-02 1.000000000E-03 5.19750182E-02 + 1.27134906E-01 3.63242589E-02 1.000000000E-03 5.19749973E-02 + 1.27238184E-01 3.63537669E-02 1.000000000E-03 5.19750461E-02 + 1.27341462E-01 3.63832748E-02 1.000000000E-03 5.19751715E-02 + 1.27444739E-01 3.64127827E-02 1.000000000E-03 5.19753800E-02 + 1.27548017E-01 3.64422906E-02 1.000000000E-03 5.19751660E-02 + 1.27651295E-01 3.64717986E-02 1.000000000E-03 5.19750316E-02 + 1.27754573E-01 3.65013065E-02 1.000000000E-03 5.19749975E-02 + 1.27857850E-01 3.65308144E-02 1.000000000E-03 5.19750507E-02 + 1.27961128E-01 3.65603224E-02 1.000000000E-03 5.19751973E-02 + 1.28064406E-01 3.65898303E-02 1.000000000E-03 5.19749553E-02 + 1.28167684E-01 3.66193382E-02 1.000000000E-03 5.19752918E-02 + 1.28270961E-01 3.66488461E-02 1.000000000E-03 5.19752541E-02 + 1.28374239E-01 3.66783541E-02 1.000000000E-03 5.19753173E-02 + 1.28477517E-01 3.67078620E-02 1.000000000E-03 5.19750229E-02 + 1.28580795E-01 3.67373699E-02 1.000000000E-03 5.19753040E-02 + 1.28684072E-01 3.67668778E-02 1.000000000E-03 5.19752362E-02 + 1.28787350E-01 3.67963858E-02 1.000000000E-03 5.19752848E-02 + 1.28890628E-01 3.68258937E-02 1.000000000E-03 5.19749956E-02 + 1.28993906E-01 3.68554016E-02 1.000000000E-03 5.19752782E-02 + 1.29097183E-01 3.68849096E-02 1.000000000E-03 5.19752313E-02 + 1.29200461E-01 3.69144175E-02 1.000000000E-03 5.19753146E-02 + 1.29303739E-01 3.69439254E-02 1.000000000E-03 5.19750787E-02 + 1.29407017E-01 3.69734333E-02 1.000000000E-03 5.19749848E-02 + 1.29510294E-01 3.70029413E-02 1.000000000E-03 5.19750163E-02 + 1.29613572E-01 3.70324492E-02 1.000000000E-03 5.19751903E-02 + 1.29716850E-01 3.70619571E-02 1.000000000E-03 5.19750665E-02 + 1.29820128E-01 3.70914651E-02 1.000000000E-03 5.19750879E-02 + 1.29923405E-01 3.71209730E-02 1.000000000E-03 5.19752463E-02 + 1.30026683E-01 3.71504809E-02 1.000000000E-03 5.19751277E-02 + 1.30129961E-01 3.71799888E-02 1.000000000E-03 5.19751608E-02 + 1.30233239E-01 3.72094968E-02 1.000000000E-03 5.19753376E-02 + 1.30336516E-01 3.72390047E-02 1.000000000E-03 5.19752568E-02 + 1.30439794E-01 3.72685126E-02 1.000000000E-03 5.19753335E-02 + 1.30543072E-01 3.72980205E-02 1.000000000E-03 5.19751567E-02 + 1.30646350E-01 3.73275285E-02 1.000000000E-03 5.19751431E-02 + 1.30749627E-01 3.73570364E-02 1.000000000E-03 5.19752883E-02 + 1.30852905E-01 3.73865443E-02 1.000000000E-03 5.19751981E-02 + 1.30956183E-01 3.74160523E-02 1.000000000E-03 5.19752720E-02 + 1.31059461E-01 3.74455602E-02 1.000000000E-03 5.19751252E-02 + 1.31162738E-01 3.74750681E-02 1.000000000E-03 5.19751510E-02 + 1.31266016E-01 3.75045760E-02 1.000000000E-03 5.19753377E-02 + 1.31369294E-01 3.75340840E-02 1.000000000E-03 5.19753201E-02 + 1.31472572E-01 3.75635919E-02 1.000000000E-03 5.19751059E-02 + 1.31575849E-01 3.75930998E-02 1.000000000E-03 5.19750585E-02 + 1.31679127E-01 3.76226078E-02 1.000000000E-03 5.19751988E-02 + 1.31782405E-01 3.76521157E-02 1.000000000E-03 5.19751398E-02 + 1.31885683E-01 3.76816236E-02 1.000000000E-03 5.19752687E-02 + 1.31988960E-01 3.77111315E-02 1.000000000E-03 5.19752147E-02 + 1.32092238E-01 3.77406395E-02 1.000000000E-03 5.19749883E-02 + 1.32195516E-01 3.77701474E-02 1.000000000E-03 5.19753082E-02 + 1.32298794E-01 3.77996553E-02 1.000000000E-03 5.19751007E-02 + 1.32402071E-01 3.78291632E-02 1.000000000E-03 5.19750886E-02 + 1.32505349E-01 3.78586712E-02 1.000000000E-03 5.19752673E-02 + 1.32608627E-01 3.78881791E-02 1.000000000E-03 5.19752853E-02 + 1.32711905E-01 3.79176870E-02 1.000000000E-03 5.19751623E-02 + 1.32815182E-01 3.79471950E-02 1.000000000E-03 5.19752368E-02 + 1.32918460E-01 3.79767029E-02 1.000000000E-03 5.19751681E-02 + 1.33021738E-01 3.80062108E-02 1.000000000E-03 5.19752993E-02 + 1.33125016E-01 3.80357187E-02 1.000000000E-03 5.19753010E-02 + 1.33228293E-01 3.80652267E-02 1.000000000E-03 5.19751760E-02 + 1.33331571E-01 3.80947346E-02 1.000000000E-03 5.19752501E-02 + 1.33434849E-01 3.81242425E-02 1.000000000E-03 5.19752138E-02 + 1.33538126E-01 3.81537505E-02 1.000000000E-03 5.19750569E-02 + 1.33641404E-01 3.81832584E-02 1.000000000E-03 5.19751106E-02 + 1.33744682E-01 3.82127663E-02 1.000000000E-03 5.19750595E-02 + 1.33847960E-01 3.82422742E-02 1.000000000E-03 5.19752173E-02 + 1.33951237E-01 3.82717822E-02 1.000000000E-03 5.19752733E-02 + 1.34054515E-01 3.83012901E-02 1.000000000E-03 5.19752356E-02 + 1.34157793E-01 3.83307980E-02 1.000000000E-03 5.19751002E-02 + 1.34261071E-01 3.83603059E-02 1.000000000E-03 5.19751899E-02 + 1.34364348E-01 3.83898139E-02 1.000000000E-03 5.19751935E-02 + 1.34467626E-01 3.84193218E-02 1.000000000E-03 5.19751127E-02 + 1.34570904E-01 3.84488297E-02 1.000000000E-03 5.19752545E-02 + 1.34674182E-01 3.84783377E-02 1.000000000E-03 5.19750260E-02 + 1.34777459E-01 3.85078456E-02 1.000000000E-03 5.19750219E-02 + 1.34880737E-01 3.85373535E-02 1.000000000E-03 5.19752462E-02 + 1.34984015E-01 3.85668614E-02 1.000000000E-03 5.19751101E-02 + 1.35087293E-01 3.85963694E-02 1.000000000E-03 5.19752095E-02 + 1.35190570E-01 3.86258773E-02 1.000000000E-03 5.19752477E-02 + 1.35293848E-01 3.86553852E-02 1.000000000E-03 5.19752316E-02 + 1.35397126E-01 3.86848932E-02 1.000000000E-03 5.19751654E-02 + 1.35500404E-01 3.87144011E-02 1.000000000E-03 5.19750558E-02 + 1.35603681E-01 3.87439090E-02 1.000000000E-03 5.19751766E-02 + 1.35706959E-01 3.87734169E-02 1.000000000E-03 5.19752577E-02 + 1.35810237E-01 3.88029249E-02 1.000000000E-03 5.19750287E-02 + 1.35913515E-01 3.88324328E-02 1.000000000E-03 5.19750408E-02 + 1.36016792E-01 3.88619407E-02 1.000000000E-03 5.19750216E-02 + 1.36120070E-01 3.88914486E-02 1.000000000E-03 5.19752376E-02 + 1.36223348E-01 3.89209566E-02 1.000000000E-03 5.19751670E-02 + 1.36326626E-01 3.89504645E-02 1.000000000E-03 5.19750754E-02 + 1.36429903E-01 3.89799724E-02 1.000000000E-03 5.19752261E-02 + 1.36533181E-01 3.90094804E-02 1.000000000E-03 5.19751005E-02 + 1.36636459E-01 3.90389883E-02 1.000000000E-03 5.19752200E-02 + 1.36739737E-01 3.90684962E-02 1.000000000E-03 5.19750758E-02 + 1.36843014E-01 3.90980041E-02 1.000000000E-03 5.19751790E-02 + 1.36946292E-01 3.91275121E-02 1.000000000E-03 5.19750232E-02 + 1.37049570E-01 3.91570200E-02 1.000000000E-03 5.19751196E-02 + 1.37152848E-01 3.91865279E-02 1.000000000E-03 5.19752184E-02 + 1.37256125E-01 3.92160359E-02 1.000000000E-03 5.19750721E-02 + 1.37359403E-01 3.92455438E-02 1.000000000E-03 5.19751784E-02 + 1.37462681E-01 3.92750517E-02 1.000000000E-03 5.19750533E-02 + 1.37565959E-01 3.93045596E-02 1.000000000E-03 5.19751849E-02 + 1.37669236E-01 3.93340676E-02 1.000000000E-03 5.19750865E-02 + 1.37772514E-01 3.93635755E-02 1.000000000E-03 5.19752487E-02 + 1.37875792E-01 3.93930834E-02 1.000000000E-03 5.19751915E-02 + 1.37979070E-01 3.94225913E-02 1.000000000E-03 5.19751603E-02 + 1.38082347E-01 3.94520993E-02 1.000000000E-03 5.19751552E-02 + 1.38185625E-01 3.94816072E-02 1.000000000E-03 5.19751805E-02 + 1.38288903E-01 3.95111151E-02 1.000000000E-03 5.19752316E-02 + 1.38392181E-01 3.95406231E-02 1.000000000E-03 5.19750904E-02 + 1.38495458E-01 3.95701310E-02 1.000000000E-03 5.19752123E-02 + 1.38598736E-01 3.95996389E-02 1.000000000E-03 5.19751490E-02 + 1.38702014E-01 3.96291468E-02 1.000000000E-03 5.19751250E-02 + 1.38805292E-01 3.96586548E-02 1.000000000E-03 5.19751466E-02 + 1.38908569E-01 3.96881627E-02 1.000000000E-03 5.19752132E-02 + 1.39011847E-01 3.97176706E-02 1.000000000E-03 5.19751092E-02 + 1.39115125E-01 3.97471786E-02 1.000000000E-03 5.19750568E-02 + 1.39218403E-01 3.97766865E-02 1.000000000E-03 5.19750598E-02 + 1.39321680E-01 3.98061944E-02 1.000000000E-03 5.19751154E-02 + 1.39424958E-01 3.98357023E-02 1.000000000E-03 5.19752273E-02 + 1.39528236E-01 3.98652103E-02 1.000000000E-03 5.19751870E-02 + 1.39631514E-01 3.98947182E-02 1.000000000E-03 5.19752088E-02 + 1.39734791E-01 3.99242261E-02 1.000000000E-03 5.19750912E-02 + 1.39838069E-01 3.99537341E-02 1.000000000E-03 5.19752449E-02 + 1.39941347E-01 3.99832420E-02 1.000000000E-03 5.19750542E-02 + 1.40044625E-01 4.00127499E-02 1.000000000E-03 5.19751413E-02 + 1.40147902E-01 4.00422578E-02 1.000000000E-03 5.19750984E-02 + 1.40251180E-01 4.00717658E-02 1.000000000E-03 5.19751308E-02 + 1.40354458E-01 4.01012737E-02 1.000000000E-03 5.19752394E-02 + 1.40457736E-01 4.01307816E-02 1.000000000E-03 5.19752282E-02 + 1.40561013E-01 4.01602895E-02 1.000000000E-03 5.19751022E-02 + 1.40664291E-01 4.01897975E-02 1.000000000E-03 5.19750609E-02 + 1.40767569E-01 4.02193054E-02 1.000000000E-03 5.19751051E-02 + 1.40870847E-01 4.02488133E-02 1.000000000E-03 5.19752337E-02 + 1.40974124E-01 4.02783213E-02 1.000000000E-03 5.19750725E-02 + 1.41077402E-01 4.03078292E-02 1.000000000E-03 5.19751916E-02 + 1.41180680E-01 4.03373371E-02 1.000000000E-03 5.19752141E-02 + 1.41283957E-01 4.03668450E-02 1.000000000E-03 5.19751446E-02 + 1.41387235E-01 4.03963530E-02 1.000000000E-03 5.19751728E-02 + 1.41490513E-01 4.04258609E-02 1.000000000E-03 5.19751170E-02 + 1.41593791E-01 4.04553688E-02 1.000000000E-03 5.19751606E-02 + 1.41697068E-01 4.04848768E-02 1.000000000E-03 5.19751264E-02 + 1.41800346E-01 4.05143847E-02 1.000000000E-03 5.19751932E-02 + 1.41903624E-01 4.05438926E-02 1.000000000E-03 5.19751879E-02 + 1.42006902E-01 4.05734005E-02 1.000000000E-03 5.19751111E-02 + 1.42110179E-01 4.06029085E-02 1.000000000E-03 5.19751483E-02 + 1.42213457E-01 4.06324164E-02 1.000000000E-03 5.19751193E-02 + 1.42316735E-01 4.06619243E-02 1.000000000E-03 5.19752021E-02 + 1.42420013E-01 4.06914323E-02 1.000000000E-03 5.19752275E-02 + 1.42523290E-01 4.07209402E-02 1.000000000E-03 5.19751974E-02 + 1.42626568E-01 4.07504481E-02 1.000000000E-03 5.19751154E-02 + 1.42729846E-01 4.07799560E-02 1.000000000E-03 5.19751528E-02 + 1.42833124E-01 4.08094640E-02 1.000000000E-03 5.19751447E-02 + 1.42936401E-01 4.08389719E-02 1.000000000E-03 5.19750914E-02 + 1.43039679E-01 4.08684798E-02 1.000000000E-03 5.19751636E-02 + 1.43142957E-01 4.08979877E-02 1.000000000E-03 5.19751965E-02 + 1.43246235E-01 4.09274957E-02 1.000000000E-03 5.19751936E-02 + 1.43349512E-01 4.09570036E-02 1.000000000E-03 5.19751578E-02 + 1.43452790E-01 4.09865115E-02 1.000000000E-03 5.19750924E-02 + 1.43556068E-01 4.10160195E-02 1.000000000E-03 5.19751606E-02 + 1.43659346E-01 4.10455274E-02 1.000000000E-03 5.19752016E-02 + 1.43762623E-01 4.10750353E-02 1.000000000E-03 5.19752197E-02 + 1.43865901E-01 4.11045432E-02 1.000000000E-03 5.19752194E-02 + 1.43969179E-01 4.11340512E-02 1.000000000E-03 5.19752006E-02 + 1.44072457E-01 4.11635591E-02 1.000000000E-03 5.19751674E-02 + 1.44175734E-01 4.11930670E-02 1.000000000E-03 5.19751212E-02 + 1.44279012E-01 4.12225750E-02 1.000000000E-03 5.19752218E-02 + 1.44382290E-01 4.12520829E-02 1.000000000E-03 5.19751593E-02 + 1.44485568E-01 4.12815908E-02 1.000000000E-03 5.19750930E-02 + 1.44588845E-01 4.13110987E-02 1.000000000E-03 5.19751751E-02 + 1.44692123E-01 4.13406067E-02 1.000000000E-03 5.19751047E-02 + 1.44795401E-01 4.13701146E-02 1.000000000E-03 5.19751885E-02 + 1.44898679E-01 4.13996225E-02 1.000000000E-03 5.19751294E-02 + 1.45001956E-01 4.14291305E-02 1.000000000E-03 5.19750771E-02 + 1.45105234E-01 4.14586384E-02 1.000000000E-03 5.19751812E-02 + 1.45208512E-01 4.14881463E-02 1.000000000E-03 5.19751507E-02 + 1.45311790E-01 4.15176542E-02 1.000000000E-03 5.19751334E-02 + 1.45415067E-01 4.15471622E-02 1.000000000E-03 5.19751343E-02 + 1.45518345E-01 4.15766701E-02 1.000000000E-03 5.19751511E-02 + 1.45621623E-01 4.16061780E-02 1.000000000E-03 5.19751873E-02 + 1.45724901E-01 4.16356859E-02 1.000000000E-03 5.19751112E-02 + 1.45828178E-01 4.16651939E-02 1.000000000E-03 5.19751969E-02 + 1.45931456E-01 4.16947018E-02 1.000000000E-03 5.19751718E-02 + 1.46034734E-01 4.17242097E-02 1.000000000E-03 5.19751766E-02 + 1.46138012E-01 4.17537177E-02 1.000000000E-03 5.19752132E-02 + 1.46241289E-01 4.17832256E-02 1.000000000E-03 5.19751461E-02 + 1.46344567E-01 4.18127335E-02 1.000000000E-03 5.19751172E-02 + 1.46447845E-01 4.18422414E-02 1.000000000E-03 5.19751255E-02 + 1.46551123E-01 4.18717494E-02 1.000000000E-03 5.19751750E-02 + 1.46654400E-01 4.19012573E-02 1.000000000E-03 5.19751325E-02 + 1.46757678E-01 4.19307652E-02 1.000000000E-03 5.19751347E-02 + 1.46860956E-01 4.19602732E-02 1.000000000E-03 5.19751831E-02 + 1.46964234E-01 4.19897811E-02 1.000000000E-03 5.19751494E-02 + 1.47067511E-01 4.20192890E-02 1.000000000E-03 5.19751674E-02 + 1.47170789E-01 4.20487969E-02 1.000000000E-03 5.19751094E-02 + 1.47274067E-01 4.20783049E-02 1.000000000E-03 5.19751061E-02 + 1.47377345E-01 4.21078128E-02 1.000000000E-03 5.19751563E-02 + 1.47480622E-01 4.21373207E-02 1.000000000E-03 5.19751419E-02 + 1.47583900E-01 4.21668287E-02 1.000000000E-03 5.19751849E-02 + 1.47687178E-01 4.21963366E-02 1.000000000E-03 5.19751651E-02 + 1.47790456E-01 4.22258445E-02 1.000000000E-03 5.19752113E-02 + 1.47893733E-01 4.22553524E-02 1.000000000E-03 5.19751988E-02 + 1.47997011E-01 4.22848604E-02 1.000000000E-03 5.19751323E-02 + 1.48100289E-01 4.23143683E-02 1.000000000E-03 5.19751365E-02 + 1.48203567E-01 4.23438762E-02 1.000000000E-03 5.19750916E-02 + 1.48306844E-01 4.23733842E-02 1.000000000E-03 5.19751183E-02 + 1.48410122E-01 4.24028921E-02 1.000000000E-03 5.19751030E-02 + 1.48513400E-01 4.24324000E-02 1.000000000E-03 5.19751602E-02 + 1.48616678E-01 4.24619079E-02 1.000000000E-03 5.19751810E-02 + 1.48719955E-01 4.24914159E-02 1.000000000E-03 5.19751639E-02 + 1.48823233E-01 4.25209238E-02 1.000000000E-03 5.19751150E-02 + 1.48926511E-01 4.25504317E-02 1.000000000E-03 5.19751482E-02 + 1.49029789E-01 4.25799396E-02 1.000000000E-03 5.19751516E-02 + 1.49133066E-01 4.26094476E-02 1.000000000E-03 5.19751292E-02 + 1.49236344E-01 4.26389555E-02 1.000000000E-03 5.19751922E-02 + 1.49339622E-01 4.26684634E-02 1.000000000E-03 5.19751242E-02 + 1.49442899E-01 4.26979714E-02 1.000000000E-03 5.19751488E-02 + 1.49546177E-01 4.27274793E-02 1.000000000E-03 5.19751532E-02 + 1.49649455E-01 4.27569872E-02 1.000000000E-03 5.19751423E-02 + 1.49752733E-01 4.27864951E-02 1.000000000E-03 5.19751205E-02 + 1.49856010E-01 4.28160031E-02 1.000000000E-03 5.19751948E-02 + 1.49959288E-01 4.28455110E-02 1.000000000E-03 5.19751536E-02 + 1.50062566E-01 4.28750189E-02 1.000000000E-03 5.19751065E-02 + 1.50165844E-01 4.29045269E-02 1.000000000E-03 5.19751634E-02 + 1.50269121E-01 4.29340348E-02 1.000000000E-03 5.19751116E-02 + 1.50372399E-01 4.29635427E-02 1.000000000E-03 5.19751648E-02 + 1.50475677E-01 4.29930506E-02 1.000000000E-03 5.19751169E-02 + 1.50578955E-01 4.30225586E-02 1.000000000E-03 5.19751769E-02 + 1.50682232E-01 4.30520665E-02 1.000000000E-03 5.19751423E-02 + 1.50785510E-01 4.30815744E-02 1.000000000E-03 5.19751156E-02 + 1.50888788E-01 4.31110824E-02 1.000000000E-03 5.19751997E-02 + 1.50992066E-01 4.31405903E-02 1.000000000E-03 5.19751980E-02 + 1.51095343E-01 4.31700982E-02 1.000000000E-03 5.19751105E-02 + 1.51198621E-01 4.31996061E-02 1.000000000E-03 5.19751414E-02 + 1.51301899E-01 4.32291141E-02 1.000000000E-03 5.19751906E-02 + 1.51405177E-01 4.32586220E-02 1.000000000E-03 5.19751611E-02 + 1.51508454E-01 4.32881299E-02 1.000000000E-03 5.19751574E-02 + 1.51611732E-01 4.33176379E-02 1.000000000E-03 5.19751772E-02 + 1.51715010E-01 4.33471458E-02 1.000000000E-03 5.19751284E-02 + 1.51818288E-01 4.33766537E-02 1.000000000E-03 5.19751084E-02 + 1.51921565E-01 4.34061616E-02 1.000000000E-03 5.19751198E-02 + 1.52024843E-01 4.34356696E-02 1.000000000E-03 5.19751639E-02 + 1.52128121E-01 4.34651775E-02 1.000000000E-03 5.19751481E-02 + 1.52231399E-01 4.34946854E-02 1.000000000E-03 5.19751682E-02 + 1.52334676E-01 4.35241934E-02 1.000000000E-03 5.19751362E-02 + 1.52437954E-01 4.35537013E-02 1.000000000E-03 5.19751430E-02 + 1.52541232E-01 4.35832092E-02 1.000000000E-03 5.19751927E-02 + 1.52644510E-01 4.36127171E-02 1.000000000E-03 5.19751926E-02 + 1.52747787E-01 4.36422251E-02 1.000000000E-03 5.19751491E-02 + 1.52851065E-01 4.36717330E-02 1.000000000E-03 5.19751535E-02 + 1.52954343E-01 4.37012409E-02 1.000000000E-03 5.19751190E-02 + 1.53057621E-01 4.37307489E-02 1.000000000E-03 5.19751341E-02 + 1.53160898E-01 4.37602568E-02 1.000000000E-03 5.19751138E-02 + 1.53264176E-01 4.37897647E-02 1.000000000E-03 5.19751480E-02 + 1.53367454E-01 4.38192726E-02 1.000000000E-03 5.19751510E-02 + 1.53470732E-01 4.38487806E-02 1.000000000E-03 5.19751265E-02 + 1.53574009E-01 4.38782885E-02 1.000000000E-03 5.19751589E-02 + 1.53677287E-01 4.39077964E-02 1.000000000E-03 5.19751676E-02 + 1.53780565E-01 4.39373044E-02 1.000000000E-03 5.19751543E-02 + 1.53883843E-01 4.39668123E-02 1.000000000E-03 5.19751214E-02 + 1.53987120E-01 4.39963202E-02 1.000000000E-03 5.19751551E-02 + 1.54090398E-01 4.40258281E-02 1.000000000E-03 5.19751713E-02 + 1.54193676E-01 4.40553361E-02 1.000000000E-03 5.19751745E-02 + 1.54296954E-01 4.40848440E-02 1.000000000E-03 5.19751663E-02 + 1.54400231E-01 4.41143519E-02 1.000000000E-03 5.19751480E-02 + 1.54503509E-01 4.41438599E-02 1.000000000E-03 5.19751226E-02 + 1.54606787E-01 4.41733678E-02 1.000000000E-03 5.19751721E-02 + 1.54710065E-01 4.42028757E-02 1.000000000E-03 5.19751390E-02 + 1.54813342E-01 4.42323836E-02 1.000000000E-03 5.19751831E-02 + 1.54916620E-01 4.42618916E-02 1.000000000E-03 5.19751487E-02 + 1.55019898E-01 4.42913995E-02 1.000000000E-03 5.19751180E-02 + 1.55123176E-01 4.43209074E-02 1.000000000E-03 5.19751689E-02 + 1.55226453E-01 4.43504153E-02 1.000000000E-03 5.19751485E-02 + 1.55329731E-01 4.43799233E-02 1.000000000E-03 5.19751374E-02 + 1.55433009E-01 4.44094312E-02 1.000000000E-03 5.19751365E-02 + 1.55536287E-01 4.44389391E-02 1.000000000E-03 5.19751477E-02 + 1.55639564E-01 4.44684471E-02 1.000000000E-03 5.19751718E-02 + 1.55742842E-01 4.44979550E-02 1.000000000E-03 5.19751366E-02 + 1.55846120E-01 4.45274629E-02 1.000000000E-03 5.19751209E-02 + 1.55949398E-01 4.45569708E-02 1.000000000E-03 5.19751246E-02 + 1.56052675E-01 4.45864788E-02 1.000000000E-03 5.19751486E-02 + 1.56155953E-01 4.46159867E-02 1.000000000E-03 5.19751225E-02 + 1.56259231E-01 4.46454946E-02 1.000000000E-03 5.19751213E-02 + 1.56362509E-01 4.46750026E-02 1.000000000E-03 5.19751478E-02 + 1.56465786E-01 4.47045105E-02 1.000000000E-03 5.19751300E-02 + 1.56569064E-01 4.47340184E-02 1.000000000E-03 5.19751429E-02 + 1.56672342E-01 4.47635263E-02 1.000000000E-03 5.19751160E-02 + 1.56775620E-01 4.47930343E-02 1.000000000E-03 5.19751239E-02 + 1.56878897E-01 4.48225422E-02 1.000000000E-03 5.19751659E-02 + 1.56982175E-01 4.48520501E-02 1.000000000E-03 5.19751754E-02 + 1.57085453E-01 4.48815581E-02 1.000000000E-03 5.19751541E-02 + 1.57188730E-01 4.49110660E-02 1.000000000E-03 5.19751722E-02 + 1.57292008E-01 4.49405739E-02 1.000000000E-03 5.19751656E-02 + 1.57395286E-01 4.49700818E-02 1.000000000E-03 5.19751345E-02 + 1.57498564E-01 4.49995898E-02 1.000000000E-03 5.19751471E-02 + 1.57601841E-01 4.50290977E-02 1.000000000E-03 5.19751404E-02 + 1.57705119E-01 4.50586056E-02 1.000000000E-03 5.19751821E-02 + 1.57808397E-01 4.50881136E-02 1.000000000E-03 5.19751403E-02 + 1.57911675E-01 4.51176215E-02 1.000000000E-03 5.19751505E-02 + 1.58014952E-01 4.51471294E-02 1.000000000E-03 5.19751491E-02 + 1.58118230E-01 4.51766373E-02 1.000000000E-03 5.19751369E-02 + 1.58221508E-01 4.52061453E-02 1.000000000E-03 5.19751796E-02 + 1.58324786E-01 4.52356532E-02 1.000000000E-03 5.19751516E-02 + 1.58428063E-01 4.52651611E-02 1.000000000E-03 5.19751829E-02 + 1.58531341E-01 4.52946691E-02 1.000000000E-03 5.19751481E-02 + 1.58634619E-01 4.53241770E-02 1.000000000E-03 5.19751743E-02 + 1.58737897E-01 4.53536849E-02 1.000000000E-03 5.19751396E-02 + 1.58841174E-01 4.53831928E-02 1.000000000E-03 5.19751699E-02 + 1.58944452E-01 4.54127008E-02 1.000000000E-03 5.19751424E-02 + 1.59047730E-01 4.54422087E-02 1.000000000E-03 5.19751210E-02 + 1.59151008E-01 4.54717166E-02 1.000000000E-03 5.19751687E-02 + 1.59254285E-01 4.55012246E-02 1.000000000E-03 5.19751653E-02 + 1.59357563E-01 4.55307325E-02 1.000000000E-03 5.19751729E-02 + 1.59460841E-01 4.55602404E-02 1.000000000E-03 5.19751354E-02 + 1.59564119E-01 4.55897484E-02 1.000000000E-03 5.19751702E-02 + 1.59667396E-01 4.56192563E-02 1.000000000E-03 5.19751642E-02 + 1.59770674E-01 4.56487642E-02 1.000000000E-03 5.19751755E-02 + 1.59873952E-01 4.56782721E-02 1.000000000E-03 5.19751490E-02 + 1.59977230E-01 4.57077801E-02 1.000000000E-03 5.19751446E-02 + 1.60080507E-01 4.57372880E-02 1.000000000E-03 5.19751631E-02 + 1.60183785E-01 4.57667959E-02 1.000000000E-03 5.19751485E-02 + 1.60287063E-01 4.57963039E-02 1.000000000E-03 5.19751619E-02 + 1.60390341E-01 4.58258118E-02 1.000000000E-03 5.19751462E-02 + 1.60493618E-01 4.58553197E-02 1.000000000E-03 5.19751594E-02 + 1.60596896E-01 4.58848276E-02 1.000000000E-03 5.19751496E-02 + 1.60700174E-01 4.59143356E-02 1.000000000E-03 5.19751717E-02 + 1.60803452E-01 4.59438435E-02 1.000000000E-03 5.19751735E-02 + 1.60906729E-01 4.59733514E-02 1.000000000E-03 5.19751564E-02 + 1.61010007E-01 4.60028594E-02 1.000000000E-03 5.19751765E-02 + 1.61113285E-01 4.60323673E-02 1.000000000E-03 5.19751282E-02 + 1.61216563E-01 4.60618752E-02 1.000000000E-03 5.19751737E-02 + 1.61319840E-01 4.60913831E-02 1.000000000E-03 5.19751543E-02 + 1.61423118E-01 4.61208911E-02 1.000000000E-03 5.19751254E-02 + 1.61526396E-01 4.61503990E-02 1.000000000E-03 5.19751418E-02 + 1.61629674E-01 4.61799069E-02 1.000000000E-03 5.19751523E-02 + 1.61732951E-01 4.62094149E-02 1.000000000E-03 5.19751578E-02 + 1.61836229E-01 4.62389228E-02 1.000000000E-03 5.19751607E-02 + 1.61939507E-01 4.62684307E-02 1.000000000E-03 5.19751626E-02 + 1.62042785E-01 4.62979386E-02 1.000000000E-03 5.19751662E-02 + 1.62146062E-01 4.63274466E-02 1.000000000E-03 5.19751714E-02 + 1.62249340E-01 4.63569545E-02 1.000000000E-03 5.19751315E-02 + 1.62352618E-01 4.63864624E-02 1.000000000E-03 5.19751468E-02 + 1.62455896E-01 4.64159704E-02 1.000000000E-03 5.19751698E-02 + 1.62559173E-01 4.64454783E-02 1.000000000E-03 5.19751531E-02 + 1.62662451E-01 4.64749862E-02 1.000000000E-03 5.19751473E-02 + 1.62765729E-01 4.65044941E-02 1.000000000E-03 5.19751540E-02 + 1.62869007E-01 4.65340021E-02 1.000000000E-03 5.19751741E-02 + 1.62972284E-01 4.65635100E-02 1.000000000E-03 5.19751621E-02 + 1.63075562E-01 4.65930179E-02 1.000000000E-03 5.19751678E-02 + 1.63178840E-01 4.66225259E-02 1.000000000E-03 5.19751438E-02 + 1.63282118E-01 4.66520338E-02 1.000000000E-03 5.19751409E-02 + 1.63385395E-01 4.66815417E-02 1.000000000E-03 5.19751603E-02 + 1.63488673E-01 4.67110496E-02 1.000000000E-03 5.19751553E-02 + 1.63591951E-01 4.67405576E-02 1.000000000E-03 5.19751299E-02 + 1.63695229E-01 4.67700655E-02 1.000000000E-03 5.19751302E-02 + 1.63798506E-01 4.67995734E-02 1.000000000E-03 5.19751594E-02 + 1.63901784E-01 4.68290814E-02 1.000000000E-03 5.19751716E-02 + 1.64005062E-01 4.68585893E-02 1.000000000E-03 5.19751692E-02 + 1.64108340E-01 4.68880972E-02 1.000000000E-03 5.19751538E-02 + 1.64211617E-01 4.69176052E-02 1.000000000E-03 5.19751728E-02 + 1.64314895E-01 4.69471131E-02 1.000000000E-03 5.19751374E-02 + 1.64418173E-01 4.69766210E-02 1.000000000E-03 5.19751394E-02 + 1.64521451E-01 4.70061289E-02 1.000000000E-03 5.19751347E-02 + 1.64624728E-01 4.70356369E-02 1.000000000E-03 5.19751704E-02 + 1.64728006E-01 4.70651448E-02 1.000000000E-03 5.19751592E-02 + 1.64831284E-01 4.70946527E-02 1.000000000E-03 5.19751468E-02 + 1.64934561E-01 4.71241607E-02 1.000000000E-03 5.19751356E-02 + 1.65037839E-01 4.71536686E-02 1.000000000E-03 5.19751690E-02 + 1.65141117E-01 4.71831765E-02 1.000000000E-03 5.19751632E-02 + 1.65244395E-01 4.72126844E-02 1.000000000E-03 5.19751641E-02 + 1.65347672E-01 4.72421924E-02 1.000000000E-03 5.19751709E-02 + 1.65450950E-01 4.72717003E-02 1.000000000E-03 5.19751446E-02 + 1.65554228E-01 4.73012082E-02 1.000000000E-03 5.19751701E-02 + 1.65657506E-01 4.73307162E-02 1.000000000E-03 5.19751658E-02 + 1.65760783E-01 4.73602241E-02 1.000000000E-03 5.19751332E-02 + 1.65864061E-01 4.73897320E-02 1.000000000E-03 5.19751571E-02 + 1.65967339E-01 4.74192399E-02 1.000000000E-03 5.19751562E-02 + 1.66070617E-01 4.74487479E-02 1.000000000E-03 5.19751320E-02 + 1.66173894E-01 4.74782558E-02 1.000000000E-03 5.19751680E-02 + 1.66277172E-01 4.75077637E-02 1.000000000E-03 5.19751442E-02 + 1.66380450E-01 4.75372717E-02 1.000000000E-03 5.19751431E-02 + 1.66483728E-01 4.75667796E-02 1.000000000E-03 5.19751651E-02 + 1.66587005E-01 4.75962875E-02 1.000000000E-03 5.19751328E-02 + 1.66690283E-01 4.76257955E-02 1.000000000E-03 5.19751668E-02 + 1.66793561E-01 4.76553034E-02 1.000000000E-03 5.19751512E-02 + 1.66896839E-01 4.76848113E-02 1.000000000E-03 5.19751641E-02 + 1.67000116E-01 4.77143192E-02 1.000000000E-03 5.19751695E-02 + 1.67103394E-01 4.77438272E-02 1.000000000E-03 5.19751689E-02 + 1.67206672E-01 4.77733351E-02 1.000000000E-03 5.19751637E-02 + 1.67309950E-01 4.78028430E-02 1.000000000E-03 5.19751554E-02 + 1.67413227E-01 4.78323510E-02 1.000000000E-03 5.19751464E-02 + 1.67516505E-01 4.78618589E-02 1.000000000E-03 5.19751368E-02 + 1.67619783E-01 4.78913668E-02 1.000000000E-03 5.19751664E-02 + 1.67723061E-01 4.79208747E-02 1.000000000E-03 5.19751626E-02 + 1.67826338E-01 4.79503827E-02 1.000000000E-03 5.19751631E-02 + 1.67929616E-01 4.79798906E-02 1.000000000E-03 5.19751339E-02 + 1.68032894E-01 4.80093985E-02 1.000000000E-03 5.19751482E-02 + 1.68136172E-01 4.80389065E-02 1.000000000E-03 5.19751365E-02 + 1.68239449E-01 4.80684144E-02 1.000000000E-03 5.19751354E-02 + 1.68342727E-01 4.80979223E-02 1.000000000E-03 5.19751464E-02 + 1.68446005E-01 4.81274302E-02 1.000000000E-03 5.19751360E-02 + 1.68549283E-01 4.81569382E-02 1.000000000E-03 5.19751400E-02 + 1.68652560E-01 4.81864461E-02 1.000000000E-03 5.19751606E-02 + 1.68755838E-01 4.82159540E-02 1.000000000E-03 5.19751649E-02 + 1.68859116E-01 4.82454620E-02 1.000000000E-03 5.19751533E-02 + 1.68962394E-01 4.82749699E-02 1.000000000E-03 5.19751628E-02 + 1.69065671E-01 4.83044778E-02 1.000000000E-03 5.19751602E-02 + 1.69168949E-01 4.83339858E-02 1.000000000E-03 5.19751473E-02 + 1.69272227E-01 4.83634937E-02 1.000000000E-03 5.19751602E-02 + 1.69375505E-01 4.83930016E-02 1.000000000E-03 5.19751640E-02 + 1.69478782E-01 4.84225095E-02 1.000000000E-03 5.19751633E-02 + 1.69582060E-01 4.84520175E-02 1.000000000E-03 5.19751578E-02 + 1.69685338E-01 4.84815254E-02 1.000000000E-03 5.19751499E-02 + 1.69788616E-01 4.85110333E-02 1.000000000E-03 5.19751409E-02 + 1.69891893E-01 4.85405413E-02 1.000000000E-03 5.19751643E-02 + 1.69995171E-01 4.85700492E-02 1.000000000E-03 5.19751576E-02 + 1.70098449E-01 4.85995571E-02 1.000000000E-03 5.19751540E-02 + 1.70201727E-01 4.86290651E-02 1.000000000E-03 5.19751547E-02 + 1.70305004E-01 4.86585730E-02 1.000000000E-03 5.19751615E-02 + 1.70408282E-01 4.86880809E-02 1.000000000E-03 5.19751443E-02 + 1.70511560E-01 4.87175888E-02 1.000000000E-03 5.19751366E-02 + 1.70614838E-01 4.87470968E-02 1.000000000E-03 5.19751387E-02 + 1.70718115E-01 4.87766047E-02 1.000000000E-03 5.19751529E-02 + 1.70821393E-01 4.88061126E-02 1.000000000E-03 5.19751497E-02 + 1.70924671E-01 4.88356206E-02 1.000000000E-03 5.19751604E-02 + 1.71027949E-01 4.88651285E-02 1.000000000E-03 5.19751569E-02 + 1.71131226E-01 4.88946364E-02 1.000000000E-03 5.19751401E-02 + 1.71234504E-01 4.89241443E-02 1.000000000E-03 5.19751419E-02 + 1.71337782E-01 4.89536523E-02 1.000000000E-03 5.19751644E-02 + 1.71441060E-01 4.89831602E-02 1.000000000E-03 5.19751478E-02 + 1.71544337E-01 4.90126681E-02 1.000000000E-03 5.19751536E-02 + 1.71647615E-01 4.90421761E-02 1.000000000E-03 5.19751542E-02 + 1.71750893E-01 4.90716840E-02 1.000000000E-03 5.19751505E-02 + 1.71854171E-01 4.91011919E-02 1.000000000E-03 5.19751443E-02 + 1.71957448E-01 4.91306999E-02 1.000000000E-03 5.19751660E-02 + 1.72060726E-01 4.91602078E-02 1.000000000E-03 5.19751587E-02 + 1.72164004E-01 4.91897157E-02 1.000000000E-03 5.19751533E-02 + 1.72267282E-01 4.92192236E-02 1.000000000E-03 5.19751512E-02 + 1.72370559E-01 4.92487316E-02 1.000000000E-03 5.19751531E-02 + 1.72473837E-01 4.92782395E-02 1.000000000E-03 5.19751612E-02 + 1.72577115E-01 4.93077474E-02 1.000000000E-03 5.19751486E-02 + 1.72680392E-01 4.93372554E-02 1.000000000E-03 5.19751444E-02 + 1.72783670E-01 4.93667633E-02 1.000000000E-03 5.19751503E-02 + 1.72886948E-01 4.93962712E-02 1.000000000E-03 5.19751398E-02 + 1.72990226E-01 4.94257792E-02 1.000000000E-03 5.19751422E-02 + 1.73093503E-01 4.94552871E-02 1.000000000E-03 5.19751582E-02 + 1.73196781E-01 4.94847950E-02 1.000000000E-03 5.19751626E-02 + 1.73300059E-01 4.95143029E-02 1.000000000E-03 5.19751567E-02 + 1.73403337E-01 4.95438109E-02 1.000000000E-03 5.19751419E-02 + 1.73506614E-01 4.95733188E-02 1.000000000E-03 5.19751466E-02 + 1.73609892E-01 4.96028267E-02 1.000000000E-03 5.19751449E-02 + 1.73713170E-01 4.96323347E-02 1.000000000E-03 5.19751394E-02 + 1.73816448E-01 4.96618426E-02 1.000000000E-03 5.19751563E-02 + 1.73919725E-01 4.96913505E-02 1.000000000E-03 5.19751450E-02 + 1.74023003E-01 4.97208585E-02 1.000000000E-03 5.19751597E-02 + 1.74126281E-01 4.97503664E-02 1.000000000E-03 5.19751499E-02 + 1.74229559E-01 4.97798743E-02 1.000000000E-03 5.19751417E-02 + 1.74332836E-01 4.98093822E-02 1.000000000E-03 5.19751633E-02 + 1.74436114E-01 4.98388902E-02 1.000000000E-03 5.19751646E-02 + 1.74539392E-01 4.98683981E-02 1.000000000E-03 5.19751472E-02 + 1.74642670E-01 4.98979060E-02 1.000000000E-03 5.19751623E-02 + 1.74745947E-01 4.99274140E-02 1.000000000E-03 5.19751617E-02 + 1.74849225E-01 4.99569219E-02 1.000000000E-03 5.19751466E-02 + 1.74952503E-01 4.99864298E-02 1.000000000E-03 5.19751436E-02 + 1.75055781E-01 5.00159378E-02 1.000000000E-03 5.19751532E-02 + 1.75159058E-01 5.00454457E-02 1.000000000E-03 5.19751529E-02 + 1.75262336E-01 5.00749536E-02 1.000000000E-03 5.19751438E-02 + 1.75365614E-01 5.01044615E-02 1.000000000E-03 5.19751515E-02 + 1.75468892E-01 5.01339695E-02 1.000000000E-03 5.19751537E-02 + 1.75572169E-01 5.01634774E-02 1.000000000E-03 5.19751509E-02 + 1.75675447E-01 5.01929853E-02 1.000000000E-03 5.19751449E-02 + 1.75778725E-01 5.02224933E-02 1.000000000E-03 5.19751610E-02 + 1.75882003E-01 5.02520012E-02 1.000000000E-03 5.19751531E-02 + 1.75985280E-01 5.02815091E-02 1.000000000E-03 5.19751459E-02 + 1.76088558E-01 5.03110171E-02 1.000000000E-03 5.19751411E-02 + 1.76191836E-01 5.03405250E-02 1.000000000E-03 5.19751627E-02 + 1.76295114E-01 5.03700329E-02 1.000000000E-03 5.19751435E-02 + 1.76398391E-01 5.03995409E-02 1.000000000E-03 5.19751530E-02 + 1.76501669E-01 5.04290488E-02 1.000000000E-03 5.19751474E-02 + 1.76604947E-01 5.04585567E-02 1.000000000E-03 5.19751506E-02 + 1.76708225E-01 5.04880646E-02 1.000000000E-03 5.19751415E-02 + 1.76811502E-01 5.05175726E-02 1.000000000E-03 5.19751435E-02 + 1.76914780E-01 5.05470805E-02 1.000000000E-03 5.19751580E-02 + 1.77018058E-01 5.05765884E-02 1.000000000E-03 5.19751418E-02 + 1.77121336E-01 5.06060964E-02 1.000000000E-03 5.19751630E-02 + 1.77224613E-01 5.06356043E-02 1.000000000E-03 5.19751562E-02 + 1.77327891E-01 5.06651122E-02 1.000000000E-03 5.19751458E-02 + 1.77431169E-01 5.06946202E-02 1.000000000E-03 5.19751533E-02 + 1.77534447E-01 5.07241281E-02 1.000000000E-03 5.19751598E-02 + 1.77637724E-01 5.07536360E-02 1.000000000E-03 5.19751442E-02 + 1.77741002E-01 5.07831440E-02 1.000000000E-03 5.19751510E-02 + 1.77844280E-01 5.08126519E-02 1.000000000E-03 5.19751601E-02 + 1.77947558E-01 5.08421598E-02 1.000000000E-03 5.19751517E-02 + 1.78050835E-01 5.08716677E-02 1.000000000E-03 5.19751481E-02 + 1.78154113E-01 5.09011757E-02 1.000000000E-03 5.19751508E-02 + 1.78257391E-01 5.09306836E-02 1.000000000E-03 5.19751606E-02 + 1.78360669E-01 5.09601915E-02 1.000000000E-03 5.19751587E-02 + 1.78463946E-01 5.09896995E-02 1.000000000E-03 5.19751457E-02 + 1.78567224E-01 5.10192074E-02 1.000000000E-03 5.19751441E-02 + 1.78670502E-01 5.10487153E-02 1.000000000E-03 5.19751548E-02 + 1.78773780E-01 5.10782233E-02 1.000000000E-03 5.19751586E-02 + 1.78877057E-01 5.11077312E-02 1.000000000E-03 5.19751574E-02 + 1.78980335E-01 5.11372391E-02 1.000000000E-03 5.19751521E-02 + 1.79083613E-01 5.11667471E-02 1.000000000E-03 5.19751439E-02 + 1.79186891E-01 5.11962550E-02 1.000000000E-03 5.19751543E-02 + 1.79290168E-01 5.12257629E-02 1.000000000E-03 5.19751448E-02 + 1.79393446E-01 5.12552708E-02 1.000000000E-03 5.19751556E-02 + 1.79496724E-01 5.12847788E-02 1.000000000E-03 5.19751498E-02 + 1.79600002E-01 5.13142867E-02 1.000000000E-03 5.19751475E-02 + 1.79703279E-01 5.13437946E-02 1.000000000E-03 5.19751500E-02 + 1.79806557E-01 5.13733026E-02 1.000000000E-03 5.19751583E-02 + 1.79909835E-01 5.14028105E-02 1.000000000E-03 5.19751550E-02 + 1.80013113E-01 5.14323184E-02 1.000000000E-03 5.19751604E-02 + 1.80116390E-01 5.14618264E-02 1.000000000E-03 5.19751566E-02 + 1.80219668E-01 5.14913343E-02 1.000000000E-03 5.19751451E-02 + 1.80322946E-01 5.15208422E-02 1.000000000E-03 5.19751458E-02 + 1.80426223E-01 5.15503502E-02 1.000000000E-03 5.19751598E-02 + 1.80529501E-01 5.15798581E-02 1.000000000E-03 5.19751514E-02 + 1.80632779E-01 5.16093660E-02 1.000000000E-03 5.19751587E-02 + 1.80736057E-01 5.16388739E-02 1.000000000E-03 5.19751464E-02 + 1.80839334E-01 5.16683819E-02 1.000000000E-03 5.19751520E-02 + 1.80942612E-01 5.16978898E-02 1.000000000E-03 5.19751585E-02 + 1.81045890E-01 5.17273977E-02 1.000000000E-03 5.19751496E-02 + 1.81149168E-01 5.17569057E-02 1.000000000E-03 5.19751619E-02 + 1.81252445E-01 5.17864136E-02 1.000000000E-03 5.19751611E-02 + 1.81355723E-01 5.18159215E-02 1.000000000E-03 5.19751490E-02 + 1.81459001E-01 5.18454295E-02 1.000000000E-03 5.19751615E-02 + 1.81562279E-01 5.18749374E-02 1.000000000E-03 5.19751472E-02 + 1.81665556E-01 5.19044453E-02 1.000000000E-03 5.19751598E-02 + 1.81768834E-01 5.19339533E-02 1.000000000E-03 5.19751486E-02 + 1.81872112E-01 5.19634612E-02 1.000000000E-03 5.19751492E-02 + 1.81975390E-01 5.19929691E-02 1.000000000E-03 5.19751460E-02 + 1.82078667E-01 5.20224771E-02 1.000000000E-03 5.19751568E-02 + 1.82181945E-01 5.20519850E-02 1.000000000E-03 5.19751490E-02 + 1.82285223E-01 5.20814929E-02 1.000000000E-03 5.19751575E-02 + 1.82388501E-01 5.21110008E-02 1.000000000E-03 5.19751502E-02 + 1.82491778E-01 5.21405088E-02 1.000000000E-03 5.19751452E-02 + 1.82595056E-01 5.21700167E-02 1.000000000E-03 5.19751594E-02 + 1.82698334E-01 5.21995246E-02 1.000000000E-03 5.19751455E-02 + 1.82801612E-01 5.22290326E-02 1.000000000E-03 5.19751534E-02 + 1.82904889E-01 5.22585405E-02 1.000000000E-03 5.19751517E-02 + 1.83008167E-01 5.22880484E-02 1.000000000E-03 5.19751580E-02 + 1.83111445E-01 5.23175564E-02 1.000000000E-03 5.19751570E-02 + 1.83214723E-01 5.23470643E-02 1.000000000E-03 5.19751503E-02 + 1.83318000E-01 5.23765722E-02 1.000000000E-03 5.19751551E-02 + 1.83421278E-01 5.24060802E-02 1.000000000E-03 5.19751566E-02 + 1.83524556E-01 5.24355881E-02 1.000000000E-03 5.19751554E-02 + 1.83627834E-01 5.24650960E-02 1.000000000E-03 5.19751537E-02 + 1.83731111E-01 5.24946040E-02 1.000000000E-03 5.19751521E-02 + 1.83834389E-01 5.25241119E-02 1.000000000E-03 5.19751517E-02 + 1.83937667E-01 5.25536198E-02 1.000000000E-03 5.19751539E-02 + 1.84040945E-01 5.25831278E-02 1.000000000E-03 5.19751598E-02 + 1.84144222E-01 5.26126357E-02 1.000000000E-03 5.19751554E-02 + 1.84247500E-01 5.26421436E-02 1.000000000E-03 5.19751572E-02 + 1.84350778E-01 5.26716516E-02 1.000000000E-03 5.19751508E-02 + 1.84454056E-01 5.27011595E-02 1.000000000E-03 5.19751529E-02 + 1.84557333E-01 5.27306674E-02 1.000000000E-03 5.19751492E-02 + 1.84660611E-01 5.27601753E-02 1.000000000E-03 5.19751561E-02 + 1.84763889E-01 5.27896833E-02 1.000000000E-03 5.19751598E-02 + 1.84867167E-01 5.28191912E-02 1.000000000E-03 5.19751471E-02 + 1.84970444E-01 5.28486991E-02 1.000000000E-03 5.19751480E-02 + 1.85073722E-01 5.28782071E-02 1.000000000E-03 5.19751494E-02 + 1.85177000E-01 5.29077150E-02 1.000000000E-03 5.19751523E-02 + 1.85280278E-01 5.29372229E-02 1.000000000E-03 5.19751578E-02 + 1.85383555E-01 5.29667309E-02 1.000000000E-03 5.19751525E-02 + 1.85486833E-01 5.29962388E-02 1.000000000E-03 5.19751523E-02 + 1.85590111E-01 5.30257467E-02 1.000000000E-03 5.19751581E-02 + 1.85693389E-01 5.30552547E-02 1.000000000E-03 5.19751571E-02 + 1.85796666E-01 5.30847626E-02 1.000000000E-03 5.19751503E-02 + 1.85899944E-01 5.31142705E-02 1.000000000E-03 5.19751529E-02 + 1.86003222E-01 5.31437785E-02 1.000000000E-03 5.19751522E-02 + 1.86106500E-01 5.31732864E-02 1.000000000E-03 5.19751491E-02 + 1.86209777E-01 5.32027943E-02 1.000000000E-03 5.19751585E-02 + 1.86313055E-01 5.32323023E-02 1.000000000E-03 5.19751543E-02 + 1.86416333E-01 5.32618102E-02 1.000000000E-03 5.19751513E-02 + 1.86519611E-01 5.32913181E-02 1.000000000E-03 5.19751506E-02 + 1.86622888E-01 5.33208261E-02 1.000000000E-03 5.19751532E-02 + 1.86726166E-01 5.33503340E-02 1.000000000E-03 5.19751604E-02 + 1.86829444E-01 5.33798419E-02 1.000000000E-03 5.19751597E-02 + 1.86932722E-01 5.34093499E-02 1.000000000E-03 5.19751526E-02 + 1.87035999E-01 5.34388578E-02 1.000000000E-03 5.19751533E-02 + 1.87139277E-01 5.34683657E-02 1.000000000E-03 5.19751498E-02 + 1.87242555E-01 5.34978737E-02 1.000000000E-03 5.19751564E-02 + 1.87345833E-01 5.35273816E-02 1.000000000E-03 5.19751480E-02 + 1.87449110E-01 5.35568895E-02 1.000000000E-03 5.19751515E-02 + 1.87552388E-01 5.35863975E-02 1.000000000E-03 5.19751552E-02 + 1.87655666E-01 5.36159054E-02 1.000000000E-03 5.19751479E-02 + 1.87758944E-01 5.36454133E-02 1.000000000E-03 5.19751555E-02 + 1.87862221E-01 5.36749213E-02 1.000000000E-03 5.19751541E-02 + 1.87965499E-01 5.37044292E-02 1.000000000E-03 5.19751573E-02 + 1.88068777E-01 5.37339371E-02 1.000000000E-03 5.19751538E-02 + 1.88172055E-01 5.37634450E-02 1.000000000E-03 5.19751571E-02 + 1.88275332E-01 5.37929530E-02 1.000000000E-03 5.19751560E-02 + 1.88378610E-01 5.38224609E-02 1.000000000E-03 5.19751516E-02 + 1.88481888E-01 5.38519688E-02 1.000000000E-03 5.19751569E-02 + 1.88585165E-01 5.38814768E-02 1.000000000E-03 5.19751492E-02 + 1.88688443E-01 5.39109847E-02 1.000000000E-03 5.19751534E-02 + 1.88791721E-01 5.39404926E-02 1.000000000E-03 5.19751587E-02 + 1.88894999E-01 5.39700006E-02 1.000000000E-03 5.19751541E-02 + 1.88998276E-01 5.39995085E-02 1.000000000E-03 5.19751529E-02 + 1.89101554E-01 5.40290164E-02 1.000000000E-03 5.19751558E-02 + 1.89204832E-01 5.40585244E-02 1.000000000E-03 5.19751522E-02 + 1.89308110E-01 5.40880323E-02 1.000000000E-03 5.19751551E-02 + 1.89411387E-01 5.41175402E-02 1.000000000E-03 5.19751536E-02 + 1.89514665E-01 5.41470482E-02 1.000000000E-03 5.19751493E-02 + 1.89617943E-01 5.41765561E-02 1.000000000E-03 5.19751543E-02 + 1.89721221E-01 5.42060640E-02 1.000000000E-03 5.19751583E-02 + 1.89824498E-01 5.42355720E-02 1.000000000E-03 5.19751509E-02 + 1.89927776E-01 5.42650799E-02 1.000000000E-03 5.19751562E-02 + 1.90031054E-01 5.42945878E-02 1.000000000E-03 5.19751524E-02 + 1.90134332E-01 5.43240958E-02 1.000000000E-03 5.19751519E-02 + 1.90237609E-01 5.43536037E-02 1.000000000E-03 5.19751556E-02 + 1.90340887E-01 5.43831116E-02 1.000000000E-03 5.19751537E-02 + 1.90444165E-01 5.44126196E-02 1.000000000E-03 5.19751584E-02 + 1.90547443E-01 5.44421275E-02 1.000000000E-03 5.19751591E-02 + 1.90650720E-01 5.44716354E-02 1.000000000E-03 5.19751576E-02 + 1.90753998E-01 5.45011434E-02 1.000000000E-03 5.19751545E-02 + 1.90857276E-01 5.45306513E-02 1.000000000E-03 5.19751512E-02 + 1.90960554E-01 5.45601592E-02 1.000000000E-03 5.19751592E-02 + 1.91063831E-01 5.45896672E-02 1.000000000E-03 5.19751583E-02 + 1.91167109E-01 5.46191751E-02 1.000000000E-03 5.19751601E-02 + 1.91270387E-01 5.46486830E-02 1.000000000E-03 5.19751552E-02 + 1.91373665E-01 5.46781910E-02 1.000000000E-03 5.19751549E-02 + 1.91476942E-01 5.47076989E-02 1.000000000E-03 5.19751502E-02 + 1.91580220E-01 5.47372068E-02 1.000000000E-03 5.19751524E-02 + 1.91683498E-01 5.47667148E-02 1.000000000E-03 5.19751519E-02 + 1.91786776E-01 5.47962227E-02 1.000000000E-03 5.19751501E-02 + 1.91890053E-01 5.48257307E-02 1.000000000E-03 5.19751580E-02 + 1.91993331E-01 5.48552386E-02 1.000000000E-03 5.19751561E-02 + 1.92096609E-01 5.48847465E-02 1.000000000E-03 5.19751559E-02 + 1.92199887E-01 5.49142545E-02 1.000000000E-03 5.19751585E-02 + 1.92303164E-01 5.49437624E-02 1.000000000E-03 5.19751545E-02 + 1.92406442E-01 5.49732703E-02 1.000000000E-03 5.19751553E-02 + 1.92509720E-01 5.50027783E-02 1.000000000E-03 5.19751517E-02 + 1.92612998E-01 5.50322862E-02 1.000000000E-03 5.19751547E-02 + 1.92716275E-01 5.50617941E-02 1.000000000E-03 5.19751557E-02 + 1.92819553E-01 5.50913021E-02 1.000000000E-03 5.19751552E-02 + 1.92922831E-01 5.51208100E-02 1.000000000E-03 5.19751548E-02 + 1.93026109E-01 5.51503179E-02 1.000000000E-03 5.19751552E-02 + 1.93129386E-01 5.51798259E-02 1.000000000E-03 5.19751573E-02 + 1.93232664E-01 5.52093338E-02 1.000000000E-03 5.19751528E-02 + 1.93335942E-01 5.52388417E-02 1.000000000E-03 5.19751521E-02 + 1.93439220E-01 5.52683497E-02 1.000000000E-03 5.19751563E-02 + 1.93542497E-01 5.52978576E-02 1.000000000E-03 5.19751568E-02 + 1.93645775E-01 5.53273655E-02 1.000000000E-03 5.19751547E-02 + 1.93749053E-01 5.53568735E-02 1.000000000E-03 5.19751601E-02 + 1.93852331E-01 5.53863814E-02 1.000000000E-03 5.19751559E-02 + 1.93955608E-01 5.54158893E-02 1.000000000E-03 5.19751520E-02 + 1.94058886E-01 5.54453973E-02 1.000000000E-03 5.19751587E-02 + 1.94162164E-01 5.54749052E-02 1.000000001E-03 5.19751587E-02 + 1.94265442E-01 5.55044131E-02 1.000000001E-03 5.19751529E-02 + 1.94368719E-01 5.55339211E-02 1.000000001E-03 5.19751516E-02 + 1.94471997E-01 5.55634290E-02 1.000000001E-03 5.19751555E-02 + 1.94575275E-01 5.55929369E-02 1.000000001E-03 5.19751568E-02 + 1.94678553E-01 5.56224449E-02 1.000000001E-03 5.19751563E-02 + 1.94781830E-01 5.56519528E-02 1.000000001E-03 5.19751550E-02 + 1.94885108E-01 5.56814607E-02 1.000000001E-03 5.19751541E-02 + 1.94988386E-01 5.57109687E-02 1.000000001E-03 5.19751546E-02 + 1.95091664E-01 5.57404766E-02 1.000000001E-03 5.19751571E-02 + 1.95194941E-01 5.57699846E-02 1.000000001E-03 5.19751543E-02 + 1.95298219E-01 5.57994925E-02 1.000000001E-03 5.19751555E-02 + 1.95401497E-01 5.58290004E-02 1.000000001E-03 5.19751534E-02 + 1.95504775E-01 5.58585084E-02 1.000000001E-03 5.19751571E-02 + 1.95608052E-01 5.58880163E-02 1.000000001E-03 5.19751595E-02 + 1.95711330E-01 5.59175242E-02 1.000000001E-03 5.19751528E-02 + 1.95814608E-01 5.59470322E-02 1.000000001E-03 5.19751550E-02 + 1.95917886E-01 5.59765401E-02 1.000000001E-03 5.19751586E-02 + 1.96021163E-01 5.60060480E-02 1.000000001E-03 5.19751562E-02 + 1.96124441E-01 5.60355560E-02 1.000000001E-03 5.19751571E-02 + 1.96227719E-01 5.60650639E-02 1.000000001E-03 5.19751540E-02 + 1.96330996E-01 5.60945718E-02 1.000000001E-03 5.19751561E-02 + 1.96434274E-01 5.61240798E-02 1.000000001E-03 5.19751560E-02 + 1.96537552E-01 5.61535877E-02 1.000000001E-03 5.19751550E-02 + 1.96640830E-01 5.61830956E-02 1.000000001E-03 5.19751538E-02 + 1.96744107E-01 5.62126036E-02 1.000000001E-03 5.19751535E-02 + 1.96847385E-01 5.62421115E-02 1.000000001E-03 5.19751548E-02 + 1.96950663E-01 5.62716195E-02 1.000000001E-03 5.19751589E-02 + 1.97053941E-01 5.63011274E-02 1.000000001E-03 5.19751588E-02 + 1.97157218E-01 5.63306353E-02 1.000000001E-03 5.19751552E-02 + 1.97260496E-01 5.63601433E-02 1.000000001E-03 5.19751573E-02 + 1.97363774E-01 5.63896512E-02 1.000000001E-03 5.19751577E-02 + 1.97467052E-01 5.64191591E-02 1.000000001E-03 5.19751578E-02 + 1.97570329E-01 5.64486671E-02 1.000000001E-03 5.19751586E-02 + 1.97673607E-01 5.64781750E-02 1.000000001E-03 5.19751528E-02 + 1.97776885E-01 5.65076829E-02 1.000000001E-03 5.19751573E-02 + 1.97880163E-01 5.65371909E-02 1.000000001E-03 5.19751574E-02 + 1.97983440E-01 5.65666988E-02 1.000000001E-03 5.19751540E-02 + 1.98086718E-01 5.65962068E-02 1.000000001E-03 5.19751558E-02 + 1.98189996E-01 5.66257147E-02 1.000000001E-03 5.19751561E-02 + 1.98293274E-01 5.66552226E-02 1.000000001E-03 5.19751560E-02 + 1.98396551E-01 5.66847306E-02 1.000000001E-03 5.19751561E-02 + 1.98499829E-01 5.67142385E-02 1.000000001E-03 5.19751576E-02 + 1.98603107E-01 5.67437464E-02 1.000000001E-03 5.19751540E-02 + 1.98706385E-01 5.67732544E-02 1.000000001E-03 5.19751535E-02 + 1.98809662E-01 5.68027623E-02 1.000000001E-03 5.19751569E-02 + 1.98912940E-01 5.68322702E-02 1.000000001E-03 5.19751581E-02 + 1.99016218E-01 5.68617782E-02 1.000000001E-03 5.19751581E-02 + 1.99119496E-01 5.68912861E-02 1.000000001E-03 5.19751576E-02 + 1.99222773E-01 5.69207941E-02 1.000000001E-03 5.19751574E-02 + 1.99326051E-01 5.69503020E-02 1.000000001E-03 5.19751587E-02 + 1.99429329E-01 5.69798099E-02 1.000000001E-03 5.19751552E-02 + 1.99532607E-01 5.70093179E-02 1.000000001E-03 5.19751550E-02 + 1.99635884E-01 5.70388258E-02 1.000000001E-03 5.19751589E-02 + 1.99739162E-01 5.70683337E-02 1.000000001E-03 5.19751608E-02 + 1.99842440E-01 5.70978417E-02 1.000000001E-03 5.19751546E-02 + 1.99945718E-01 5.71273496E-02 1.000000001E-03 5.19751553E-02 + 2.00048995E-01 5.71568575E-02 1.000000001E-03 5.19751567E-02 + 2.00152273E-01 5.71863655E-02 1.000000001E-03 5.19751597E-02 + 2.00255551E-01 5.72158734E-02 1.000000001E-03 5.19751584E-02 + 2.00358829E-01 5.72453814E-02 1.000000001E-03 5.19751607E-02 + 2.00462106E-01 5.72748893E-02 1.000000001E-03 5.19751604E-02 + 2.00565384E-01 5.73043972E-02 1.000000001E-03 5.19751588E-02 + 2.00668662E-01 5.73339052E-02 1.000000001E-03 5.19751565E-02 + 2.00771940E-01 5.73634131E-02 1.000000001E-03 5.19751546E-02 + 2.00875217E-01 5.73929210E-02 1.000000001E-03 5.19751605E-02 + 2.00978495E-01 5.74224290E-02 1.000000001E-03 5.19751552E-02 + 2.01081773E-01 5.74519369E-02 1.000000001E-03 5.19751595E-02 + 2.01185051E-01 5.74814449E-02 1.000000001E-03 5.19751546E-02 + 2.01288328E-01 5.75109528E-02 1.000000001E-03 5.19751610E-02 + 2.01391606E-01 5.75404607E-02 1.000000002E-03 5.19751600E-02 + 2.01494884E-01 5.75699687E-02 1.000000002E-03 5.19751591E-02 + 2.01598162E-01 5.75994766E-02 1.000000002E-03 5.19751590E-02 + 2.01701439E-01 5.76289845E-02 1.000000002E-03 5.19751607E-02 + 2.01804717E-01 5.76584925E-02 1.000000002E-03 5.19751588E-02 + 2.01907995E-01 5.76880004E-02 1.000000002E-03 5.19751604E-02 + 2.02011273E-01 5.77175084E-02 1.000000002E-03 5.19751602E-02 + 2.02114550E-01 5.77470163E-02 1.000000002E-03 5.19751589E-02 + 2.02217828E-01 5.77765242E-02 1.000000002E-03 5.19751576E-02 + 2.02321106E-01 5.78060322E-02 1.000000002E-03 5.19751572E-02 + 2.02424384E-01 5.78355401E-02 1.000000002E-03 5.19751583E-02 + 2.02527661E-01 5.78650480E-02 1.000000002E-03 5.19751558E-02 + 2.02630939E-01 5.78945560E-02 1.000000002E-03 5.19751568E-02 + 2.02734217E-01 5.79240639E-02 1.000000002E-03 5.19751560E-02 + 2.02837495E-01 5.79535719E-02 1.000000002E-03 5.19751602E-02 + 2.02940772E-01 5.79830798E-02 1.000000002E-03 5.19751584E-02 + 2.03044050E-01 5.80125877E-02 1.000000002E-03 5.19751573E-02 + 2.03147328E-01 5.80420957E-02 1.000000002E-03 5.19751578E-02 + 2.03250606E-01 5.80716036E-02 1.000000002E-03 5.19751611E-02 + 2.03353883E-01 5.81011116E-02 1.000000002E-03 5.19751557E-02 + 2.03457161E-01 5.81306195E-02 1.000000002E-03 5.19751606E-02 + 2.03560439E-01 5.81601274E-02 1.000000002E-03 5.19751588E-02 + 2.03663717E-01 5.81896354E-02 1.000000002E-03 5.19751571E-02 + 2.03766994E-01 5.82191433E-02 1.000000002E-03 5.19751564E-02 + 2.03870272E-01 5.82486512E-02 1.000000002E-03 5.19751574E-02 + 2.03973550E-01 5.82781592E-02 1.000000002E-03 5.19751612E-02 + 2.04076827E-01 5.83076671E-02 1.000000002E-03 5.19751570E-02 + 2.04180105E-01 5.83371751E-02 1.000000002E-03 5.19751572E-02 + 2.04283383E-01 5.83666830E-02 1.000000002E-03 5.19751569E-02 + 2.04386661E-01 5.83961909E-02 1.000000002E-03 5.19751569E-02 + 2.04489938E-01 5.84256989E-02 1.000000002E-03 5.19751582E-02 + 2.04593216E-01 5.84552068E-02 1.000000002E-03 5.19751616E-02 + 2.04696494E-01 5.84847148E-02 1.000000002E-03 5.19751567E-02 + 2.04799772E-01 5.85142227E-02 1.000000003E-03 5.19751613E-02 + 2.04903049E-01 5.85437306E-02 1.000000003E-03 5.19751593E-02 + 2.05006327E-01 5.85732386E-02 1.000000003E-03 5.19751573E-02 + 2.05109605E-01 5.86027465E-02 1.000000003E-03 5.19751615E-02 + 2.05212883E-01 5.86322545E-02 1.000000003E-03 5.19751618E-02 + 2.05316160E-01 5.86617624E-02 1.000000003E-03 5.19751593E-02 + 2.05419438E-01 5.86912703E-02 1.000000003E-03 5.19751601E-02 + 2.05522716E-01 5.87207783E-02 1.000000003E-03 5.19751597E-02 + 2.05625994E-01 5.87502862E-02 1.000000003E-03 5.19751587E-02 + 2.05729271E-01 5.87797942E-02 1.000000003E-03 5.19751584E-02 + 2.05832549E-01 5.88093021E-02 1.000000003E-03 5.19751593E-02 + 2.05935827E-01 5.88388100E-02 1.000000003E-03 5.19751570E-02 + 2.06039105E-01 5.88683180E-02 1.000000003E-03 5.19751578E-02 + 2.06142382E-01 5.88978259E-02 1.000000003E-03 5.19751622E-02 + 2.06245660E-01 5.89273339E-02 1.000000003E-03 5.19751608E-02 + 2.06348938E-01 5.89568418E-02 1.000000003E-03 5.19751598E-02 + 2.06452216E-01 5.89863497E-02 1.000000003E-03 5.19751597E-02 + 2.06555493E-01 5.90158577E-02 1.000000003E-03 5.19751616E-02 + 2.06658771E-01 5.90453656E-02 1.000000003E-03 5.19751611E-02 + 2.06762049E-01 5.90748736E-02 1.000000003E-03 5.19751592E-02 + 2.06865327E-01 5.91043815E-02 1.000000003E-03 5.19751614E-02 + 2.06968604E-01 5.91338894E-02 1.000000003E-03 5.19751588E-02 + 2.07071882E-01 5.91633974E-02 1.000000003E-03 5.19751622E-02 + 2.07175160E-01 5.91929053E-02 1.000000004E-03 5.19751623E-02 + 2.07278438E-01 5.92224133E-02 1.000000004E-03 5.19751601E-02 + 2.07381715E-01 5.92519212E-02 1.000000004E-03 5.19751612E-02 + 2.07484993E-01 5.92814291E-02 1.000000004E-03 5.19751617E-02 + 2.07588271E-01 5.93109371E-02 1.000000004E-03 5.19751623E-02 + 2.07691549E-01 5.93404450E-02 1.000000004E-03 5.19751590E-02 + 2.07794826E-01 5.93699530E-02 1.000000004E-03 5.19751623E-02 + 2.07898104E-01 5.93994609E-02 1.000000004E-03 5.19751584E-02 + 2.08001382E-01 5.94289688E-02 1.000000004E-03 5.19751628E-02 + 2.08104660E-01 5.94584768E-02 1.000000004E-03 5.19751618E-02 + 2.08207937E-01 5.94879847E-02 1.000000004E-03 5.19751609E-02 + 2.08311215E-01 5.95174927E-02 1.000000004E-03 5.19751611E-02 + 2.08414493E-01 5.95470006E-02 1.000000004E-03 5.19751630E-02 + 2.08517771E-01 5.95765086E-02 1.000000004E-03 5.19751629E-02 + 2.08621048E-01 5.96060165E-02 1.000000004E-03 5.19751617E-02 + 2.08724326E-01 5.96355244E-02 1.000000004E-03 5.19751599E-02 + 2.08827604E-01 5.96650324E-02 1.000000005E-03 5.19751631E-02 + 2.08930882E-01 5.96945403E-02 1.000000005E-03 5.19751629E-02 + 2.09034159E-01 5.97240483E-02 1.000000005E-03 5.19751601E-02 + 2.09137437E-01 5.97535562E-02 1.000000005E-03 5.19751601E-02 + 2.09240715E-01 5.97830641E-02 1.000000005E-03 5.19751592E-02 + 2.09343993E-01 5.98125721E-02 1.000000005E-03 5.19751624E-02 + 2.09447270E-01 5.98420800E-02 1.000000005E-03 5.19751619E-02 + 2.09550548E-01 5.98715880E-02 1.000000005E-03 5.19751628E-02 + 2.09653826E-01 5.99010959E-02 1.000000005E-03 5.19751615E-02 + 2.09757104E-01 5.99306039E-02 1.000000005E-03 5.19751631E-02 + 2.09860381E-01 5.99601118E-02 1.000000005E-03 5.19751597E-02 + 2.09963659E-01 5.99896197E-02 1.000000005E-03 5.19751608E-02 + 2.10066937E-01 6.00191277E-02 1.000000005E-03 5.19751629E-02 + 2.10170215E-01 6.00486356E-02 1.000000005E-03 5.19751624E-02 + 2.10273492E-01 6.00781436E-02 1.000000006E-03 5.19751601E-02 + 2.10376770E-01 6.01076515E-02 1.000000006E-03 5.19751611E-02 + 2.10480048E-01 6.01371595E-02 1.000000006E-03 5.19751619E-02 + 2.10583326E-01 6.01666674E-02 1.000000006E-03 5.19751632E-02 + 2.10686603E-01 6.01961753E-02 1.000000006E-03 5.19751618E-02 + 2.10789881E-01 6.02256833E-02 1.000000006E-03 5.19751623E-02 + 2.10893159E-01 6.02551912E-02 1.000000006E-03 5.19751616E-02 + 2.10996437E-01 6.02846992E-02 1.000000006E-03 5.19751604E-02 + 2.11099714E-01 6.03142071E-02 1.000000006E-03 5.19751635E-02 + 2.11202992E-01 6.03437151E-02 1.000000006E-03 5.19751636E-02 + 2.11306270E-01 6.03732230E-02 1.000000006E-03 5.19751613E-02 + 2.11409548E-01 6.04027309E-02 1.000000007E-03 5.19751617E-02 + 2.11512825E-01 6.04322389E-02 1.000000007E-03 5.19751613E-02 + 2.11616103E-01 6.04617468E-02 1.000000007E-03 5.19751610E-02 + 2.11719381E-01 6.04912548E-02 1.000000007E-03 5.19751614E-02 + 2.11822658E-01 6.05207627E-02 1.000000007E-03 5.19751634E-02 + 2.11925936E-01 6.05502707E-02 1.000000007E-03 5.19751638E-02 + 2.12029214E-01 6.05797786E-02 1.000000007E-03 5.19751631E-02 + 2.12132492E-01 6.06092865E-02 1.000000007E-03 5.19751625E-02 + 2.12235769E-01 6.06387945E-02 1.000000007E-03 5.19751624E-02 + 2.12339047E-01 6.06683024E-02 1.000000007E-03 5.19751638E-02 + 2.12442325E-01 6.06978104E-02 1.000000008E-03 5.19751634E-02 + 2.12545603E-01 6.07273183E-02 1.000000008E-03 5.19751619E-02 + 2.12648880E-01 6.07568263E-02 1.000000008E-03 5.19751642E-02 + 2.12752158E-01 6.07863342E-02 1.000000008E-03 5.19751632E-02 + 2.12855436E-01 6.08158422E-02 1.000000008E-03 5.19751634E-02 + 2.12958714E-01 6.08453501E-02 1.000000008E-03 5.19751619E-02 + 2.13061991E-01 6.08748580E-02 1.000000008E-03 5.19751632E-02 + 2.13165269E-01 6.09043660E-02 1.000000008E-03 5.19751642E-02 + 2.13268547E-01 6.09338739E-02 1.000000008E-03 5.19751619E-02 + 2.13371825E-01 6.09633819E-02 1.000000009E-03 5.19751647E-02 + 2.13475102E-01 6.09928898E-02 1.000000009E-03 5.19751619E-02 + 2.13578380E-01 6.10223978E-02 1.000000009E-03 5.19751620E-02 + 2.13681658E-01 6.10519057E-02 1.000000009E-03 5.19751655E-02 + 2.13784936E-01 6.10814137E-02 1.000000009E-03 5.19751621E-02 + 2.13888213E-01 6.11109216E-02 1.000000009E-03 5.19751638E-02 + 2.13991491E-01 6.11404295E-02 1.000000009E-03 5.19751637E-02 + 2.14094769E-01 6.11699375E-02 1.000000010E-03 5.19751628E-02 + 2.14198047E-01 6.11994454E-02 1.000000010E-03 5.19751654E-02 + 2.14301324E-01 6.12289534E-02 1.000000010E-03 5.19751650E-02 + 2.14404602E-01 6.12584613E-02 1.000000010E-03 5.19751659E-02 + 2.14507880E-01 6.12879693E-02 1.000000010E-03 5.19751654E-02 + 2.14611158E-01 6.13174772E-02 1.000000010E-03 5.19751640E-02 + 2.14714435E-01 6.13469852E-02 1.000000010E-03 5.19751628E-02 + 2.14817713E-01 6.13764931E-02 1.000000011E-03 5.19751657E-02 + 2.14920991E-01 6.14060011E-02 1.000000011E-03 5.19751632E-02 + 2.15024269E-01 6.14355090E-02 1.000000011E-03 5.19751628E-02 + 2.15127546E-01 6.14650170E-02 1.000000011E-03 5.19751654E-02 + 2.15230824E-01 6.14945249E-02 1.000000011E-03 5.19751647E-02 + 2.15334102E-01 6.15240328E-02 1.000000011E-03 5.19751650E-02 + 2.15437380E-01 6.15535408E-02 1.000000011E-03 5.19751634E-02 + 2.15540657E-01 6.15830487E-02 1.000000012E-03 5.19751643E-02 + 2.15643935E-01 6.16125567E-02 1.000000012E-03 5.19751649E-02 + 2.15747213E-01 6.16420646E-02 1.000000012E-03 5.19751659E-02 + 2.15850491E-01 6.16715726E-02 1.000000012E-03 5.19751646E-02 + 2.15953768E-01 6.17010805E-02 1.000000012E-03 5.19751653E-02 + 2.16057046E-01 6.17305885E-02 1.000000012E-03 5.19751652E-02 + 2.16160324E-01 6.17600964E-02 1.000000013E-03 5.19751651E-02 + 2.16263602E-01 6.17896044E-02 1.000000013E-03 5.19751658E-02 + 2.16366879E-01 6.18191123E-02 1.000000013E-03 5.19751645E-02 + 2.16470157E-01 6.18486203E-02 1.000000013E-03 5.19751654E-02 + 2.16573435E-01 6.18781282E-02 1.000000013E-03 5.19751659E-02 + 2.16676713E-01 6.19076362E-02 1.000000014E-03 5.19751668E-02 + 2.16779990E-01 6.19371441E-02 1.000000014E-03 5.19751654E-02 + 2.16883268E-01 6.19666521E-02 1.000000014E-03 5.19751658E-02 + 2.16986546E-01 6.19961600E-02 1.000000014E-03 5.19751654E-02 + 2.17089824E-01 6.20256679E-02 1.000000014E-03 5.19751651E-02 + 2.17193101E-01 6.20551759E-02 1.000000015E-03 5.19751654E-02 + 2.17296379E-01 6.20846838E-02 1.000000015E-03 5.19751671E-02 + 2.17399657E-01 6.21141918E-02 1.000000015E-03 5.19751647E-02 + 2.17502935E-01 6.21436997E-02 1.000000015E-03 5.19751651E-02 + 2.17606212E-01 6.21732077E-02 1.000000015E-03 5.19751658E-02 + 2.17709490E-01 6.22027156E-02 1.000000016E-03 5.19751676E-02 + 2.17812768E-01 6.22322236E-02 1.000000016E-03 5.19751651E-02 + 2.17916046E-01 6.22617315E-02 1.000000016E-03 5.19751651E-02 + 2.18019323E-01 6.22912395E-02 1.000000016E-03 5.19751652E-02 + 2.18122601E-01 6.23207474E-02 1.000000017E-03 5.19751662E-02 + 2.18225879E-01 6.23502554E-02 1.000000017E-03 5.19751657E-02 + 2.18329157E-01 6.23797633E-02 1.000000017E-03 5.19751674E-02 + 2.18432434E-01 6.24092713E-02 1.000000017E-03 5.19751661E-02 + 2.18535712E-01 6.24387792E-02 1.000000018E-03 5.19751683E-02 + 2.18638990E-01 6.24682872E-02 1.000000018E-03 5.19751659E-02 + 2.18742268E-01 6.24977951E-02 1.000000018E-03 5.19751656E-02 + 2.18845545E-01 6.25273031E-02 1.000000018E-03 5.19751679E-02 + 2.18948823E-01 6.25568110E-02 1.000000019E-03 5.19751678E-02 + 2.19052101E-01 6.25863190E-02 1.000000019E-03 5.19751659E-02 + 2.19155379E-01 6.26158269E-02 1.000000019E-03 5.19751687E-02 + 2.19258656E-01 6.26453349E-02 1.000000019E-03 5.19751683E-02 + 2.19361934E-01 6.26748428E-02 1.000000020E-03 5.19751682E-02 + 2.19465212E-01 6.27043508E-02 1.000000020E-03 5.19751662E-02 + 2.19568490E-01 6.27338587E-02 1.000000020E-03 5.19751688E-02 + 2.19671767E-01 6.27633667E-02 1.000000021E-03 5.19751680E-02 + 2.19775045E-01 6.27928746E-02 1.000000021E-03 5.19751676E-02 + 2.19878323E-01 6.28223826E-02 1.000000021E-03 5.19751680E-02 + 2.19981600E-01 6.28518905E-02 1.000000021E-03 5.19751672E-02 + 2.20084878E-01 6.28813985E-02 1.000000022E-03 5.19751687E-02 + 2.20188156E-01 6.29109064E-02 1.000000022E-03 5.19751676E-02 + 2.20291434E-01 6.29404144E-02 1.000000022E-03 5.19751673E-02 + 2.20394711E-01 6.29699223E-02 1.000000023E-03 5.19751686E-02 + 2.20497989E-01 6.29994303E-02 1.000000023E-03 5.19751693E-02 + 2.20601267E-01 6.30289382E-02 1.000000023E-03 5.19751675E-02 + 2.20704545E-01 6.30584462E-02 1.000000024E-03 5.19751691E-02 + 2.20807822E-01 6.30879541E-02 1.000000024E-03 5.19751696E-02 + 2.20911100E-01 6.31174621E-02 1.000000024E-03 5.19751695E-02 + 2.21014378E-01 6.31469700E-02 1.000000025E-03 5.19751696E-02 + 2.21117656E-01 6.31764780E-02 1.000000025E-03 5.19751678E-02 + 2.21220933E-01 6.32059859E-02 1.000000025E-03 5.19751702E-02 + 2.21324211E-01 6.32354939E-02 1.000000026E-03 5.19751695E-02 + 2.21427489E-01 6.32650018E-02 1.000000026E-03 5.19751690E-02 + 2.21530767E-01 6.32945098E-02 1.000000026E-03 5.19751693E-02 + 2.21634044E-01 6.33240177E-02 1.000000027E-03 5.19751686E-02 + 2.21737322E-01 6.33535257E-02 1.000000027E-03 5.19751700E-02 + 2.21840600E-01 6.33830337E-02 1.000000028E-03 5.19751692E-02 + 2.21943878E-01 6.34125416E-02 1.000000028E-03 5.19751692E-02 + 2.22047155E-01 6.34420496E-02 1.000000028E-03 5.19751684E-02 + 2.22150433E-01 6.34715575E-02 1.000000029E-03 5.19751697E-02 + 2.22253711E-01 6.35010655E-02 1.000000029E-03 5.19751689E-02 + 2.22356989E-01 6.35305734E-02 1.000000030E-03 5.19751691E-02 + 2.22460266E-01 6.35600814E-02 1.000000030E-03 5.19751710E-02 + 2.22563544E-01 6.35895893E-02 1.000000030E-03 5.19751702E-02 + 2.22666822E-01 6.36190973E-02 1.000000031E-03 5.19751700E-02 + 2.22770100E-01 6.36486052E-02 1.000000031E-03 5.19751709E-02 + 2.22873377E-01 6.36781132E-02 1.000000032E-03 5.19751711E-02 + 2.22976655E-01 6.37076211E-02 1.000000032E-03 5.19751713E-02 + 2.23079933E-01 6.37371291E-02 1.000000033E-03 5.19751697E-02 + 2.23183211E-01 6.37666370E-02 1.000000033E-03 5.19751694E-02 + 2.23286488E-01 6.37961450E-02 1.000000034E-03 5.19751711E-02 + 2.23389766E-01 6.38256530E-02 1.000000034E-03 5.19751706E-02 + 2.23493044E-01 6.38551609E-02 1.000000034E-03 5.19751708E-02 + 2.23596322E-01 6.38846689E-02 1.000000035E-03 5.19751702E-02 + 2.23699599E-01 6.39141768E-02 1.000000035E-03 5.19751717E-02 + 2.23802877E-01 6.39436848E-02 1.000000036E-03 5.19751712E-02 + 2.23906155E-01 6.39731927E-02 1.000000036E-03 5.19751717E-02 + 2.24009433E-01 6.40027007E-02 1.000000037E-03 5.19751716E-02 + 2.24112710E-01 6.40322086E-02 1.000000037E-03 5.19751715E-02 + 2.24215988E-01 6.40617166E-02 1.000000038E-03 5.19751720E-02 + 2.24319266E-01 6.40912245E-02 1.000000039E-03 5.19751714E-02 + 2.24422544E-01 6.41207325E-02 1.000000039E-03 5.19751727E-02 + 2.24525821E-01 6.41502405E-02 1.000000040E-03 5.19751720E-02 + 2.24629099E-01 6.41797484E-02 1.000000040E-03 5.19751721E-02 + 2.24732377E-01 6.42092564E-02 1.000000041E-03 5.19751716E-02 + 2.24835655E-01 6.42387643E-02 1.000000041E-03 5.19751731E-02 + 2.24938932E-01 6.42682723E-02 1.000000042E-03 5.19751729E-02 + 2.25042210E-01 6.42977802E-02 1.000000042E-03 5.19751716E-02 + 2.25145488E-01 6.43272882E-02 1.000000043E-03 5.19751721E-02 + 2.25248766E-01 6.43567962E-02 1.000000044E-03 5.19751728E-02 + 2.25352043E-01 6.43863041E-02 1.000000044E-03 5.19751721E-02 + 2.25455321E-01 6.44158121E-02 1.000000045E-03 5.19751729E-02 + 2.25558599E-01 6.44453200E-02 1.000000045E-03 5.19751735E-02 + 2.25661877E-01 6.44748280E-02 1.000000046E-03 5.19751725E-02 + 2.25765154E-01 6.45043359E-02 1.000000047E-03 5.19751726E-02 + 2.25868432E-01 6.45338439E-02 1.000000047E-03 5.19751723E-02 + 2.25971710E-01 6.45633519E-02 1.000000048E-03 5.19751722E-02 + 2.26074988E-01 6.45928598E-02 1.000000049E-03 5.19751730E-02 + 2.26178265E-01 6.46223678E-02 1.000000049E-03 5.19751731E-02 + 2.26281543E-01 6.46518757E-02 1.000000050E-03 5.19751732E-02 + 2.26384821E-01 6.46813837E-02 1.000000051E-03 5.19751739E-02 + 2.26488099E-01 6.47108916E-02 1.000000051E-03 5.19751737E-02 + 2.26591376E-01 6.47403996E-02 1.000000052E-03 5.19751732E-02 + 2.26694654E-01 6.47699076E-02 1.000000053E-03 5.19751731E-02 + 2.26797932E-01 6.47994155E-02 1.000000054E-03 5.19751740E-02 + 2.26901210E-01 6.48289235E-02 1.000000054E-03 5.19751744E-02 + 2.27004487E-01 6.48584314E-02 1.000000055E-03 5.19751749E-02 + 2.27107765E-01 6.48879394E-02 1.000000056E-03 5.19751741E-02 + 2.27211043E-01 6.49174473E-02 1.000000057E-03 5.19751748E-02 + 2.27314321E-01 6.49469553E-02 1.000000057E-03 5.19751753E-02 + 2.27417598E-01 6.49764633E-02 1.000000058E-03 5.19751744E-02 + 2.27520876E-01 6.50059712E-02 1.000000059E-03 5.19751747E-02 + 2.27624154E-01 6.50354792E-02 1.000000060E-03 5.19751747E-02 + 2.27727431E-01 6.50649871E-02 1.000000061E-03 5.19751752E-02 + 2.27830709E-01 6.50944951E-02 1.000000061E-03 5.19751746E-02 + 2.27933987E-01 6.51240031E-02 1.000000062E-03 5.19751757E-02 + 2.28037265E-01 6.51535110E-02 1.000000063E-03 5.19751750E-02 + 2.28140542E-01 6.51830190E-02 1.000000064E-03 5.19751752E-02 + 2.28243820E-01 6.52125269E-02 1.000000065E-03 5.19751748E-02 + 2.28347098E-01 6.52420349E-02 1.000000066E-03 5.19751746E-02 + 2.28450376E-01 6.52715429E-02 1.000000067E-03 5.19751751E-02 + 2.28553653E-01 6.53010508E-02 1.000000067E-03 5.19751749E-02 + 2.28656931E-01 6.53305588E-02 1.000000068E-03 5.19751767E-02 + 2.28760209E-01 6.53600667E-02 1.000000069E-03 5.19751752E-02 + 2.28863487E-01 6.53895747E-02 1.000000070E-03 5.19751769E-02 + 2.28966764E-01 6.54190827E-02 1.000000071E-03 5.19751765E-02 + 2.29070042E-01 6.54485906E-02 1.000000072E-03 5.19751766E-02 + 2.29173320E-01 6.54780986E-02 1.000000073E-03 5.19751759E-02 + 2.29276598E-01 6.55076066E-02 1.000000074E-03 5.19751770E-02 + 2.29379875E-01 6.55371145E-02 1.000000075E-03 5.19751765E-02 + 2.29483153E-01 6.55666225E-02 1.000000076E-03 5.19751772E-02 + 2.29586431E-01 6.55961304E-02 1.000000077E-03 5.19751775E-02 + 2.29689709E-01 6.56256384E-02 1.000000078E-03 5.19751763E-02 + 2.29792986E-01 6.56551464E-02 1.000000079E-03 5.19751780E-02 + 2.29896264E-01 6.56846543E-02 1.000000080E-03 5.19751775E-02 + 2.29999542E-01 6.57141623E-02 1.000000082E-03 5.19751774E-02 + 2.30102820E-01 6.57436703E-02 1.000000083E-03 5.19751781E-02 + 2.30206097E-01 6.57731782E-02 1.000000084E-03 5.19751768E-02 + 2.30309375E-01 6.58026862E-02 1.000000085E-03 5.19751775E-02 + 2.30412653E-01 6.58321941E-02 1.000000086E-03 5.19751773E-02 + 2.30515931E-01 6.58617021E-02 1.000000087E-03 5.19751785E-02 + 2.30619208E-01 6.58912101E-02 1.000000088E-03 5.19751783E-02 + 2.30722486E-01 6.59207180E-02 1.000000090E-03 5.19751789E-02 + 2.30825764E-01 6.59502260E-02 1.000000091E-03 5.19751774E-02 + 2.30929042E-01 6.59797340E-02 1.000000092E-03 5.19751780E-02 + 2.31032319E-01 6.60092419E-02 1.000000093E-03 5.19751777E-02 + 2.31135597E-01 6.60387499E-02 1.000000095E-03 5.19751788E-02 + 2.31238875E-01 6.60682579E-02 1.000000096E-03 5.19751785E-02 + 2.31342153E-01 6.60977658E-02 1.000000097E-03 5.19751791E-02 + 2.31445430E-01 6.61272738E-02 1.000000098E-03 5.19751794E-02 + 2.31548708E-01 6.61567817E-02 1.000000100E-03 5.19751783E-02 + 2.31651986E-01 6.61862897E-02 1.000000101E-03 5.19751798E-02 + 2.31755264E-01 6.62157977E-02 1.000000102E-03 5.19751794E-02 + 2.31858541E-01 6.62453056E-02 1.000000104E-03 5.19751794E-02 + 2.31961819E-01 6.62748136E-02 1.000000105E-03 5.19751804E-02 + 2.32065097E-01 6.63043216E-02 1.000000107E-03 5.19751795E-02 + 2.32168375E-01 6.63338295E-02 1.000000108E-03 5.19751790E-02 + 2.32271652E-01 6.63633375E-02 1.000000110E-03 5.19751796E-02 + 2.32374930E-01 6.63928455E-02 1.000000111E-03 5.19751801E-02 + 2.32478208E-01 6.64223534E-02 1.000000112E-03 5.19751795E-02 + 2.32581486E-01 6.64518614E-02 1.000000114E-03 5.19751800E-02 + 2.32684763E-01 6.64813694E-02 1.000000116E-03 5.19751804E-02 + 2.32788041E-01 6.65108773E-02 1.000000117E-03 5.19751799E-02 + 2.32891319E-01 6.65403853E-02 1.000000119E-03 5.19751805E-02 + 2.32994597E-01 6.65698933E-02 1.000000120E-03 5.19751812E-02 + 2.33097874E-01 6.65994012E-02 1.000000122E-03 5.19751811E-02 + 2.33201152E-01 6.66289092E-02 1.000000123E-03 5.19751805E-02 + 2.33304430E-01 6.66584172E-02 1.000000125E-03 5.19751819E-02 + 2.33407708E-01 6.66879251E-02 1.000000127E-03 5.19751809E-02 + 2.33510985E-01 6.67174331E-02 1.000000128E-03 5.19751812E-02 + 2.33614263E-01 6.67469411E-02 1.000000130E-03 5.19751819E-02 + 2.33717541E-01 6.67764491E-02 1.000000132E-03 5.19751819E-02 + 2.33820819E-01 6.68059570E-02 1.000000134E-03 5.19751819E-02 + 2.33924096E-01 6.68354650E-02 1.000000135E-03 5.19751824E-02 + 2.34027374E-01 6.68649730E-02 1.000000137E-03 5.19751825E-02 + 2.34130652E-01 6.68944809E-02 1.000000139E-03 5.19751826E-02 + 2.34233930E-01 6.69239889E-02 1.000000141E-03 5.19751818E-02 + 2.34337207E-01 6.69534969E-02 1.000000143E-03 5.19751822E-02 + 2.34440485E-01 6.69830048E-02 1.000000145E-03 5.19751829E-02 + 2.34543763E-01 6.70125128E-02 1.000000147E-03 5.19751829E-02 + 2.34647041E-01 6.70420208E-02 1.000000149E-03 5.19751828E-02 + 2.34750318E-01 6.70715287E-02 1.000000151E-03 5.19751831E-02 + 2.34853596E-01 6.71010367E-02 1.000000153E-03 5.19751828E-02 + 2.34956874E-01 6.71305447E-02 1.000000155E-03 5.19751841E-02 + 2.35060152E-01 6.71600527E-02 1.000000157E-03 5.19751831E-02 + 2.35163429E-01 6.71895606E-02 1.000000159E-03 5.19751832E-02 + 2.35266707E-01 6.72190686E-02 1.000000161E-03 5.19751835E-02 + 2.35369985E-01 6.72485766E-02 1.000000163E-03 5.19751847E-02 + 2.35473262E-01 6.72780845E-02 1.000000165E-03 5.19751842E-02 + 2.35576540E-01 6.73075925E-02 1.000000167E-03 5.19751842E-02 + 2.35679818E-01 6.73371005E-02 1.000000170E-03 5.19751838E-02 + 2.35783096E-01 6.73666085E-02 1.000000172E-03 5.19751849E-02 + 2.35886373E-01 6.73961164E-02 1.000000174E-03 5.19751853E-02 + 2.35989651E-01 6.74256244E-02 1.000000176E-03 5.19751854E-02 + 2.36092929E-01 6.74551324E-02 1.000000179E-03 5.19751844E-02 + 2.36196207E-01 6.74846403E-02 1.000000181E-03 5.19751858E-02 + 2.36299484E-01 6.75141483E-02 1.000000183E-03 5.19751857E-02 + 2.36402762E-01 6.75436563E-02 1.000000186E-03 5.19751848E-02 + 2.36506040E-01 6.75731643E-02 1.000000188E-03 5.19751850E-02 + 2.36609318E-01 6.76026722E-02 1.000000191E-03 5.19751855E-02 + 2.36712595E-01 6.76321802E-02 1.000000193E-03 5.19751854E-02 + 2.36815873E-01 6.76616882E-02 1.000000196E-03 5.19751867E-02 + 2.36919151E-01 6.76911962E-02 1.000000198E-03 5.19751857E-02 + 2.37022429E-01 6.77207041E-02 1.000000201E-03 5.19751858E-02 + 2.37125706E-01 6.77502121E-02 1.000000204E-03 5.19751861E-02 + 2.37228984E-01 6.77797201E-02 1.000000206E-03 5.19751872E-02 + 2.37332262E-01 6.78092281E-02 1.000000209E-03 5.19751869E-02 + 2.37435540E-01 6.78387360E-02 1.000000212E-03 5.19751871E-02 + 2.37538817E-01 6.78682440E-02 1.000000215E-03 5.19751869E-02 + 2.37642095E-01 6.78977520E-02 1.000000217E-03 5.19751871E-02 + 2.37745373E-01 6.79272600E-02 1.000000220E-03 5.19751880E-02 + 2.37848651E-01 6.79567679E-02 1.000000223E-03 5.19751876E-02 + 2.37951928E-01 6.79862759E-02 1.000000226E-03 5.19751877E-02 + 2.38055206E-01 6.80157839E-02 1.000000229E-03 5.19751876E-02 + 2.38158484E-01 6.80452919E-02 1.000000232E-03 5.19751877E-02 + 2.38261762E-01 6.80747998E-02 1.000000235E-03 5.19751887E-02 + 2.38365039E-01 6.81043078E-02 1.000000238E-03 5.19751884E-02 + 2.38468317E-01 6.81338158E-02 1.000000241E-03 5.19751888E-02 + 2.38571595E-01 6.81633238E-02 1.000000244E-03 5.19751889E-02 + 2.38674873E-01 6.81928318E-02 1.000000248E-03 5.19751882E-02 + 2.38778150E-01 6.82223397E-02 1.000000251E-03 5.19751883E-02 + 2.38881428E-01 6.82518477E-02 1.000000254E-03 5.19751886E-02 + 2.38984706E-01 6.82813557E-02 1.000000257E-03 5.19751896E-02 + 2.39087984E-01 6.83108637E-02 1.000000261E-03 5.19751893E-02 + 2.39191261E-01 6.83403716E-02 1.000000264E-03 5.19751895E-02 + 2.39294539E-01 6.83698796E-02 1.000000268E-03 5.19751894E-02 + 2.39397817E-01 6.83993876E-02 1.000000271E-03 5.19751897E-02 + 2.39501095E-01 6.84288956E-02 1.000000275E-03 5.19751895E-02 + 2.39604372E-01 6.84584036E-02 1.000000278E-03 5.19751906E-02 + 2.39707650E-01 6.84879115E-02 1.000000282E-03 5.19751899E-02 + 2.39810928E-01 6.85174195E-02 1.000000286E-03 5.19751904E-02 + 2.39914206E-01 6.85469275E-02 1.000000289E-03 5.19751913E-02 + 2.40017483E-01 6.85764355E-02 1.000000293E-03 5.19751908E-02 + 2.40120761E-01 6.86059435E-02 1.000000297E-03 5.19751905E-02 + 2.40224039E-01 6.86354514E-02 1.000000301E-03 5.19751911E-02 + 2.40327317E-01 6.86649594E-02 1.000000305E-03 5.19751917E-02 + 2.40430594E-01 6.86944674E-02 1.000000309E-03 5.19751919E-02 + 2.40533872E-01 6.87239754E-02 1.000000313E-03 5.19751920E-02 + 2.40637150E-01 6.87534834E-02 1.000000317E-03 5.19751914E-02 + 2.40740428E-01 6.87829913E-02 1.000000321E-03 5.19751918E-02 + 2.40843705E-01 6.88124993E-02 1.000000325E-03 5.19751926E-02 + 2.40946983E-01 6.88420073E-02 1.000000329E-03 5.19751919E-02 + 2.41050261E-01 6.88715153E-02 1.000000333E-03 5.19751926E-02 + 2.41153539E-01 6.89010233E-02 1.000000338E-03 5.19751929E-02 + 2.41256816E-01 6.89305313E-02 1.000000342E-03 5.19751932E-02 + 2.41360094E-01 6.89600392E-02 1.000000346E-03 5.19751930E-02 + 2.41463372E-01 6.89895472E-02 1.000000351E-03 5.19751927E-02 + 2.41566650E-01 6.90190552E-02 1.000000355E-03 5.19751930E-02 + 2.41669927E-01 6.90485632E-02 1.000000360E-03 5.19751931E-02 + 2.41773205E-01 6.90780712E-02 1.000000365E-03 5.19751935E-02 + 2.41876483E-01 6.91075792E-02 1.000000369E-03 5.19751937E-02 + 2.41979761E-01 6.91370871E-02 1.000000374E-03 5.19751942E-02 + 2.42083038E-01 6.91665951E-02 1.000000379E-03 5.19751943E-02 + 2.42186316E-01 6.91961031E-02 1.000000384E-03 5.19751946E-02 + 2.42289594E-01 6.92256111E-02 1.000000389E-03 5.19751944E-02 + 2.42392872E-01 6.92551191E-02 1.000000394E-03 5.19751944E-02 + 2.42496149E-01 6.92846271E-02 1.000000399E-03 5.19751948E-02 + 2.42599427E-01 6.93141351E-02 1.000000404E-03 5.19751953E-02 + 2.42702705E-01 6.93436430E-02 1.000000409E-03 5.19751952E-02 + 2.42805983E-01 6.93731510E-02 1.000000414E-03 5.19751961E-02 + 2.42909260E-01 6.94026590E-02 1.000000420E-03 5.19751963E-02 + 2.43012538E-01 6.94321670E-02 1.000000425E-03 5.19751963E-02 + 2.43115816E-01 6.94616750E-02 1.000000431E-03 5.19751957E-02 + 2.43219093E-01 6.94911830E-02 1.000000436E-03 5.19751958E-02 + 2.43322371E-01 6.95206910E-02 1.000000442E-03 5.19751963E-02 + 2.43425649E-01 6.95501990E-02 1.000000447E-03 5.19751965E-02 + 2.43528927E-01 6.95797069E-02 1.000000453E-03 5.19751969E-02 + 2.43632204E-01 6.96092149E-02 1.000000459E-03 5.19751969E-02 + 2.43735482E-01 6.96387229E-02 1.000000465E-03 5.19751971E-02 + 2.43838760E-01 6.96682309E-02 1.000000471E-03 5.19751970E-02 + 2.43942038E-01 6.96977389E-02 1.000000477E-03 5.19751980E-02 + 2.44045315E-01 6.97272469E-02 1.000000483E-03 5.19751975E-02 + 2.44148593E-01 6.97567549E-02 1.000000489E-03 5.19751982E-02 + 2.44251871E-01 6.97862629E-02 1.000000495E-03 5.19751984E-02 + 2.44355149E-01 6.98157709E-02 1.000000501E-03 5.19751987E-02 + 2.44458426E-01 6.98452788E-02 1.000000508E-03 5.19751985E-02 + 2.44561704E-01 6.98747868E-02 1.000000514E-03 5.19751983E-02 + 2.44664982E-01 6.99042948E-02 1.000000521E-03 5.19751987E-02 + 2.44768260E-01 6.99338028E-02 1.000000528E-03 5.19751990E-02 + 2.44871537E-01 6.99633108E-02 1.000000534E-03 5.19751999E-02 + 2.44974815E-01 6.99928188E-02 1.000000541E-03 5.19751997E-02 + 2.45078093E-01 7.00223268E-02 1.000000548E-03 5.19752000E-02 + 2.45181371E-01 7.00518348E-02 1.000000555E-03 5.19752003E-02 + 2.45284648E-01 7.00813428E-02 1.000000562E-03 5.19752000E-02 + 2.45387926E-01 7.01108508E-02 1.000000569E-03 5.19752007E-02 + 2.45491204E-01 7.01403588E-02 1.000000576E-03 5.19752009E-02 + 2.45594482E-01 7.01698668E-02 1.000000584E-03 5.19752011E-02 + 2.45697759E-01 7.01993747E-02 1.000000591E-03 5.19752007E-02 + 2.45801037E-01 7.02288827E-02 1.000000599E-03 5.19752013E-02 + 2.45904315E-01 7.02583907E-02 1.000000606E-03 5.19752014E-02 + 2.46007593E-01 7.02878987E-02 1.000000614E-03 5.19752015E-02 + 2.46110870E-01 7.03174067E-02 1.000000622E-03 5.19752020E-02 + 2.46214148E-01 7.03469147E-02 1.000000630E-03 5.19752016E-02 + 2.46317426E-01 7.03764227E-02 1.000000637E-03 5.19752027E-02 + 2.46420704E-01 7.04059307E-02 1.000000646E-03 5.19752028E-02 + 2.46523981E-01 7.04354387E-02 1.000000654E-03 5.19752025E-02 + 2.46627259E-01 7.04649467E-02 1.000000662E-03 5.19752032E-02 + 2.46730537E-01 7.04944547E-02 1.000000670E-03 5.19752035E-02 + 2.46833815E-01 7.05239627E-02 1.000000679E-03 5.19752029E-02 + 2.46937092E-01 7.05534707E-02 1.000000687E-03 5.19752038E-02 + 2.47040370E-01 7.05829787E-02 1.000000696E-03 5.19752039E-02 + 2.47143648E-01 7.06124867E-02 1.000000705E-03 5.19752037E-02 + 2.47246926E-01 7.06419947E-02 1.000000714E-03 5.19752037E-02 + 2.47350203E-01 7.06715027E-02 1.000000723E-03 5.19752043E-02 + 2.47453481E-01 7.07010107E-02 1.000000732E-03 5.19752042E-02 + 2.47556759E-01 7.07305187E-02 1.000000741E-03 5.19752048E-02 + 2.47660037E-01 7.07600267E-02 1.000000750E-03 5.19752047E-02 + 2.47763314E-01 7.07895347E-02 1.000000760E-03 5.19752054E-02 + 2.47866592E-01 7.08190427E-02 1.000000769E-03 5.19752054E-02 + 2.47969870E-01 7.08485507E-02 1.000000779E-03 5.19752054E-02 + 2.48073148E-01 7.08780587E-02 1.000000789E-03 5.19752057E-02 + 2.48176425E-01 7.09075667E-02 1.000000799E-03 5.19752060E-02 + 2.48279703E-01 7.09370747E-02 1.000000809E-03 5.19752067E-02 + 2.48382981E-01 7.09665827E-02 1.000000819E-03 5.19752065E-02 + 2.48486259E-01 7.09960907E-02 1.000000829E-03 5.19752069E-02 + 2.48589536E-01 7.10255987E-02 1.000000840E-03 5.19752073E-02 + 2.48692814E-01 7.10551067E-02 1.000000850E-03 5.19752074E-02 + 2.48796092E-01 7.10846147E-02 1.000000861E-03 5.19752077E-02 + 2.48899370E-01 7.11141227E-02 1.000000872E-03 5.19752078E-02 + 2.49002647E-01 7.11436307E-02 1.000000883E-03 5.19752081E-02 + 2.49105925E-01 7.11731387E-02 1.000000894E-03 5.19752083E-02 + 2.49209203E-01 7.12026467E-02 1.000000905E-03 5.19752088E-02 + 2.49312481E-01 7.12321547E-02 1.000000916E-03 5.19752084E-02 + 2.49415758E-01 7.12616627E-02 1.000000928E-03 5.19752084E-02 + 2.49519036E-01 7.12911707E-02 1.000000939E-03 5.19752094E-02 + 2.49622314E-01 7.13206787E-02 1.000000951E-03 5.19752091E-02 + 2.49725592E-01 7.13501867E-02 1.000000963E-03 5.19752099E-02 + 2.49828869E-01 7.13796947E-02 1.000000975E-03 5.19752095E-02 + 2.49932147E-01 7.14092027E-02 1.000000987E-03 5.19752102E-02 + 2.50035425E-01 7.14387107E-02 1.000000999E-03 5.19752100E-02 + 2.50138703E-01 7.14682187E-02 1.000001012E-03 5.19752102E-02 + 2.50241980E-01 7.14977267E-02 1.000001024E-03 5.19752111E-02 + 2.50345258E-01 7.15272347E-02 1.000001037E-03 5.19752108E-02 + 2.50448536E-01 7.15567427E-02 1.000001050E-03 5.19752115E-02 + 2.50551814E-01 7.15862507E-02 1.000001063E-03 5.19752110E-02 + 2.50655091E-01 7.16157588E-02 1.000001076E-03 5.19752117E-02 + 2.50758369E-01 7.16452668E-02 1.000001090E-03 5.19752121E-02 + 2.50861647E-01 7.16747748E-02 1.000001103E-03 5.19752121E-02 + 2.50964925E-01 7.17042828E-02 1.000001117E-03 5.19752121E-02 + 2.51068202E-01 7.17337908E-02 1.000001131E-03 5.19752125E-02 + 2.51171480E-01 7.17632988E-02 1.000001145E-03 5.19752131E-02 + 2.51274758E-01 7.17928068E-02 1.000001159E-03 5.19752134E-02 + 2.51378035E-01 7.18223148E-02 1.000001173E-03 5.19752132E-02 + 2.51481313E-01 7.18518228E-02 1.000001188E-03 5.19752136E-02 + 2.51584591E-01 7.18813308E-02 1.000001203E-03 5.19752137E-02 + 2.51687869E-01 7.19108388E-02 1.000001218E-03 5.19752138E-02 + 2.51791146E-01 7.19403469E-02 1.000001233E-03 5.19752144E-02 + 2.51894424E-01 7.19698549E-02 1.000001248E-03 5.19752145E-02 + 2.51997702E-01 7.19993629E-02 1.000001263E-03 5.19752151E-02 + 2.52100980E-01 7.20288709E-02 1.000001279E-03 5.19752154E-02 + 2.52204257E-01 7.20583789E-02 1.000001295E-03 5.19752156E-02 + 2.52307535E-01 7.20878869E-02 1.000001311E-03 5.19752156E-02 + 2.52410813E-01 7.21173949E-02 1.000001327E-03 5.19752157E-02 + 2.52514091E-01 7.21469029E-02 1.000001343E-03 5.19752165E-02 + 2.52617368E-01 7.21764109E-02 1.000001360E-03 5.19752161E-02 + 2.52720646E-01 7.22059190E-02 1.000001377E-03 5.19752164E-02 + 2.52823924E-01 7.22354270E-02 1.000001394E-03 5.19752172E-02 + 2.52927202E-01 7.22649350E-02 1.000001411E-03 5.19752174E-02 + 2.53030479E-01 7.22944430E-02 1.000001428E-03 5.19752176E-02 + 2.53133757E-01 7.23239510E-02 1.000001446E-03 5.19752180E-02 + 2.53237035E-01 7.23534590E-02 1.000001464E-03 5.19752178E-02 + 2.53340313E-01 7.23829671E-02 1.000001482E-03 5.19752181E-02 + 2.53443590E-01 7.24124751E-02 1.000001500E-03 5.19752186E-02 + 2.53546868E-01 7.24419831E-02 1.000001518E-03 5.19752190E-02 + 2.53650146E-01 7.24714911E-02 1.000001537E-03 5.19752190E-02 + 2.53753424E-01 7.25009991E-02 1.000001556E-03 5.19752192E-02 + 2.53856701E-01 7.25305071E-02 1.000001575E-03 5.19752192E-02 + 2.53959979E-01 7.25600152E-02 1.000001594E-03 5.19752195E-02 + 2.54063257E-01 7.25895232E-02 1.000001614E-03 5.19752198E-02 + 2.54166535E-01 7.26190312E-02 1.000001634E-03 5.19752206E-02 + 2.54269812E-01 7.26485392E-02 1.000001654E-03 5.19752209E-02 + 2.54373090E-01 7.26780472E-02 1.000001674E-03 5.19752210E-02 + 2.54476368E-01 7.27075552E-02 1.000001694E-03 5.19752209E-02 + 2.54579646E-01 7.27370633E-02 1.000001715E-03 5.19752215E-02 + 2.54682923E-01 7.27665713E-02 1.000001736E-03 5.19752214E-02 + 2.54786201E-01 7.27960793E-02 1.000001757E-03 5.19752222E-02 + 2.54889479E-01 7.28255873E-02 1.000001779E-03 5.19752224E-02 + 2.54992757E-01 7.28550953E-02 1.000001801E-03 5.19752223E-02 + 2.55096034E-01 7.28846034E-02 1.000001823E-03 5.19752226E-02 + 2.55199312E-01 7.29141114E-02 1.000001845E-03 5.19752228E-02 + 2.55302590E-01 7.29436194E-02 1.000001868E-03 5.19752234E-02 + 2.55405868E-01 7.29731274E-02 1.000001890E-03 5.19752236E-02 + 2.55509145E-01 7.30026355E-02 1.000001913E-03 5.19752237E-02 + 2.55612423E-01 7.30321435E-02 1.000001937E-03 5.19752242E-02 + 2.55715701E-01 7.30616515E-02 1.000001960E-03 5.19752242E-02 + 2.55818979E-01 7.30911595E-02 1.000001984E-03 5.19752248E-02 + 2.55922256E-01 7.31206676E-02 1.000002008E-03 5.19752251E-02 + 2.56025534E-01 7.31501756E-02 1.000002033E-03 5.19752255E-02 + 2.56128812E-01 7.31796836E-02 1.000002058E-03 5.19752259E-02 + 2.56232090E-01 7.32091916E-02 1.000002083E-03 5.19752259E-02 + 2.56335367E-01 7.32386997E-02 1.000002108E-03 5.19752260E-02 + 2.56438645E-01 7.32682077E-02 1.000002134E-03 5.19752267E-02 + 2.56541923E-01 7.32977157E-02 1.000002160E-03 5.19752270E-02 + 2.56645201E-01 7.33272237E-02 1.000002186E-03 5.19752269E-02 + 2.56748478E-01 7.33567318E-02 1.000002212E-03 5.19752272E-02 + 2.56851756E-01 7.33862398E-02 1.000002239E-03 5.19752279E-02 + 2.56955034E-01 7.34157478E-02 1.000002266E-03 5.19752281E-02 + 2.57058312E-01 7.34452558E-02 1.000002294E-03 5.19752282E-02 + 2.57161589E-01 7.34747639E-02 1.000002322E-03 5.19752286E-02 + 2.57264867E-01 7.35042719E-02 1.000002350E-03 5.19752292E-02 + 2.57368145E-01 7.35337799E-02 1.000002378E-03 5.19752290E-02 + 2.57471423E-01 7.35632880E-02 1.000002407E-03 5.19752293E-02 + 2.57574700E-01 7.35927960E-02 1.000002436E-03 5.19752297E-02 + 2.57677978E-01 7.36223040E-02 1.000002466E-03 5.19752300E-02 + 2.57781256E-01 7.36518121E-02 1.000002495E-03 5.19752301E-02 + 2.57884534E-01 7.36813201E-02 1.000002526E-03 5.19752304E-02 + 2.57987811E-01 7.37108281E-02 1.000002556E-03 5.19752308E-02 + 2.58091089E-01 7.37403362E-02 1.000002587E-03 5.19752315E-02 + 2.58194367E-01 7.37698442E-02 1.000002618E-03 5.19752319E-02 + 2.58297645E-01 7.37993522E-02 1.000002650E-03 5.19752317E-02 + 2.58400922E-01 7.38288603E-02 1.000002682E-03 5.19752320E-02 + 2.58504200E-01 7.38583683E-02 1.000002714E-03 5.19752325E-02 + 2.58607478E-01 7.38878763E-02 1.000002747E-03 5.19752326E-02 + 2.58710756E-01 7.39173844E-02 1.000002780E-03 5.19752333E-02 + 2.58814033E-01 7.39468924E-02 1.000002813E-03 5.19752336E-02 + 2.58917311E-01 7.39764004E-02 1.000002847E-03 5.19752336E-02 + 2.59020589E-01 7.40059085E-02 1.000002882E-03 5.19752341E-02 + 2.59123866E-01 7.40354165E-02 1.000002916E-03 5.19752345E-02 + 2.59227144E-01 7.40649245E-02 1.000002951E-03 5.19752346E-02 + 2.59330422E-01 7.40944326E-02 1.000002987E-03 5.19752353E-02 + 2.59433700E-01 7.41239406E-02 1.000003023E-03 5.19752353E-02 + 2.59536977E-01 7.41534487E-02 1.000003059E-03 5.19752357E-02 + 2.59640255E-01 7.41829567E-02 1.000003096E-03 5.19752362E-02 + 2.59743533E-01 7.42124647E-02 1.000003133E-03 5.19752362E-02 + 2.59846811E-01 7.42419728E-02 1.000003171E-03 5.19752366E-02 + 2.59950088E-01 7.42714808E-02 1.000003209E-03 5.19752373E-02 + 2.60053366E-01 7.43009888E-02 1.000003247E-03 5.19752375E-02 + 2.60156644E-01 7.43304969E-02 1.000003286E-03 5.19752376E-02 + 2.60259922E-01 7.43600049E-02 1.000003325E-03 5.19752382E-02 + 2.60363199E-01 7.43895130E-02 1.000003365E-03 5.19752383E-02 + 2.60466477E-01 7.44190210E-02 1.000003405E-03 5.19752386E-02 + 2.60569755E-01 7.44485291E-02 1.000003446E-03 5.19752393E-02 + 2.60673033E-01 7.44780371E-02 1.000003487E-03 5.19752392E-02 + 2.60776310E-01 7.45075451E-02 1.000003529E-03 5.19752398E-02 + 2.60879588E-01 7.45370532E-02 1.000003571E-03 5.19752400E-02 + 2.60982866E-01 7.45665612E-02 1.000003614E-03 5.19752406E-02 + 2.61086144E-01 7.45960693E-02 1.000003657E-03 5.19752409E-02 + 2.61189421E-01 7.46255773E-02 1.000003701E-03 5.19752409E-02 + 2.61292699E-01 7.46550854E-02 1.000003745E-03 5.19752414E-02 + 2.61395977E-01 7.46845934E-02 1.000003789E-03 5.19752419E-02 + 2.61499255E-01 7.47141015E-02 1.000003835E-03 5.19752421E-02 + 2.61602532E-01 7.47436095E-02 1.000003880E-03 5.19752424E-02 + 2.61705810E-01 7.47731176E-02 1.000003927E-03 5.19752428E-02 + 2.61809088E-01 7.48026256E-02 1.000003973E-03 5.19752432E-02 + 2.61912366E-01 7.48321336E-02 1.000004021E-03 5.19752433E-02 + 2.62015643E-01 7.48616417E-02 1.000004068E-03 5.19752441E-02 + 2.62118921E-01 7.48911497E-02 1.000004117E-03 5.19752444E-02 + 2.62222199E-01 7.49206578E-02 1.000004166E-03 5.19752447E-02 + 2.62325477E-01 7.49501658E-02 1.000004215E-03 5.19752448E-02 + 2.62428754E-01 7.49796739E-02 1.000004265E-03 5.19752452E-02 + 2.62532032E-01 7.50091819E-02 1.000004316E-03 5.19752456E-02 + 2.62635310E-01 7.50386900E-02 1.000004367E-03 5.19752461E-02 + 2.62738588E-01 7.50681980E-02 1.000004419E-03 5.19752464E-02 + 2.62841865E-01 7.50977061E-02 1.000004471E-03 5.19752464E-02 + 2.62945143E-01 7.51272142E-02 1.000004524E-03 5.19752472E-02 + 2.63048421E-01 7.51567222E-02 1.000004578E-03 5.19752474E-02 + 2.63151699E-01 7.51862303E-02 1.000004632E-03 5.19752477E-02 + 2.63254976E-01 7.52157383E-02 1.000004687E-03 5.19752482E-02 + 2.63358254E-01 7.52452464E-02 1.000004743E-03 5.19752485E-02 + 2.63461532E-01 7.52747544E-02 1.000004799E-03 5.19752489E-02 + 2.63564810E-01 7.53042625E-02 1.000004855E-03 5.19752493E-02 + 2.63668087E-01 7.53337705E-02 1.000004913E-03 5.19752497E-02 + 2.63771365E-01 7.53632786E-02 1.000004971E-03 5.19752498E-02 + 2.63874643E-01 7.53927867E-02 1.000005030E-03 5.19752502E-02 + 2.63977921E-01 7.54222947E-02 1.000005089E-03 5.19752507E-02 + 2.64081198E-01 7.54518028E-02 1.000005149E-03 5.19752512E-02 + 2.64184476E-01 7.54813108E-02 1.000005210E-03 5.19752516E-02 + 2.64287754E-01 7.55108189E-02 1.000005271E-03 5.19752518E-02 + 2.64391032E-01 7.55403269E-02 1.000005333E-03 5.19752523E-02 + 2.64494309E-01 7.55698350E-02 1.000005396E-03 5.19752524E-02 + 2.64597587E-01 7.55993431E-02 1.000005460E-03 5.19752531E-02 + 2.64700865E-01 7.56288511E-02 1.000005524E-03 5.19752532E-02 + 2.64804143E-01 7.56583592E-02 1.000005589E-03 5.19752536E-02 + 2.64907420E-01 7.56878672E-02 1.000005655E-03 5.19752543E-02 + 2.65010698E-01 7.57173753E-02 1.000005722E-03 5.19752547E-02 + 2.65113976E-01 7.57468834E-02 1.000005789E-03 5.19752547E-02 + 2.65217254E-01 7.57763914E-02 1.000005857E-03 5.19752552E-02 + 2.65320531E-01 7.58058995E-02 1.000005926E-03 5.19752556E-02 + 2.65423809E-01 7.58354076E-02 1.000005995E-03 5.19752559E-02 + 2.65527087E-01 7.58649156E-02 1.000006066E-03 5.19752564E-02 + 2.65630365E-01 7.58944237E-02 1.000006137E-03 5.19752570E-02 + 2.65733642E-01 7.59239318E-02 1.000006209E-03 5.19752573E-02 + 2.65836920E-01 7.59534398E-02 1.000006282E-03 5.19752575E-02 + 2.65940198E-01 7.59829479E-02 1.000006355E-03 5.19752581E-02 + 2.66043476E-01 7.60124560E-02 1.000006430E-03 5.19752586E-02 + 2.66146753E-01 7.60419640E-02 1.000006505E-03 5.19752589E-02 + 2.66250031E-01 7.60714721E-02 1.000006581E-03 5.19752594E-02 + 2.66353309E-01 7.61009802E-02 1.000006658E-03 5.19752595E-02 + 2.66456587E-01 7.61304882E-02 1.000006736E-03 5.19752601E-02 + 2.66559864E-01 7.61599963E-02 1.000006815E-03 5.19752606E-02 + 2.66663142E-01 7.61895044E-02 1.000006894E-03 5.19752611E-02 + 2.66766420E-01 7.62190125E-02 1.000006975E-03 5.19752614E-02 + 2.66869697E-01 7.62485205E-02 1.000007056E-03 5.19752619E-02 + 2.66972975E-01 7.62780286E-02 1.000007139E-03 5.19752622E-02 + 2.67076253E-01 7.63075367E-02 1.000007222E-03 5.19752625E-02 + 2.67179531E-01 7.63370447E-02 1.000007306E-03 5.19752629E-02 + 2.67282808E-01 7.63665528E-02 1.000007392E-03 5.19752633E-02 + 2.67386086E-01 7.63960609E-02 1.000007478E-03 5.19752636E-02 + 2.67489364E-01 7.64255690E-02 1.000007565E-03 5.19752642E-02 + 2.67592642E-01 7.64550770E-02 1.000007653E-03 5.19752647E-02 + 2.67695919E-01 7.64845851E-02 1.000007742E-03 5.19752649E-02 + 2.67799197E-01 7.65140932E-02 1.000007832E-03 5.19752652E-02 + 2.67902475E-01 7.65436013E-02 1.000007923E-03 5.19752657E-02 + 2.68005753E-01 7.65731093E-02 1.000008016E-03 5.19752662E-02 + 2.68109030E-01 7.66026174E-02 1.000008109E-03 5.19752667E-02 + 2.68212308E-01 7.66321255E-02 1.000008203E-03 5.19752671E-02 + 2.68315586E-01 7.66616336E-02 1.000008298E-03 5.19752675E-02 + 2.68418864E-01 7.66911417E-02 1.000008395E-03 5.19752681E-02 + 2.68522141E-01 7.67206497E-02 1.000008492E-03 5.19752685E-02 + 2.68625419E-01 7.67501578E-02 1.000008591E-03 5.19752688E-02 + 2.68728697E-01 7.67796659E-02 1.000008690E-03 5.19752691E-02 + 2.68831975E-01 7.68091740E-02 1.000008791E-03 5.19752696E-02 + 2.68935252E-01 7.68386821E-02 1.000008893E-03 5.19752702E-02 + 2.69038530E-01 7.68681902E-02 1.000008996E-03 5.19752707E-02 + 2.69141808E-01 7.68976982E-02 1.000009100E-03 5.19752709E-02 + 2.69245086E-01 7.69272063E-02 1.000009205E-03 5.19752714E-02 + 2.69348363E-01 7.69567144E-02 1.000009312E-03 5.19752719E-02 + 2.69451641E-01 7.69862225E-02 1.000009420E-03 5.19752722E-02 + 2.69554919E-01 7.70157306E-02 1.000009529E-03 5.19752728E-02 + 2.69658197E-01 7.70452387E-02 1.000009639E-03 5.19752732E-02 + 2.69761474E-01 7.70747468E-02 1.000009750E-03 5.19752738E-02 + 2.69864752E-01 7.71042548E-02 1.000009863E-03 5.19752741E-02 + 2.69968030E-01 7.71337629E-02 1.000009976E-03 5.19752746E-02 + 2.70071308E-01 7.71632710E-02 1.000010092E-03 5.19752752E-02 + 2.70174585E-01 7.71927791E-02 1.000010208E-03 5.19752755E-02 + 2.70277863E-01 7.72222872E-02 1.000010326E-03 5.19752758E-02 + 2.70381141E-01 7.72517953E-02 1.000010445E-03 5.19752765E-02 + 2.70484419E-01 7.72813034E-02 1.000010565E-03 5.19752769E-02 + 2.70587696E-01 7.73108115E-02 1.000010687E-03 5.19752772E-02 + 2.70690974E-01 7.73403196E-02 1.000010810E-03 5.19752779E-02 + 2.70794252E-01 7.73698277E-02 1.000010934E-03 5.19752781E-02 + 2.70897530E-01 7.73993358E-02 1.000011060E-03 5.19752786E-02 + 2.71000807E-01 7.74288438E-02 1.000011187E-03 5.19752794E-02 + 2.71104085E-01 7.74583519E-02 1.000011316E-03 5.19752797E-02 + 2.71207363E-01 7.74878600E-02 1.000011446E-03 5.19752802E-02 + 2.71310641E-01 7.75173681E-02 1.000011577E-03 5.19752806E-02 + 2.71413918E-01 7.75468762E-02 1.000011710E-03 5.19752812E-02 + 2.71517196E-01 7.75763843E-02 1.000011845E-03 5.19752816E-02 + 2.71620474E-01 7.76058924E-02 1.000011981E-03 5.19752821E-02 + 2.71723752E-01 7.76354005E-02 1.000012118E-03 5.19752825E-02 + 2.71827029E-01 7.76649086E-02 1.000012257E-03 5.19752830E-02 + 2.71930307E-01 7.76944167E-02 1.000012398E-03 5.19752833E-02 + 2.72033585E-01 7.77239248E-02 1.000012540E-03 5.19752841E-02 + 2.72136863E-01 7.77534329E-02 1.000012683E-03 5.19752843E-02 + 2.72240140E-01 7.77829410E-02 1.000012828E-03 5.19752850E-02 + 2.72343418E-01 7.78124491E-02 1.000012975E-03 5.19752854E-02 + 2.72446696E-01 7.78419572E-02 1.000013124E-03 5.19752859E-02 + 2.72549974E-01 7.78714653E-02 1.000013274E-03 5.19752865E-02 + 2.72653251E-01 7.79009734E-02 1.000013425E-03 5.19752868E-02 + 2.72756529E-01 7.79304815E-02 1.000013579E-03 5.19752873E-02 + 2.72859807E-01 7.79599896E-02 1.000013734E-03 5.19752878E-02 + 2.72963085E-01 7.79894978E-02 1.000013891E-03 5.19752884E-02 + 2.73066362E-01 7.80190059E-02 1.000014049E-03 5.19752887E-02 + 2.73169640E-01 7.80485140E-02 1.000014209E-03 5.19752895E-02 + 2.73272918E-01 7.80780221E-02 1.000014372E-03 5.19752900E-02 + 2.73376196E-01 7.81075302E-02 1.000014535E-03 5.19752902E-02 + 2.73479473E-01 7.81370383E-02 1.000014701E-03 5.19752909E-02 + 2.73582751E-01 7.81665464E-02 1.000014868E-03 5.19752913E-02 + 2.73686029E-01 7.81960545E-02 1.000015038E-03 5.19752918E-02 + 2.73789307E-01 7.82255626E-02 1.000015209E-03 5.19752924E-02 + 2.73892584E-01 7.82550707E-02 1.000015382E-03 5.19752927E-02 + 2.73995862E-01 7.82845789E-02 1.000015557E-03 5.19752936E-02 + 2.74099140E-01 7.83140870E-02 1.000015734E-03 5.19752938E-02 + 2.74202418E-01 7.83435951E-02 1.000015913E-03 5.19752945E-02 + 2.74305695E-01 7.83731032E-02 1.000016093E-03 5.19752951E-02 + 2.74408973E-01 7.84026113E-02 1.000016276E-03 5.19752954E-02 + 2.74512251E-01 7.84321194E-02 1.000016461E-03 5.19752959E-02 + 2.74615528E-01 7.84616275E-02 1.000016648E-03 5.19752966E-02 + 2.74718806E-01 7.84911357E-02 1.000016837E-03 5.19752971E-02 + 2.74822084E-01 7.85206438E-02 1.000017028E-03 5.19752974E-02 + 2.74925362E-01 7.85501519E-02 1.000017221E-03 5.19752980E-02 + 2.75028639E-01 7.85796600E-02 1.000017416E-03 5.19752985E-02 + 2.75131917E-01 7.86091681E-02 1.000017613E-03 5.19752992E-02 + 2.75235195E-01 7.86386763E-02 1.000017812E-03 5.19752998E-02 + 2.75338473E-01 7.86681844E-02 1.000018014E-03 5.19753001E-02 + 2.75441750E-01 7.86976925E-02 1.000018218E-03 5.19753006E-02 + 2.75545028E-01 7.87272006E-02 1.000018424E-03 5.19753011E-02 + 2.75648306E-01 7.87567087E-02 1.000018632E-03 5.19753020E-02 + 2.75751584E-01 7.87862169E-02 1.000018843E-03 5.19753025E-02 + 2.75854861E-01 7.88157250E-02 1.000019056E-03 5.19753028E-02 + 2.75958139E-01 7.88452331E-02 1.000019271E-03 5.19753034E-02 + 2.76061417E-01 7.88747412E-02 1.000019488E-03 5.19753039E-02 + 2.76164695E-01 7.89042494E-02 1.000019708E-03 5.19753044E-02 + 2.76267972E-01 7.89337575E-02 1.000019931E-03 5.19753051E-02 + 2.76371250E-01 7.89632656E-02 1.000020155E-03 5.19753056E-02 + 2.76474528E-01 7.89927738E-02 1.000020382E-03 5.19753063E-02 + 2.76577806E-01 7.90222819E-02 1.000020612E-03 5.19753069E-02 + 2.76681083E-01 7.90517900E-02 1.000020844E-03 5.19753074E-02 + 2.76784361E-01 7.90812982E-02 1.000021079E-03 5.19753078E-02 + 2.76887639E-01 7.91108063E-02 1.000021316E-03 5.19753083E-02 + 2.76990917E-01 7.91403144E-02 1.000021556E-03 5.19753091E-02 + 2.77094194E-01 7.91698226E-02 1.000021798E-03 5.19753096E-02 + 2.77197472E-01 7.91993307E-02 1.000022043E-03 5.19753102E-02 + 2.77300750E-01 7.92288388E-02 1.000022291E-03 5.19753108E-02 + 2.77404028E-01 7.92583470E-02 1.000022542E-03 5.19753114E-02 + 2.77507305E-01 7.92878551E-02 1.000022795E-03 5.19753117E-02 + 2.77610583E-01 7.93173632E-02 1.000023051E-03 5.19753123E-02 + 2.77713861E-01 7.93468714E-02 1.000023309E-03 5.19753131E-02 + 2.77817139E-01 7.93763795E-02 1.000023571E-03 5.19753136E-02 + 2.77920416E-01 7.94058876E-02 1.000023835E-03 5.19753141E-02 + 2.78023694E-01 7.94353958E-02 1.000024102E-03 5.19753146E-02 + 2.78126972E-01 7.94649039E-02 1.000024372E-03 5.19753152E-02 + 2.78230250E-01 7.94944121E-02 1.000024645E-03 5.19753160E-02 + 2.78333527E-01 7.95239202E-02 1.000024921E-03 5.19753166E-02 + 2.78436805E-01 7.95534284E-02 1.000025200E-03 5.19753170E-02 + 2.78540083E-01 7.95829365E-02 1.000025482E-03 5.19753178E-02 + 2.78643361E-01 7.96124446E-02 1.000025767E-03 5.19753181E-02 + 2.78746638E-01 7.96419528E-02 1.000026055E-03 5.19753189E-02 + 2.78849916E-01 7.96714609E-02 1.000026346E-03 5.19753194E-02 + 2.78953194E-01 7.97009691E-02 1.000026640E-03 5.19753199E-02 + 2.79056472E-01 7.97304772E-02 1.000026938E-03 5.19753207E-02 + 2.79159749E-01 7.97599854E-02 1.000027238E-03 5.19753213E-02 + 2.79263027E-01 7.97894935E-02 1.000027542E-03 5.19753219E-02 + 2.79366305E-01 7.98190017E-02 1.000027850E-03 5.19753225E-02 + 2.79469583E-01 7.98485098E-02 1.000028160E-03 5.19753231E-02 + 2.79572860E-01 7.98780180E-02 1.000028474E-03 5.19753236E-02 + 2.79676138E-01 7.99075261E-02 1.000028791E-03 5.19753241E-02 + 2.79779416E-01 7.99370343E-02 1.000029112E-03 5.19753249E-02 + 2.79882694E-01 7.99665424E-02 1.000029436E-03 5.19753255E-02 + 2.79985971E-01 7.99960506E-02 1.000029764E-03 5.19753262E-02 + 2.80089249E-01 8.00255588E-02 1.000030095E-03 5.19753267E-02 + 2.80192527E-01 8.00550669E-02 1.000030429E-03 5.19753272E-02 + 2.80295805E-01 8.00845751E-02 1.000030768E-03 5.19753279E-02 + 2.80399082E-01 8.01140832E-02 1.000031110E-03 5.19753285E-02 + 2.80502360E-01 8.01435914E-02 1.000031455E-03 5.19753291E-02 + 2.80605638E-01 8.01730995E-02 1.000031804E-03 5.19753299E-02 + 2.80708916E-01 8.02026077E-02 1.000032157E-03 5.19753304E-02 + 2.80812193E-01 8.02321159E-02 1.000032514E-03 5.19753312E-02 + 2.80915471E-01 8.02616240E-02 1.000032875E-03 5.19753316E-02 + 2.81018749E-01 8.02911322E-02 1.000033239E-03 5.19753323E-02 + 2.81122027E-01 8.03206404E-02 1.000033608E-03 5.19753331E-02 + 2.81225304E-01 8.03501485E-02 1.000033980E-03 5.19753336E-02 + 2.81328582E-01 8.03796567E-02 1.000034357E-03 5.19753343E-02 + 2.81431860E-01 8.04091649E-02 1.000034737E-03 5.19753349E-02 + 2.81535138E-01 8.04386730E-02 1.000035121E-03 5.19753354E-02 + 2.81638415E-01 8.04681812E-02 1.000035510E-03 5.19753361E-02 + 2.81741693E-01 8.04976894E-02 1.000035903E-03 5.19753368E-02 + 2.81844971E-01 8.05271975E-02 1.000036300E-03 5.19753374E-02 + 2.81948249E-01 8.05567057E-02 1.000036701E-03 5.19753380E-02 + 2.82051526E-01 8.05862139E-02 1.000037106E-03 5.19753389E-02 + 2.82154804E-01 8.06157220E-02 1.000037516E-03 5.19753394E-02 + 2.82258082E-01 8.06452302E-02 1.000037930E-03 5.19753402E-02 + 2.82361360E-01 8.06747384E-02 1.000038349E-03 5.19753407E-02 + 2.82464637E-01 8.07042466E-02 1.000038772E-03 5.19753415E-02 + 2.82567915E-01 8.07337547E-02 1.000039199E-03 5.19753421E-02 + 2.82671193E-01 8.07632629E-02 1.000039631E-03 5.19753429E-02 + 2.82774470E-01 8.07927711E-02 1.000040068E-03 5.19753433E-02 + 2.82877748E-01 8.08222793E-02 1.000040509E-03 5.19753440E-02 + 2.82981026E-01 8.08517874E-02 1.000040955E-03 5.19753448E-02 + 2.83084304E-01 8.08812956E-02 1.000041406E-03 5.19753455E-02 + 2.83187581E-01 8.09108038E-02 1.000041862E-03 5.19753461E-02 + 2.83290859E-01 8.09403120E-02 1.000042322E-03 5.19753468E-02 + 2.83394137E-01 8.09698202E-02 1.000042787E-03 5.19753475E-02 + 2.83497415E-01 8.09993284E-02 1.000043258E-03 5.19753482E-02 + 2.83600692E-01 8.10288365E-02 1.000043733E-03 5.19753488E-02 + 2.83703970E-01 8.10583447E-02 1.000044213E-03 5.19753495E-02 + 2.83807248E-01 8.10878529E-02 1.000044698E-03 5.19753503E-02 + 2.83910526E-01 8.11173611E-02 1.000045189E-03 5.19753510E-02 + 2.84013803E-01 8.11468693E-02 1.000045685E-03 5.19753516E-02 + 2.84117081E-01 8.11763775E-02 1.000046186E-03 5.19753524E-02 + 2.84220359E-01 8.12058857E-02 1.000046692E-03 5.19753529E-02 + 2.84323637E-01 8.12353939E-02 1.000047204E-03 5.19753537E-02 + 2.84426914E-01 8.12649020E-02 1.000047721E-03 5.19753545E-02 + 2.84530192E-01 8.12944102E-02 1.000048243E-03 5.19753552E-02 + 2.84633470E-01 8.13239184E-02 1.000048771E-03 5.19753558E-02 + 2.84736748E-01 8.13534266E-02 1.000049305E-03 5.19753565E-02 + 2.84840025E-01 8.13829348E-02 1.000049844E-03 5.19753574E-02 + 2.84943303E-01 8.14124430E-02 1.000050389E-03 5.19753579E-02 + 2.85046581E-01 8.14419512E-02 1.000050940E-03 5.19753587E-02 + 2.85149859E-01 8.14714594E-02 1.000051497E-03 5.19753594E-02 + 2.85253136E-01 8.15009676E-02 1.000052059E-03 5.19753602E-02 + 2.85356414E-01 8.15304758E-02 1.000052627E-03 5.19753608E-02 + 2.85459692E-01 8.15599840E-02 1.000053202E-03 5.19753616E-02 + 2.85562970E-01 8.15894922E-02 1.000053782E-03 5.19753623E-02 + 2.85666247E-01 8.16190004E-02 1.000054369E-03 5.19753630E-02 + 2.85769525E-01 8.16485086E-02 1.000054962E-03 5.19753638E-02 + 2.85872803E-01 8.16780168E-02 1.000055561E-03 5.19753645E-02 + 2.85976081E-01 8.17075250E-02 1.000056166E-03 5.19753653E-02 + 2.86079358E-01 8.17370332E-02 1.000056778E-03 5.19753660E-02 + 2.86182636E-01 8.17665414E-02 1.000057396E-03 5.19753668E-02 + 2.86285914E-01 8.17960497E-02 1.000058020E-03 5.19753675E-02 + 2.86389192E-01 8.18255579E-02 1.000058651E-03 5.19753683E-02 + 2.86492469E-01 8.18550661E-02 1.000059289E-03 5.19753689E-02 + 2.86595747E-01 8.18845743E-02 1.000059934E-03 5.19753698E-02 + 2.86699025E-01 8.19140825E-02 1.000060585E-03 5.19753706E-02 + 2.86802303E-01 8.19435907E-02 1.000061243E-03 5.19753713E-02 + 2.86905580E-01 8.19730989E-02 1.000061908E-03 5.19753720E-02 + 2.87008858E-01 8.20026071E-02 1.000062580E-03 5.19753729E-02 + 2.87112136E-01 8.20321154E-02 1.000063259E-03 5.19753735E-02 + 2.87215414E-01 8.20616236E-02 1.000063945E-03 5.19753743E-02 + 2.87318691E-01 8.20911318E-02 1.000064639E-03 5.19753751E-02 + 2.87421969E-01 8.21206400E-02 1.000065339E-03 5.19753759E-02 + 2.87525247E-01 8.21501482E-02 1.000066047E-03 5.19753765E-02 + 2.87628525E-01 8.21796565E-02 1.000066763E-03 5.19753773E-02 + 2.87731802E-01 8.22091647E-02 1.000067485E-03 5.19753780E-02 + 2.87835080E-01 8.22386729E-02 1.000068216E-03 5.19753790E-02 + 2.87938358E-01 8.22681811E-02 1.000068954E-03 5.19753798E-02 + 2.88041636E-01 8.22976894E-02 1.000069700E-03 5.19753805E-02 + 2.88144913E-01 8.23271976E-02 1.000070453E-03 5.19753813E-02 + 2.88248191E-01 8.23567058E-02 1.000071215E-03 5.19753820E-02 + 2.88351469E-01 8.23862140E-02 1.000071984E-03 5.19753829E-02 + 2.88454747E-01 8.24157223E-02 1.000072762E-03 5.19753837E-02 + 2.88558024E-01 8.24452305E-02 1.000073547E-03 5.19753845E-02 + 2.88661302E-01 8.24747387E-02 1.000074341E-03 5.19753852E-02 + 2.88764580E-01 8.25042470E-02 1.000075143E-03 5.19753860E-02 + 2.88867858E-01 8.25337552E-02 1.000075953E-03 5.19753868E-02 + 2.88971135E-01 8.25632634E-02 1.000076772E-03 5.19753876E-02 + 2.89074413E-01 8.25927717E-02 1.000077599E-03 5.19753884E-02 + 2.89177691E-01 8.26222799E-02 1.000078435E-03 5.19753893E-02 + 2.89280969E-01 8.26517881E-02 1.000079280E-03 5.19753900E-02 + 2.89384246E-01 8.26812964E-02 1.000080133E-03 5.19753910E-02 + 2.89487524E-01 8.27108046E-02 1.000080996E-03 5.19753917E-02 + 2.89590802E-01 8.27403129E-02 1.000081867E-03 5.19753926E-02 + 2.89694080E-01 8.27698211E-02 1.000082747E-03 5.19753934E-02 + 2.89797357E-01 8.27993293E-02 1.000083637E-03 5.19753942E-02 + 2.89900635E-01 8.28288376E-02 1.000084535E-03 5.19753951E-02 + 2.90003913E-01 8.28583458E-02 1.000085443E-03 5.19753959E-02 + 2.90107191E-01 8.28878541E-02 1.000086361E-03 5.19753967E-02 + 2.90210468E-01 8.29173623E-02 1.000087288E-03 5.19753974E-02 + 2.90313746E-01 8.29468706E-02 1.000088225E-03 5.19753984E-02 + 2.90417024E-01 8.29763788E-02 1.000089171E-03 5.19753992E-02 + 2.90520301E-01 8.30058871E-02 1.000090127E-03 5.19754000E-02 + 2.90623579E-01 8.30353953E-02 1.000091093E-03 5.19754008E-02 + 2.90726857E-01 8.30649036E-02 1.000092069E-03 5.19754018E-02 + 2.90830135E-01 8.30944118E-02 1.000093055E-03 5.19754026E-02 + 2.90933412E-01 8.31239201E-02 1.000094052E-03 5.19754035E-02 + 2.91036690E-01 8.31534283E-02 1.000095058E-03 5.19754043E-02 + 2.91139968E-01 8.31829366E-02 1.000096075E-03 5.19754052E-02 + 2.91243246E-01 8.32124449E-02 1.000097103E-03 5.19754059E-02 + 2.91346523E-01 8.32419531E-02 1.000098141E-03 5.19754069E-02 + 2.91449801E-01 8.32714614E-02 1.000099190E-03 5.19754076E-02 + 2.91553079E-01 8.33009696E-02 1.000100250E-03 5.19754086E-02 + 2.91656357E-01 8.33304779E-02 1.000101320E-03 5.19754094E-02 + 2.91759634E-01 8.33599862E-02 1.000102402E-03 5.19754103E-02 + 2.91862912E-01 8.33894944E-02 1.000103495E-03 5.19754112E-02 + 2.91966190E-01 8.34190027E-02 1.000104599E-03 5.19754121E-02 + 2.92069468E-01 8.34485110E-02 1.000105715E-03 5.19754130E-02 + 2.92172745E-01 8.34780192E-02 1.000106842E-03 5.19754138E-02 + 2.92276023E-01 8.35075275E-02 1.000107980E-03 5.19754147E-02 + 2.92379301E-01 8.35370358E-02 1.000109131E-03 5.19754156E-02 + 2.92482579E-01 8.35665440E-02 1.000110293E-03 5.19754165E-02 + 2.92585856E-01 8.35960523E-02 1.000111467E-03 5.19754174E-02 + 2.92689134E-01 8.36255606E-02 1.000112653E-03 5.19754183E-02 + 2.92792412E-01 8.36550689E-02 1.000113852E-03 5.19754192E-02 + 2.92895690E-01 8.36845771E-02 1.000115063E-03 5.19754201E-02 + 2.92998967E-01 8.37140854E-02 1.000116286E-03 5.19754211E-02 + 2.93102245E-01 8.37435937E-02 1.000117522E-03 5.19754220E-02 + 2.93205523E-01 8.37731020E-02 1.000118770E-03 5.19754229E-02 + 2.93308801E-01 8.38026103E-02 1.000120031E-03 5.19754237E-02 + 2.93412078E-01 8.38321185E-02 1.000121306E-03 5.19754246E-02 + 2.93515356E-01 8.38616268E-02 1.000122593E-03 5.19754255E-02 + 2.93618634E-01 8.38911351E-02 1.000123893E-03 5.19754266E-02 + 2.93721912E-01 8.39206434E-02 1.000125207E-03 5.19754274E-02 + 2.93825189E-01 8.39501517E-02 1.000126534E-03 5.19754283E-02 + 2.93928467E-01 8.39796600E-02 1.000127875E-03 5.19754292E-02 + 2.94031745E-01 8.40091683E-02 1.000129230E-03 5.19754303E-02 + 2.94135023E-01 8.40386765E-02 1.000130598E-03 5.19754311E-02 + 2.94238300E-01 8.40681848E-02 1.000131981E-03 5.19754321E-02 + 2.94341578E-01 8.40976931E-02 1.000133377E-03 5.19754330E-02 + 2.94444856E-01 8.41272014E-02 1.000134788E-03 5.19754340E-02 + 2.94548134E-01 8.41567097E-02 1.000136213E-03 5.19754350E-02 + 2.94651411E-01 8.41862180E-02 1.000137653E-03 5.19754359E-02 + 2.94754689E-01 8.42157263E-02 1.000139108E-03 5.19754369E-02 + 2.94857967E-01 8.42452346E-02 1.000140577E-03 5.19754377E-02 + 2.94961245E-01 8.42747429E-02 1.000142062E-03 5.19754388E-02 + 2.95064522E-01 8.43042512E-02 1.000143561E-03 5.19754397E-02 + 2.95167800E-01 8.43337595E-02 1.000145076E-03 5.19754407E-02 + 2.95271078E-01 8.43632678E-02 1.000146606E-03 5.19754416E-02 + 2.95374356E-01 8.43927761E-02 1.000148152E-03 5.19754426E-02 + 2.95477633E-01 8.44222844E-02 1.000149714E-03 5.19754436E-02 + 2.95580911E-01 8.44517927E-02 1.000151291E-03 5.19754446E-02 + 2.95684189E-01 8.44813011E-02 1.000152885E-03 5.19754456E-02 + 2.95787467E-01 8.45108094E-02 1.000154495E-03 5.19754465E-02 + 2.95890744E-01 8.45403177E-02 1.000156121E-03 5.19754475E-02 + 2.95994022E-01 8.45698260E-02 1.000157763E-03 5.19754485E-02 + 2.96097300E-01 8.45993343E-02 1.000159423E-03 5.19754495E-02 + 2.96200578E-01 8.46288426E-02 1.000161099E-03 5.19754505E-02 + 2.96303855E-01 8.46583509E-02 1.000162792E-03 5.19754515E-02 + 2.96407133E-01 8.46878593E-02 1.000164503E-03 5.19754524E-02 + 2.96510411E-01 8.47173676E-02 1.000166231E-03 5.19754535E-02 + 2.96613689E-01 8.47468759E-02 1.000167976E-03 5.19754545E-02 + 2.96716966E-01 8.47763842E-02 1.000169739E-03 5.19754555E-02 + 2.96820244E-01 8.48058925E-02 1.000171520E-03 5.19754565E-02 + 2.96923522E-01 8.48354009E-02 1.000173319E-03 5.19754575E-02 + 2.97026800E-01 8.48649092E-02 1.000175136E-03 5.19754585E-02 + 2.97130077E-01 8.48944175E-02 1.000176972E-03 5.19754595E-02 + 2.97233355E-01 8.49239259E-02 1.000178826E-03 5.19754606E-02 + 2.97336633E-01 8.49534342E-02 1.000180699E-03 5.19754616E-02 + 2.97439911E-01 8.49829425E-02 1.000182591E-03 5.19754627E-02 + 2.97543188E-01 8.50124508E-02 1.000184502E-03 5.19754637E-02 + 2.97646466E-01 8.50419592E-02 1.000186433E-03 5.19754647E-02 + 2.97749744E-01 8.50714675E-02 1.000188383E-03 5.19754657E-02 + 2.97853022E-01 8.51009759E-02 1.000190352E-03 5.19754668E-02 + 2.97956299E-01 8.51304842E-02 1.000192342E-03 5.19754678E-02 + 2.98059577E-01 8.51599925E-02 1.000194351E-03 5.19754688E-02 + 2.98162855E-01 8.51895009E-02 1.000196381E-03 5.19754699E-02 + 2.98266132E-01 8.52190092E-02 1.000198432E-03 5.19754709E-02 + 2.98369410E-01 8.52485176E-02 1.000200503E-03 5.19754720E-02 + 2.98472688E-01 8.52780259E-02 1.000202595E-03 5.19754730E-02 + 2.98575966E-01 8.53075342E-02 1.000204708E-03 5.19754741E-02 + 2.98679243E-01 8.53370426E-02 1.000206842E-03 5.19754753E-02 + 2.98782521E-01 8.53665509E-02 1.000208998E-03 5.19754762E-02 + 2.98885799E-01 8.53960593E-02 1.000211175E-03 5.19754773E-02 + 2.98989077E-01 8.54255676E-02 1.000213375E-03 5.19754785E-02 + 2.99092354E-01 8.54550760E-02 1.000215596E-03 5.19754794E-02 + 2.99195632E-01 8.54845844E-02 1.000217840E-03 5.19754806E-02 + 2.99298910E-01 8.55140927E-02 1.000220107E-03 5.19754817E-02 + 2.99402188E-01 8.55436011E-02 1.000222396E-03 5.19754828E-02 + 2.99505465E-01 8.55731094E-02 1.000224708E-03 5.19754838E-02 + 2.99608743E-01 8.56026178E-02 1.000227043E-03 5.19754849E-02 + 2.99712021E-01 8.56321261E-02 1.000229402E-03 5.19754861E-02 + 2.99815299E-01 8.56616345E-02 1.000231785E-03 5.19754871E-02 + 2.99918576E-01 8.56911429E-02 1.000234191E-03 5.19754883E-02 + 3.00021854E-01 8.57206512E-02 1.000236622E-03 5.19754894E-02 + 3.00125132E-01 8.57501596E-02 1.000239077E-03 5.19754905E-02 + 3.00228410E-01 8.57796680E-02 1.000241557E-03 5.19754917E-02 + 3.00331687E-01 8.58091763E-02 1.000244061E-03 5.19754927E-02 + 3.00434965E-01 8.58386847E-02 1.000246590E-03 5.19754938E-02 + 3.00538243E-01 8.58681931E-02 1.000249145E-03 5.19754949E-02 + 3.00641521E-01 8.58977015E-02 1.000251726E-03 5.19754960E-02 + 3.00744798E-01 8.59272098E-02 1.000254332E-03 5.19754973E-02 + 3.00848076E-01 8.59567182E-02 1.000256964E-03 5.19754983E-02 + 3.00951354E-01 8.59862266E-02 1.000259623E-03 5.19754994E-02 + 3.01054632E-01 8.60157350E-02 1.000262308E-03 5.19755006E-02 + 3.01157909E-01 8.60452434E-02 1.000265020E-03 5.19755017E-02 + 3.01261187E-01 8.60747517E-02 1.000267759E-03 5.19755030E-02 + 3.01364465E-01 8.61042601E-02 1.000270525E-03 5.19755041E-02 + 3.01467743E-01 8.61337685E-02 1.000273319E-03 5.19755053E-02 + 3.01571020E-01 8.61632769E-02 1.000276141E-03 5.19755064E-02 + 3.01674298E-01 8.61927853E-02 1.000278991E-03 5.19755075E-02 + 3.01777576E-01 8.62222937E-02 1.000281870E-03 5.19755087E-02 + 3.01880854E-01 8.62518021E-02 1.000284777E-03 5.19755099E-02 + 3.01984131E-01 8.62813105E-02 1.000287713E-03 5.19755110E-02 + 3.02087409E-01 8.63108189E-02 1.000290678E-03 5.19755122E-02 + 3.02190687E-01 8.63403273E-02 1.000293673E-03 5.19755133E-02 + 3.02293965E-01 8.63698357E-02 1.000296698E-03 5.19755146E-02 + 3.02397242E-01 8.63993441E-02 1.000299753E-03 5.19755157E-02 + 3.02500520E-01 8.64288525E-02 1.000302838E-03 5.19755170E-02 + 3.02603798E-01 8.64583609E-02 1.000305954E-03 5.19755181E-02 + 3.02707076E-01 8.64878693E-02 1.000309100E-03 5.19755193E-02 + 3.02810353E-01 8.65173777E-02 1.000312278E-03 5.19755206E-02 + 3.02913631E-01 8.65468861E-02 1.000315488E-03 5.19755218E-02 + 3.03016909E-01 8.65763945E-02 1.000318729E-03 5.19755230E-02 + 3.03120187E-01 8.66059029E-02 1.000322003E-03 5.19755242E-02 + 3.03223464E-01 8.66354113E-02 1.000325309E-03 5.19755254E-02 + 3.03326742E-01 8.66649197E-02 1.000328648E-03 5.19755266E-02 + 3.03430020E-01 8.66944282E-02 1.000332020E-03 5.19755277E-02 + 3.03533298E-01 8.67239366E-02 1.000335425E-03 5.19755290E-02 + 3.03636575E-01 8.67534450E-02 1.000338864E-03 5.19755302E-02 + 3.03739853E-01 8.67829534E-02 1.000342337E-03 5.19755315E-02 + 3.03843131E-01 8.68124618E-02 1.000345845E-03 5.19755326E-02 + 3.03946409E-01 8.68419703E-02 1.000349387E-03 5.19755339E-02 + 3.04049686E-01 8.68714787E-02 1.000352965E-03 5.19755352E-02 + 3.04152964E-01 8.69009871E-02 1.000356577E-03 5.19755364E-02 + 3.04256242E-01 8.69304955E-02 1.000360226E-03 5.19755376E-02 + 3.04359520E-01 8.69600040E-02 1.000363910E-03 5.19755389E-02 + 3.04462797E-01 8.69895124E-02 1.000367631E-03 5.19755401E-02 + 3.04566075E-01 8.70190208E-02 1.000371388E-03 5.19755414E-02 + 3.04669353E-01 8.70485293E-02 1.000375183E-03 5.19755428E-02 + 3.04772631E-01 8.70780377E-02 1.000379015E-03 5.19755440E-02 + 3.04875908E-01 8.71075461E-02 1.000382885E-03 5.19755452E-02 + 3.04979186E-01 8.71370546E-02 1.000386793E-03 5.19755465E-02 + 3.05082464E-01 8.71665630E-02 1.000390740E-03 5.19755477E-02 + 3.05185742E-01 8.71960715E-02 1.000394725E-03 5.19755491E-02 + 3.05289019E-01 8.72255799E-02 1.000398750E-03 5.19755503E-02 + 3.05392297E-01 8.72550884E-02 1.000402814E-03 5.19755517E-02 + 3.05495575E-01 8.72845968E-02 1.000406919E-03 5.19755530E-02 + 3.05598853E-01 8.73141053E-02 1.000411063E-03 5.19755542E-02 + 3.05702130E-01 8.73436137E-02 1.000415249E-03 5.19755556E-02 + 3.05805408E-01 8.73731222E-02 1.000419476E-03 5.19755569E-02 + 3.05908686E-01 8.74026306E-02 1.000423744E-03 5.19755581E-02 + 3.06011963E-01 8.74321391E-02 1.000428054E-03 5.19755594E-02 + 3.06115241E-01 8.74616475E-02 1.000432406E-03 5.19755607E-02 + 3.06218519E-01 8.74911560E-02 1.000436802E-03 5.19755620E-02 + 3.06321797E-01 8.75206644E-02 1.000441240E-03 5.19755634E-02 + 3.06425074E-01 8.75501729E-02 1.000445722E-03 5.19755647E-02 + 3.06528352E-01 8.75796814E-02 1.000450248E-03 5.19755661E-02 + 3.06631630E-01 8.76091898E-02 1.000454818E-03 5.19755674E-02 + 3.06734908E-01 8.76386983E-02 1.000459433E-03 5.19755687E-02 + 3.06838185E-01 8.76682068E-02 1.000464093E-03 5.19755700E-02 + 3.06941463E-01 8.76977153E-02 1.000468799E-03 5.19755714E-02 + 3.07044741E-01 8.77272237E-02 1.000473551E-03 5.19755727E-02 + 3.07148019E-01 8.77567322E-02 1.000478350E-03 5.19755741E-02 + 3.07251296E-01 8.77862407E-02 1.000483195E-03 5.19755754E-02 + 3.07354574E-01 8.78157492E-02 1.000488088E-03 5.19755768E-02 + 3.07457852E-01 8.78452576E-02 1.000493029E-03 5.19755782E-02 + 3.07561130E-01 8.78747661E-02 1.000498018E-03 5.19755795E-02 + 3.07664407E-01 8.79042746E-02 1.000503056E-03 5.19755809E-02 + 3.07767685E-01 8.79337831E-02 1.000508143E-03 5.19755823E-02 + 3.07870963E-01 8.79632916E-02 1.000513279E-03 5.19755837E-02 + 3.07974241E-01 8.79928001E-02 1.000518466E-03 5.19755850E-02 + 3.08077518E-01 8.80223086E-02 1.000523703E-03 5.19755865E-02 + 3.08180796E-01 8.80518171E-02 1.000528992E-03 5.19755879E-02 + 3.08284074E-01 8.80813256E-02 1.000534332E-03 5.19755893E-02 + 3.08387352E-01 8.81108340E-02 1.000539724E-03 5.19755906E-02 + 3.08490629E-01 8.81403425E-02 1.000545168E-03 5.19755920E-02 + 3.08593907E-01 8.81698510E-02 1.000550666E-03 5.19755935E-02 + 3.08697185E-01 8.81993595E-02 1.000556217E-03 5.19755949E-02 + 3.08800463E-01 8.82288681E-02 1.000561822E-03 5.19755963E-02 + 3.08903740E-01 8.82583766E-02 1.000567482E-03 5.19755977E-02 + 3.09007018E-01 8.82878851E-02 1.000573197E-03 5.19755992E-02 + 3.09110296E-01 8.83173936E-02 1.000578967E-03 5.19756006E-02 + 3.09213574E-01 8.83469021E-02 1.000584793E-03 5.19756020E-02 + 3.09316851E-01 8.83764106E-02 1.000590676E-03 5.19756034E-02 + 3.09420129E-01 8.84059191E-02 1.000596616E-03 5.19756049E-02 + 3.09523407E-01 8.84354276E-02 1.000602614E-03 5.19756063E-02 + 3.09626685E-01 8.84649362E-02 1.000608670E-03 5.19756078E-02 + 3.09729962E-01 8.84944447E-02 1.000614785E-03 5.19756092E-02 + 3.09833240E-01 8.85239532E-02 1.000620959E-03 5.19756107E-02 + 3.09936518E-01 8.85534617E-02 1.000627193E-03 5.19756121E-02 + 3.10039796E-01 8.85829702E-02 1.000633487E-03 5.19756136E-02 + 3.10143073E-01 8.86124788E-02 1.000639842E-03 5.19756151E-02 + 3.10246351E-01 8.86419873E-02 1.000646259E-03 5.19756165E-02 + 3.10349629E-01 8.86714958E-02 1.000652738E-03 5.19756180E-02 + 3.10452907E-01 8.87010044E-02 1.000659280E-03 5.19756195E-02 + 3.10556184E-01 8.87305129E-02 1.000665885E-03 5.19756210E-02 + 3.10659462E-01 8.87600214E-02 1.000672554E-03 5.19756225E-02 + 3.10762740E-01 8.87895300E-02 1.000679287E-03 5.19756239E-02 + 3.10866018E-01 8.88190385E-02 1.000686086E-03 5.19756255E-02 + 3.10969295E-01 8.88485471E-02 1.000692950E-03 5.19756270E-02 + 3.11072573E-01 8.88780556E-02 1.000699880E-03 5.19756285E-02 + 3.11175851E-01 8.89075642E-02 1.000706877E-03 5.19756300E-02 + 3.11279129E-01 8.89370727E-02 1.000713942E-03 5.19756315E-02 + 3.11382406E-01 8.89665813E-02 1.000721075E-03 5.19756330E-02 + 3.11485684E-01 8.89960898E-02 1.000728277E-03 5.19756346E-02 + 3.11588962E-01 8.90255984E-02 1.000735548E-03 5.19756360E-02 + 3.11692240E-01 8.90551069E-02 1.000742889E-03 5.19756376E-02 + 3.11795517E-01 8.90846155E-02 1.000750301E-03 5.19756391E-02 + 3.11898795E-01 8.91141241E-02 1.000757784E-03 5.19756406E-02 + 3.12002073E-01 8.91436326E-02 1.000765340E-03 5.19756422E-02 + 3.12105351E-01 8.91731412E-02 1.000772968E-03 5.19756437E-02 + 3.12208628E-01 8.92026498E-02 1.000780669E-03 5.19756453E-02 + 3.12311906E-01 8.92321583E-02 1.000788445E-03 5.19756469E-02 + 3.12415184E-01 8.92616669E-02 1.000796295E-03 5.19756485E-02 + 3.12518462E-01 8.92911755E-02 1.000804220E-03 5.19756500E-02 + 3.12621739E-01 8.93206840E-02 1.000812222E-03 5.19756516E-02 + 3.12725017E-01 8.93501926E-02 1.000820301E-03 5.19756532E-02 + 3.12828295E-01 8.93797012E-02 1.000828457E-03 5.19756547E-02 + 3.12931573E-01 8.94092098E-02 1.000836691E-03 5.19756563E-02 + 3.13034850E-01 8.94387184E-02 1.000845005E-03 5.19756579E-02 + 3.13138128E-01 8.94682270E-02 1.000853398E-03 5.19756595E-02 + 3.13241406E-01 8.94977355E-02 1.000861872E-03 5.19756611E-02 + 3.13344684E-01 8.95272441E-02 1.000870426E-03 5.19756627E-02 + 3.13447961E-01 8.95567527E-02 1.000879063E-03 5.19756643E-02 + 3.13551239E-01 8.95862613E-02 1.000887782E-03 5.19756659E-02 + 3.13654517E-01 8.96157699E-02 1.000896585E-03 5.19756675E-02 + 3.13757795E-01 8.96452785E-02 1.000905472E-03 5.19756692E-02 + 3.13861072E-01 8.96747871E-02 1.000914445E-03 5.19756708E-02 + 3.13964350E-01 8.97042957E-02 1.000923502E-03 5.19756724E-02 + 3.14067628E-01 8.97338043E-02 1.000932647E-03 5.19756741E-02 + 3.14170905E-01 8.97633129E-02 1.000941879E-03 5.19756757E-02 + 3.14274183E-01 8.97928215E-02 1.000951199E-03 5.19756773E-02 + 3.14377461E-01 8.98223301E-02 1.000960608E-03 5.19756790E-02 + 3.14480739E-01 8.98518388E-02 1.000970106E-03 5.19756806E-02 + 3.14584016E-01 8.98813474E-02 1.000979696E-03 5.19756823E-02 + 3.14687294E-01 8.99108560E-02 1.000989377E-03 5.19756839E-02 + 3.14790572E-01 8.99403646E-02 1.000999150E-03 5.19756856E-02 + 3.14893850E-01 8.99698732E-02 1.001009016E-03 5.19756873E-02 + 3.14997127E-01 8.99993819E-02 1.001018977E-03 5.19756889E-02 + 3.15100405E-01 9.00288905E-02 1.001029032E-03 5.19756906E-02 + 3.15203683E-01 9.00583991E-02 1.001039183E-03 5.19756923E-02 + 3.15306961E-01 9.00879077E-02 1.001049430E-03 5.19756940E-02 + 3.15410238E-01 9.01174164E-02 1.001059775E-03 5.19756957E-02 + 3.15513516E-01 9.01469250E-02 1.001070218E-03 5.19756974E-02 + 3.15616794E-01 9.01764336E-02 1.001080761E-03 5.19756991E-02 + 3.15720072E-01 9.02059423E-02 1.001091404E-03 5.19757008E-02 + 3.15823349E-01 9.02354509E-02 1.001102148E-03 5.19757025E-02 + 3.15926627E-01 9.02649596E-02 1.001112994E-03 5.19757042E-02 + 3.16029905E-01 9.02944682E-02 1.001123942E-03 5.19757060E-02 + 3.16133183E-01 9.03239769E-02 1.001134995E-03 5.19757077E-02 + 3.16236460E-01 9.03534855E-02 1.001146153E-03 5.19757094E-02 + 3.16339738E-01 9.03829942E-02 1.001157416E-03 5.19757112E-02 + 3.16443016E-01 9.04125028E-02 1.001168786E-03 5.19757129E-02 + 3.16546294E-01 9.04420115E-02 1.001180264E-03 5.19757147E-02 + 3.16649571E-01 9.04715201E-02 1.001191851E-03 5.19757164E-02 + 3.16752849E-01 9.05010288E-02 1.001203547E-03 5.19757182E-02 + 3.16856127E-01 9.05305375E-02 1.001215354E-03 5.19757200E-02 + 3.16959405E-01 9.05600461E-02 1.001227273E-03 5.19757217E-02 + 3.17062682E-01 9.05895548E-02 1.001239305E-03 5.19757235E-02 + 3.17165960E-01 9.06190635E-02 1.001251450E-03 5.19757252E-02 + 3.17269238E-01 9.06485721E-02 1.001263710E-03 5.19757270E-02 + 3.17372516E-01 9.06780808E-02 1.001276086E-03 5.19757288E-02 + 3.17475793E-01 9.07075895E-02 1.001288578E-03 5.19757306E-02 + 3.17579071E-01 9.07370982E-02 1.001301189E-03 5.19757324E-02 + 3.17682349E-01 9.07666069E-02 1.001313919E-03 5.19757342E-02 + 3.17785627E-01 9.07961155E-02 1.001326769E-03 5.19757360E-02 + 3.17888904E-01 9.08256242E-02 1.001339740E-03 5.19757378E-02 + 3.17992182E-01 9.08551329E-02 1.001352833E-03 5.19757397E-02 + 3.18095460E-01 9.08846416E-02 1.001366049E-03 5.19757414E-02 + 3.18198738E-01 9.09141503E-02 1.001379391E-03 5.19757433E-02 + 3.18302015E-01 9.09436590E-02 1.001392857E-03 5.19757451E-02 + 3.18405293E-01 9.09731677E-02 1.001406451E-03 5.19757469E-02 + 3.18508571E-01 9.10026764E-02 1.001420172E-03 5.19757488E-02 + 3.18611849E-01 9.10321851E-02 1.001434023E-03 5.19757506E-02 + 3.18715126E-01 9.10616938E-02 1.001448004E-03 5.19757525E-02 + 3.18818404E-01 9.10912025E-02 1.001462116E-03 5.19757544E-02 + 3.18921682E-01 9.11207112E-02 1.001476360E-03 5.19757562E-02 + 3.19024960E-01 9.11502199E-02 1.001490739E-03 5.19757581E-02 + 3.19128237E-01 9.11797287E-02 1.001505253E-03 5.19757600E-02 + 3.19231515E-01 9.12092374E-02 1.001519902E-03 5.19757618E-02 + 3.19334793E-01 9.12387461E-02 1.001534689E-03 5.19757637E-02 + 3.19438071E-01 9.12682548E-02 1.001549615E-03 5.19757656E-02 + 3.19541348E-01 9.12977635E-02 1.001564681E-03 5.19757674E-02 + 3.19644626E-01 9.13272723E-02 1.001579888E-03 5.19757694E-02 + 3.19747904E-01 9.13567810E-02 1.001595238E-03 5.19757713E-02 + 3.19851182E-01 9.13862897E-02 1.001610731E-03 5.19757732E-02 + 3.19954459E-01 9.14157985E-02 1.001626369E-03 5.19757751E-02 + 3.20057737E-01 9.14453072E-02 1.001642154E-03 5.19757770E-02 + 3.20161015E-01 9.14748160E-02 1.001658086E-03 5.19757790E-02 + 3.20264293E-01 9.15043247E-02 1.001674167E-03 5.19757809E-02 + 3.20367570E-01 9.15338334E-02 1.001690398E-03 5.19757828E-02 + 3.20470848E-01 9.15633422E-02 1.001706782E-03 5.19757847E-02 + 3.20574126E-01 9.15928509E-02 1.001723318E-03 5.19757867E-02 + 3.20677404E-01 9.16223597E-02 1.001740008E-03 5.19757886E-02 + 3.20780681E-01 9.16518684E-02 1.001756855E-03 5.19757906E-02 + 3.20883959E-01 9.16813772E-02 1.001773858E-03 5.19757926E-02 + 3.20987237E-01 9.17108860E-02 1.001791020E-03 5.19757946E-02 + 3.21090515E-01 9.17403947E-02 1.001808342E-03 5.19757965E-02 + 3.21193792E-01 9.17699035E-02 1.001825826E-03 5.19757985E-02 + 3.21297070E-01 9.17994123E-02 1.001843472E-03 5.19758005E-02 + 3.21400348E-01 9.18289210E-02 1.001861283E-03 5.19758025E-02 + 3.21503626E-01 9.18584298E-02 1.001879259E-03 5.19758044E-02 + 3.21606903E-01 9.18879386E-02 1.001897403E-03 5.19758064E-02 + 3.21710181E-01 9.19174474E-02 1.001915716E-03 5.19758085E-02 + 3.21813459E-01 9.19469561E-02 1.001934198E-03 5.19758104E-02 + 3.21916736E-01 9.19764649E-02 1.001952853E-03 5.19758125E-02 + 3.22020014E-01 9.20059737E-02 1.001971681E-03 5.19758145E-02 + 3.22123292E-01 9.20354825E-02 1.001990684E-03 5.19758165E-02 + 3.22226570E-01 9.20649913E-02 1.002009863E-03 5.19758186E-02 + 3.22329847E-01 9.20945001E-02 1.002029220E-03 5.19758206E-02 + 3.22433125E-01 9.21240089E-02 1.002048757E-03 5.19758226E-02 + 3.22536403E-01 9.21535177E-02 1.002068475E-03 5.19758247E-02 + 3.22639681E-01 9.21830265E-02 1.002088375E-03 5.19758267E-02 + 3.22742958E-01 9.22125353E-02 1.002108460E-03 5.19758288E-02 + 3.22846236E-01 9.22420441E-02 1.002128731E-03 5.19758308E-02 + 3.22949514E-01 9.22715529E-02 1.002149190E-03 5.19758330E-02 + 3.23052792E-01 9.23010617E-02 1.002169838E-03 5.19758350E-02 + 3.23156069E-01 9.23305705E-02 1.002190677E-03 5.19758371E-02 + 3.23259347E-01 9.23600794E-02 1.002211709E-03 5.19758392E-02 + 3.23362625E-01 9.23895882E-02 1.002232936E-03 5.19758413E-02 + 3.23465903E-01 9.24190970E-02 1.002254358E-03 5.19758434E-02 + 3.23569180E-01 9.24486058E-02 1.002275979E-03 5.19758455E-02 + 3.23672458E-01 9.24781147E-02 1.002297799E-03 5.19758476E-02 + 3.23775736E-01 9.25076235E-02 1.002319820E-03 5.19758497E-02 + 3.23879014E-01 9.25371323E-02 1.002342045E-03 5.19758518E-02 + 3.23982291E-01 9.25666412E-02 1.002364474E-03 5.19758540E-02 + 3.24085569E-01 9.25961500E-02 1.002387111E-03 5.19758561E-02 + 3.24188847E-01 9.26256588E-02 1.002409956E-03 5.19758582E-02 + 3.24292125E-01 9.26551677E-02 1.002433011E-03 5.19758604E-02 + 3.24395402E-01 9.26846765E-02 1.002456279E-03 5.19758625E-02 + 3.24498680E-01 9.27141854E-02 1.002479761E-03 5.19758647E-02 + 3.24601958E-01 9.27436942E-02 1.002503459E-03 5.19758669E-02 + 3.24705236E-01 9.27732031E-02 1.002527375E-03 5.19758690E-02 + 3.24808513E-01 9.28027120E-02 1.002551511E-03 5.19758712E-02 + 3.24911791E-01 9.28322208E-02 1.002575868E-03 5.19758734E-02 + 3.25015069E-01 9.28617297E-02 1.002600450E-03 5.19758756E-02 + 3.25118347E-01 9.28912386E-02 1.002625257E-03 5.19758778E-02 + 3.25221624E-01 9.29207474E-02 1.002650292E-03 5.19758800E-02 + 3.25324902E-01 9.29502563E-02 1.002675557E-03 5.19758822E-02 + 3.25428180E-01 9.29797652E-02 1.002701053E-03 5.19758844E-02 + 3.25531458E-01 9.30092741E-02 1.002726783E-03 5.19758866E-02 + 3.25634735E-01 9.30387829E-02 1.002752749E-03 5.19758888E-02 + 3.25738013E-01 9.30682918E-02 1.002778953E-03 5.19758911E-02 + 3.25841291E-01 9.30978007E-02 1.002805397E-03 5.19758933E-02 + 3.25944569E-01 9.31273096E-02 1.002832083E-03 5.19758955E-02 + 3.26047846E-01 9.31568185E-02 1.002859013E-03 5.19758978E-02 + 3.26151124E-01 9.31863274E-02 1.002886189E-03 5.19759001E-02 + 3.26254402E-01 9.32158363E-02 1.002913614E-03 5.19759023E-02 + 3.26357680E-01 9.32453452E-02 1.002941290E-03 5.19759045E-02 + 3.26460957E-01 9.32748541E-02 1.002969218E-03 5.19759068E-02 + 3.26564235E-01 9.33043630E-02 1.002997402E-03 5.19759091E-02 + 3.26667513E-01 9.33338719E-02 1.003025843E-03 5.19759114E-02 + 3.26770791E-01 9.33633808E-02 1.003054543E-03 5.19759137E-02 + 3.26874068E-01 9.33928897E-02 1.003083505E-03 5.19759160E-02 + 3.26977346E-01 9.34223987E-02 1.003112731E-03 5.19759183E-02 + 3.27080624E-01 9.34519076E-02 1.003142223E-03 5.19759206E-02 + 3.27183902E-01 9.34814165E-02 1.003171984E-03 5.19759229E-02 + 3.27287179E-01 9.35109254E-02 1.003202017E-03 5.19759252E-02 + 3.27390457E-01 9.35404344E-02 1.003232322E-03 5.19759276E-02 + 3.27493735E-01 9.35699433E-02 1.003262903E-03 5.19759299E-02 + 3.27597013E-01 9.35994523E-02 1.003293762E-03 5.19759322E-02 + 3.27700290E-01 9.36289612E-02 1.003324902E-03 5.19759345E-02 + 3.27803568E-01 9.36584701E-02 1.003356325E-03 5.19759369E-02 + 3.27906846E-01 9.36879791E-02 1.003388034E-03 5.19759393E-02 + 3.28010124E-01 9.37174880E-02 1.003420030E-03 5.19759416E-02 + 3.28113401E-01 9.37469970E-02 1.003452316E-03 5.19759440E-02 + 3.28216679E-01 9.37765059E-02 1.003484896E-03 5.19759464E-02 + 3.28319957E-01 9.38060149E-02 1.003517771E-03 5.19759487E-02 + 3.28423235E-01 9.38355239E-02 1.003550944E-03 5.19759512E-02 + 3.28526512E-01 9.38650328E-02 1.003584417E-03 5.19759535E-02 + 3.28629790E-01 9.38945418E-02 1.003618194E-03 5.19759560E-02 + 3.28733068E-01 9.39240508E-02 1.003652277E-03 5.19759583E-02 + 3.28836346E-01 9.39535598E-02 1.003686668E-03 5.19759608E-02 + 3.28939623E-01 9.39830687E-02 1.003721370E-03 5.19759632E-02 + 3.29042901E-01 9.40125777E-02 1.003756385E-03 5.19759656E-02 + 3.29146179E-01 9.40420867E-02 1.003791718E-03 5.19759681E-02 + 3.29249457E-01 9.40715957E-02 1.003827369E-03 5.19759705E-02 + 3.29352734E-01 9.41011047E-02 1.003863343E-03 5.19759730E-02 + 3.29456012E-01 9.41306137E-02 1.003899641E-03 5.19759754E-02 + 3.29559290E-01 9.41601227E-02 1.003936266E-03 5.19759778E-02 + 3.29662567E-01 9.41896317E-02 1.003973222E-03 5.19759804E-02 + 3.29765845E-01 9.42191407E-02 1.004010512E-03 5.19759828E-02 + 3.29869123E-01 9.42486497E-02 1.004048137E-03 5.19759853E-02 + 3.29972401E-01 9.42781587E-02 1.004086101E-03 5.19759878E-02 + 3.30075678E-01 9.43076677E-02 1.004124407E-03 5.19759903E-02 + 3.30178956E-01 9.43371767E-02 1.004163057E-03 5.19759928E-02 + 3.30282234E-01 9.43666857E-02 1.004202055E-03 5.19759953E-02 + 3.30385512E-01 9.43961948E-02 1.004241404E-03 5.19759978E-02 + 3.30488789E-01 9.44257038E-02 1.004281107E-03 5.19760003E-02 + 3.30592067E-01 9.44552128E-02 1.004321166E-03 5.19760029E-02 + 3.30695345E-01 9.44847219E-02 1.004361585E-03 5.19760054E-02 + 3.30798623E-01 9.45142309E-02 1.004402367E-03 5.19760079E-02 + 3.30901900E-01 9.45437399E-02 1.004443515E-03 5.19760105E-02 + 3.31005178E-01 9.45732490E-02 1.004485031E-03 5.19760130E-02 + 3.31108456E-01 9.46027580E-02 1.004526920E-03 5.19760156E-02 + 3.31211734E-01 9.46322671E-02 1.004569184E-03 5.19760182E-02 + 3.31315011E-01 9.46617761E-02 1.004611827E-03 5.19760207E-02 + 3.31418289E-01 9.46912852E-02 1.004654852E-03 5.19760233E-02 + 3.31521567E-01 9.47207942E-02 1.004698261E-03 5.19760259E-02 + 3.31624845E-01 9.47503033E-02 1.004742059E-03 5.19760285E-02 + 3.31728122E-01 9.47798124E-02 1.004786248E-03 5.19760311E-02 + 3.31831400E-01 9.48093214E-02 1.004830832E-03 5.19760337E-02 + 3.31934678E-01 9.48388305E-02 1.004875814E-03 5.19760363E-02 + 3.32037956E-01 9.48683396E-02 1.004921198E-03 5.19760389E-02 + 3.32141233E-01 9.48978487E-02 1.004966987E-03 5.19760416E-02 + 3.32244511E-01 9.49273577E-02 1.005013185E-03 5.19760442E-02 + 3.32347789E-01 9.49568668E-02 1.005059794E-03 5.19760468E-02 + 3.32451067E-01 9.49863759E-02 1.005106819E-03 5.19760495E-02 + 3.32554344E-01 9.50158850E-02 1.005154262E-03 5.19760522E-02 + 3.32657622E-01 9.50453941E-02 1.005202128E-03 5.19760548E-02 + 3.32760900E-01 9.50749032E-02 1.005250420E-03 5.19760575E-02 + 3.32864178E-01 9.51044123E-02 1.005299142E-03 5.19760602E-02 + 3.32967455E-01 9.51339214E-02 1.005348296E-03 5.19760629E-02 + 3.33070733E-01 9.51634305E-02 1.005397888E-03 5.19760656E-02 + 3.33174011E-01 9.51929397E-02 1.005447920E-03 5.19760683E-02 + 3.33277289E-01 9.52224488E-02 1.005498396E-03 5.19760709E-02 + 3.33380566E-01 9.52519579E-02 1.005549321E-03 5.19760736E-02 + 3.33483844E-01 9.52814670E-02 1.005600697E-03 5.19760764E-02 + 3.33587122E-01 9.53109761E-02 1.005652528E-03 5.19760791E-02 + 3.33690400E-01 9.53404853E-02 1.005704819E-03 5.19760818E-02 + 3.33793677E-01 9.53699944E-02 1.005757574E-03 5.19760846E-02 + 3.33896955E-01 9.53995035E-02 1.005810795E-03 5.19760873E-02 + 3.34000233E-01 9.54290127E-02 1.005864487E-03 5.19760901E-02 + 3.34103511E-01 9.54585218E-02 1.005918654E-03 5.19760929E-02 + 3.34206788E-01 9.54880310E-02 1.005973300E-03 5.19760957E-02 + 3.34310066E-01 9.55175401E-02 1.006028429E-03 5.19760984E-02 + 3.34413344E-01 9.55470493E-02 1.006084045E-03 5.19761012E-02 + 3.34516622E-01 9.55765585E-02 1.006140152E-03 5.19761040E-02 + 3.34619899E-01 9.56060676E-02 1.006196754E-03 5.19761068E-02 + 3.34723177E-01 9.56355768E-02 1.006253856E-03 5.19761096E-02 + 3.34826455E-01 9.56650860E-02 1.006311460E-03 5.19761124E-02 + 3.34929733E-01 9.56945951E-02 1.006369573E-03 5.19761153E-02 + 3.35033010E-01 9.57241043E-02 1.006428197E-03 5.19761181E-02 + 3.35136288E-01 9.57536135E-02 1.006487337E-03 5.19761209E-02 + 3.35239566E-01 9.57831227E-02 1.006546997E-03 5.19761238E-02 + 3.35342844E-01 9.58126319E-02 1.006607182E-03 5.19761266E-02 + 3.35446121E-01 9.58421411E-02 1.006667897E-03 5.19761295E-02 + 3.35549399E-01 9.58716503E-02 1.006729144E-03 5.19761323E-02 + 3.35652677E-01 9.59011595E-02 1.006790930E-03 5.19761352E-02 + 3.35755955E-01 9.59306687E-02 1.006853257E-03 5.19761381E-02 + 3.35859232E-01 9.59601779E-02 1.006916132E-03 5.19761410E-02 + 3.35962510E-01 9.59896871E-02 1.006979558E-03 5.19761439E-02 + 3.36065788E-01 9.60191963E-02 1.007043539E-03 5.19761468E-02 + 3.36169066E-01 9.60487055E-02 1.007108081E-03 5.19761497E-02 + 3.36272343E-01 9.60782147E-02 1.007173188E-03 5.19761526E-02 + 3.36375621E-01 9.61077240E-02 1.007238865E-03 5.19761556E-02 + 3.36478899E-01 9.61372332E-02 1.007305116E-03 5.19761585E-02 + 3.36582177E-01 9.61667424E-02 1.007371946E-03 5.19761615E-02 + 3.36685454E-01 9.61962517E-02 1.007439361E-03 5.19761644E-02 + 3.36788732E-01 9.62257609E-02 1.007507364E-03 5.19761673E-02 + 3.36892010E-01 9.62552702E-02 1.007575960E-03 5.19761703E-02 + 3.36995288E-01 9.62847794E-02 1.007645155E-03 5.19761733E-02 + 3.37098565E-01 9.63142887E-02 1.007714953E-03 5.19761763E-02 + 3.37201843E-01 9.63437979E-02 1.007785359E-03 5.19761793E-02 + 3.37305121E-01 9.63733072E-02 1.007856378E-03 5.19761823E-02 + 3.37408398E-01 9.64028165E-02 1.007928016E-03 5.19761853E-02 + 3.37511676E-01 9.64323257E-02 1.008000277E-03 5.19761883E-02 + 3.37614954E-01 9.64618350E-02 1.008073166E-03 5.19761913E-02 + 3.37718232E-01 9.64913443E-02 1.008146689E-03 5.19761943E-02 + 3.37821509E-01 9.65208536E-02 1.008220851E-03 5.19761974E-02 + 3.37924787E-01 9.65503628E-02 1.008295656E-03 5.19762004E-02 + 3.38028065E-01 9.65798721E-02 1.008371111E-03 5.19762035E-02 + 3.38131343E-01 9.66093814E-02 1.008447220E-03 5.19762066E-02 + 3.38234620E-01 9.66388907E-02 1.008523988E-03 5.19762096E-02 + 3.38337898E-01 9.66684000E-02 1.008601422E-03 5.19762127E-02 + 3.38441176E-01 9.66979093E-02 1.008679526E-03 5.19762158E-02 + 3.38544454E-01 9.67274186E-02 1.008758306E-03 5.19762188E-02 + 3.38647731E-01 9.67569279E-02 1.008837768E-03 5.19762220E-02 + 3.38751009E-01 9.67864373E-02 1.008917916E-03 5.19762251E-02 + 3.38854287E-01 9.68159466E-02 1.008998757E-03 5.19762282E-02 + 3.38957565E-01 9.68454559E-02 1.009080296E-03 5.19762313E-02 + 3.39060842E-01 9.68749652E-02 1.009162538E-03 5.19762344E-02 + 3.39164120E-01 9.69044746E-02 1.009245490E-03 5.19762376E-02 + 3.39267398E-01 9.69339839E-02 1.009329157E-03 5.19762407E-02 + 3.39370676E-01 9.69634933E-02 1.009413545E-03 5.19762439E-02 + 3.39473953E-01 9.69930026E-02 1.009498659E-03 5.19762471E-02 + 3.39577231E-01 9.70225119E-02 1.009584506E-03 5.19762503E-02 + 3.39680509E-01 9.70520213E-02 1.009671091E-03 5.19762534E-02 + 3.39783787E-01 9.70815307E-02 1.009758421E-03 5.19762566E-02 + 3.39887064E-01 9.71110400E-02 1.009846500E-03 5.19762598E-02 + 3.39990342E-01 9.71405494E-02 1.009935336E-03 5.19762630E-02 + 3.40093620E-01 9.71700588E-02 1.010024935E-03 5.19762662E-02 + 3.40196898E-01 9.71995681E-02 1.010115301E-03 5.19762695E-02 + 3.40300175E-01 9.72290775E-02 1.010206443E-03 5.19762727E-02 + 3.40403453E-01 9.72585869E-02 1.010298365E-03 5.19762760E-02 + 3.40506731E-01 9.72880963E-02 1.010391074E-03 5.19762792E-02 + 3.40610009E-01 9.73176057E-02 1.010484576E-03 5.19762825E-02 + 3.40713286E-01 9.73471151E-02 1.010578878E-03 5.19762857E-02 + 3.40816564E-01 9.73766245E-02 1.010673986E-03 5.19762890E-02 + 3.40919842E-01 9.74061339E-02 1.010769906E-03 5.19762923E-02 + 3.41023120E-01 9.74356433E-02 1.010866645E-03 5.19762955E-02 + 3.41126397E-01 9.74651527E-02 1.010964209E-03 5.19762989E-02 + 3.41229675E-01 9.74946621E-02 1.011062605E-03 5.19763022E-02 + 3.41332953E-01 9.75241715E-02 1.011161839E-03 5.19763055E-02 + 3.41436231E-01 9.75536810E-02 1.011261918E-03 5.19763088E-02 + 3.41539508E-01 9.75831904E-02 1.011362849E-03 5.19763122E-02 + 3.41642786E-01 9.76126998E-02 1.011464638E-03 5.19763155E-02 + 3.41746064E-01 9.76422093E-02 1.011567293E-03 5.19763188E-02 + 3.41849342E-01 9.76717187E-02 1.011670820E-03 5.19763222E-02 + 3.41952619E-01 9.77012281E-02 1.011775225E-03 5.19763256E-02 + 3.42055897E-01 9.77307376E-02 1.011880516E-03 5.19763289E-02 + 3.42159175E-01 9.77602471E-02 1.011986700E-03 5.19763323E-02 + 3.42262453E-01 9.77897565E-02 1.012093784E-03 5.19763357E-02 + 3.42365730E-01 9.78192660E-02 1.012201774E-03 5.19763391E-02 + 3.42469008E-01 9.78487754E-02 1.012310679E-03 5.19763425E-02 + 3.42572286E-01 9.78782849E-02 1.012420504E-03 5.19763459E-02 + 3.42675564E-01 9.79077944E-02 1.012531258E-03 5.19763494E-02 + 3.42778841E-01 9.79373039E-02 1.012642947E-03 5.19763528E-02 + 3.42882119E-01 9.79668134E-02 1.012755579E-03 5.19763563E-02 + 3.42985397E-01 9.79963229E-02 1.012869161E-03 5.19763597E-02 + 3.43088675E-01 9.80258324E-02 1.012983700E-03 5.19763632E-02 + 3.43191952E-01 9.80553419E-02 1.013099205E-03 5.19763666E-02 + 3.43295230E-01 9.80848514E-02 1.013215682E-03 5.19763701E-02 + 3.43398508E-01 9.81143609E-02 1.013333138E-03 5.19763736E-02 + 3.43501786E-01 9.81438704E-02 1.013451583E-03 5.19763771E-02 + 3.43605063E-01 9.81733799E-02 1.013571023E-03 5.19763807E-02 + 3.43708341E-01 9.82028894E-02 1.013691466E-03 5.19763842E-02 + 3.43811619E-01 9.82323989E-02 1.013812919E-03 5.19763877E-02 + 3.43914897E-01 9.82619085E-02 1.013935391E-03 5.19763912E-02 + 3.44018174E-01 9.82914180E-02 1.014058889E-03 5.19763948E-02 + 3.44121452E-01 9.83209276E-02 1.014183422E-03 5.19763983E-02 + 3.44224730E-01 9.83504371E-02 1.014308996E-03 5.19764019E-02 + 3.44328008E-01 9.83799467E-02 1.014435621E-03 5.19764054E-02 + 3.44431285E-01 9.84094562E-02 1.014563304E-03 5.19764090E-02 + 3.44534563E-01 9.84389658E-02 1.014692054E-03 5.19764126E-02 + 3.44637841E-01 9.84684753E-02 1.014821878E-03 5.19764162E-02 + 3.44741119E-01 9.84979849E-02 1.014952784E-03 5.19764199E-02 + 3.44844396E-01 9.85274945E-02 1.015084782E-03 5.19764235E-02 + 3.44947674E-01 9.85570040E-02 1.015217879E-03 5.19764271E-02 + 3.45050952E-01 9.85865136E-02 1.015352084E-03 5.19764307E-02 + 3.45154230E-01 9.86160232E-02 1.015487405E-03 5.19764343E-02 + 3.45257507E-01 9.86455328E-02 1.015623850E-03 5.19764380E-02 + 3.45360785E-01 9.86750424E-02 1.015761429E-03 5.19764417E-02 + 3.45464063E-01 9.87045520E-02 1.015900149E-03 5.19764454E-02 + 3.45567340E-01 9.87340616E-02 1.016040020E-03 5.19764490E-02 + 3.45670618E-01 9.87635712E-02 1.016181050E-03 5.19764527E-02 + 3.45773896E-01 9.87930808E-02 1.016323248E-03 5.19764564E-02 + 3.45877174E-01 9.88225905E-02 1.016466623E-03 5.19764601E-02 + 3.45980451E-01 9.88521001E-02 1.016611183E-03 5.19764639E-02 + 3.46083729E-01 9.88816097E-02 1.016756937E-03 5.19764676E-02 + 3.46187007E-01 9.89111194E-02 1.016903895E-03 5.19764713E-02 + 3.46290285E-01 9.89406290E-02 1.017052065E-03 5.19764751E-02 + 3.46393562E-01 9.89701386E-02 1.017201457E-03 5.19764789E-02 + 3.46496840E-01 9.89996483E-02 1.017352080E-03 5.19764826E-02 + 3.46600118E-01 9.90291579E-02 1.017503943E-03 5.19764864E-02 + 3.46703396E-01 9.90586676E-02 1.017657054E-03 5.19764902E-02 + 3.46806673E-01 9.90881773E-02 1.017811425E-03 5.19764940E-02 + 3.46909951E-01 9.91176869E-02 1.017967063E-03 5.19764978E-02 + 3.47013229E-01 9.91471966E-02 1.018123978E-03 5.19765016E-02 + 3.47116507E-01 9.91767063E-02 1.018282180E-03 5.19765054E-02 + 3.47219784E-01 9.92062160E-02 1.018441679E-03 5.19765093E-02 + 3.47323062E-01 9.92357257E-02 1.018602483E-03 5.19765131E-02 + 3.47426340E-01 9.92652354E-02 1.018764604E-03 5.19765169E-02 + 3.47529618E-01 9.92947451E-02 1.018928049E-03 5.19765208E-02 + 3.47632895E-01 9.93242548E-02 1.019092830E-03 5.19765247E-02 + 3.47736173E-01 9.93537645E-02 1.019258955E-03 5.19765286E-02 + 3.47839451E-01 9.93832742E-02 1.019426436E-03 5.19765325E-02 + 3.47942729E-01 9.94127839E-02 1.019595281E-03 5.19765364E-02 + 3.48046006E-01 9.94422936E-02 1.019765501E-03 5.19765403E-02 + 3.48149284E-01 9.94718034E-02 1.019937106E-03 5.19765442E-02 + 3.48252562E-01 9.95013131E-02 1.020110106E-03 5.19765482E-02 + 3.48355840E-01 9.95308228E-02 1.020284511E-03 5.19765521E-02 + 3.48459117E-01 9.95603326E-02 1.020460332E-03 5.19765561E-02 + 3.48562395E-01 9.95898423E-02 1.020637578E-03 5.19765600E-02 + 3.48665673E-01 9.96193521E-02 1.020816261E-03 5.19765640E-02 + 3.48768951E-01 9.96488618E-02 1.020996390E-03 5.19765680E-02 + 3.48872228E-01 9.96783716E-02 1.021177976E-03 5.19765720E-02 + 3.48975506E-01 9.97078814E-02 1.021361030E-03 5.19765760E-02 + 3.49078784E-01 9.97373912E-02 1.021545562E-03 5.19765800E-02 + 3.49182062E-01 9.97669009E-02 1.021731583E-03 5.19765840E-02 + 3.49285339E-01 9.97964107E-02 1.021919104E-03 5.19765880E-02 + 3.49388617E-01 9.98259205E-02 1.022108135E-03 5.19765921E-02 + 3.49491895E-01 9.98554303E-02 1.022298688E-03 5.19765961E-02 + 3.49595173E-01 9.98849401E-02 1.022490772E-03 5.19766002E-02 + 3.49698450E-01 9.99144499E-02 1.022684400E-03 5.19766043E-02 + 3.49801728E-01 9.99439597E-02 1.022879582E-03 5.19766084E-02 + 3.49905006E-01 9.99734696E-02 1.023076330E-03 5.19766124E-02 + 3.50008284E-01 1.00002979E-01 1.023274654E-03 5.19766166E-02 + 3.50111561E-01 1.00032489E-01 1.023474565E-03 5.19766207E-02 + 3.50214839E-01 1.00061999E-01 1.023676076E-03 5.19766248E-02 + 3.50318117E-01 1.00091509E-01 1.023879197E-03 5.19766289E-02 + 3.50421395E-01 1.00121019E-01 1.024083940E-03 5.19766331E-02 + 3.50524672E-01 1.00150529E-01 1.024290316E-03 5.19766372E-02 + 3.50627950E-01 1.00180038E-01 1.024498336E-03 5.19766414E-02 + 3.50731228E-01 1.00209548E-01 1.024708014E-03 5.19766456E-02 + 3.50834506E-01 1.00239058E-01 1.024919359E-03 5.19766498E-02 + 3.50937783E-01 1.00268568E-01 1.025132384E-03 5.19766540E-02 + 3.51041061E-01 1.00298078E-01 1.025347100E-03 5.19766582E-02 + 3.51144339E-01 1.00327588E-01 1.025563520E-03 5.19766624E-02 + 3.51247617E-01 1.00357098E-01 1.025781654E-03 5.19766666E-02 + 3.51350894E-01 1.00386608E-01 1.026001517E-03 5.19766709E-02 + 3.51454172E-01 1.00416117E-01 1.026223118E-03 5.19766751E-02 + 3.51557450E-01 1.00445627E-01 1.026446471E-03 5.19766794E-02 + 3.51660728E-01 1.00475137E-01 1.026671587E-03 5.19766837E-02 + 3.51764005E-01 1.00504647E-01 1.026898479E-03 5.19766880E-02 + 3.51867283E-01 1.00534157E-01 1.027127159E-03 5.19766923E-02 + 3.51970561E-01 1.00563667E-01 1.027357639E-03 5.19766965E-02 + 3.52073839E-01 1.00593177E-01 1.027589932E-03 5.19767009E-02 + 3.52177116E-01 1.00622687E-01 1.027824050E-03 5.19767052E-02 + 3.52280394E-01 1.00652197E-01 1.028060006E-03 5.19767095E-02 + 3.52383672E-01 1.00681707E-01 1.028297812E-03 5.19767139E-02 + 3.52486950E-01 1.00711217E-01 1.028537481E-03 5.19767182E-02 + 3.52590227E-01 1.00740727E-01 1.028779026E-03 5.19767226E-02 + 3.52693505E-01 1.00770237E-01 1.029022459E-03 5.19767270E-02 + 3.52796783E-01 1.00799747E-01 1.029267793E-03 5.19767314E-02 + 3.52900061E-01 1.00829257E-01 1.029515042E-03 5.19767358E-02 + 3.53003338E-01 1.00858767E-01 1.029764218E-03 5.19767402E-02 + 3.53106616E-01 1.00888277E-01 1.030015334E-03 5.19767446E-02 + 3.53209894E-01 1.00917787E-01 1.030268403E-03 5.19767491E-02 + 3.53313171E-01 1.00947297E-01 1.030523439E-03 5.19767535E-02 + 3.53416449E-01 1.00976807E-01 1.030780454E-03 5.19767580E-02 + 3.53519727E-01 1.01006317E-01 1.031039463E-03 5.19767624E-02 + 3.53623005E-01 1.01035827E-01 1.031300477E-03 5.19767669E-02 + 3.53726282E-01 1.01065337E-01 1.031563511E-03 5.19767714E-02 + 3.53829560E-01 1.01094847E-01 1.031828579E-03 5.19767759E-02 + 3.53932838E-01 1.01124357E-01 1.032095693E-03 5.19767804E-02 + 3.54036116E-01 1.01153867E-01 1.032364867E-03 5.19767850E-02 + 3.54139393E-01 1.01183377E-01 1.032636115E-03 5.19767895E-02 + 3.54242671E-01 1.01212887E-01 1.032909450E-03 5.19767940E-02 + 3.54345949E-01 1.01242397E-01 1.033184887E-03 5.19767986E-02 + 3.54449227E-01 1.01271907E-01 1.033462440E-03 5.19768032E-02 + 3.54552504E-01 1.01301417E-01 1.033742121E-03 5.19768077E-02 + 3.54655782E-01 1.01330927E-01 1.034023945E-03 5.19768123E-02 + 3.54759060E-01 1.01360437E-01 1.034307926E-03 5.19768169E-02 + 3.54862338E-01 1.01389947E-01 1.034594079E-03 5.19768216E-02 + 3.54965615E-01 1.01419457E-01 1.034882416E-03 5.19768262E-02 + 3.55068893E-01 1.01448967E-01 1.035172954E-03 5.19768308E-02 + 3.55172171E-01 1.01478478E-01 1.035465704E-03 5.19768355E-02 + 3.55275449E-01 1.01507988E-01 1.035760683E-03 5.19768401E-02 + 3.55378726E-01 1.01537498E-01 1.036057905E-03 5.19768448E-02 + 3.55482004E-01 1.01567008E-01 1.036357383E-03 5.19768495E-02 + 3.55585282E-01 1.01596518E-01 1.036659132E-03 5.19768542E-02 + 3.55688560E-01 1.01626028E-01 1.036963168E-03 5.19768589E-02 + 3.55791837E-01 1.01655538E-01 1.037269503E-03 5.19768636E-02 + 3.55895115E-01 1.01685049E-01 1.037578154E-03 5.19768684E-02 + 3.55998393E-01 1.01714559E-01 1.037889135E-03 5.19768731E-02 + 3.56101671E-01 1.01744069E-01 1.038202461E-03 5.19768778E-02 + 3.56204948E-01 1.01773579E-01 1.038518146E-03 5.19768826E-02 + 3.56308226E-01 1.01803089E-01 1.038836205E-03 5.19768874E-02 + 3.56411504E-01 1.01832599E-01 1.039156654E-03 5.19768922E-02 + 3.56514782E-01 1.01862110E-01 1.039479508E-03 5.19768970E-02 + 3.56618059E-01 1.01891620E-01 1.039804780E-03 5.19769018E-02 + 3.56721337E-01 1.01921130E-01 1.040132488E-03 5.19769066E-02 + 3.56824615E-01 1.01950640E-01 1.040462645E-03 5.19769115E-02 + 3.56927893E-01 1.01980150E-01 1.040795268E-03 5.19769163E-02 + 3.57031170E-01 1.02009661E-01 1.041130371E-03 5.19769212E-02 + 3.57134448E-01 1.02039171E-01 1.041467970E-03 5.19769260E-02 + 3.57237726E-01 1.02068681E-01 1.041808080E-03 5.19769309E-02 + 3.57341004E-01 1.02098191E-01 1.042150716E-03 5.19769358E-02 + 3.57444281E-01 1.02127701E-01 1.042495895E-03 5.19769407E-02 + 3.57547559E-01 1.02157212E-01 1.042843631E-03 5.19769457E-02 + 3.57650837E-01 1.02186722E-01 1.043193941E-03 5.19769506E-02 + 3.57754115E-01 1.02216232E-01 1.043546840E-03 5.19769555E-02 + 3.57857392E-01 1.02245743E-01 1.043902344E-03 5.19769605E-02 + 3.57960670E-01 1.02275253E-01 1.044260468E-03 5.19769654E-02 + 3.58063948E-01 1.02304763E-01 1.044621229E-03 5.19769704E-02 + 3.58167226E-01 1.02334273E-01 1.044984642E-03 5.19769754E-02 + 3.58270503E-01 1.02363784E-01 1.045350724E-03 5.19769804E-02 + 3.58373781E-01 1.02393294E-01 1.045719490E-03 5.19769855E-02 + 3.58477059E-01 1.02422804E-01 1.046090956E-03 5.19769905E-02 + 3.58580337E-01 1.02452315E-01 1.046465139E-03 5.19769955E-02 + 3.58683614E-01 1.02481825E-01 1.046842054E-03 5.19770006E-02 + 3.58786892E-01 1.02511335E-01 1.047221719E-03 5.19770057E-02 + 3.58890170E-01 1.02540846E-01 1.047604148E-03 5.19770107E-02 + 3.58993448E-01 1.02570356E-01 1.047989359E-03 5.19770158E-02 + 3.59096725E-01 1.02599866E-01 1.048377368E-03 5.19770209E-02 + 3.59200003E-01 1.02629377E-01 1.048768191E-03 5.19770260E-02 + 3.59303281E-01 1.02658887E-01 1.049161845E-03 5.19770312E-02 + 3.59406559E-01 1.02688397E-01 1.049558345E-03 5.19770363E-02 + 3.59509836E-01 1.02717908E-01 1.049957710E-03 5.19770415E-02 + 3.59613114E-01 1.02747418E-01 1.050359955E-03 5.19770466E-02 + 3.59716392E-01 1.02776928E-01 1.050765097E-03 5.19770518E-02 + 3.59819670E-01 1.02806439E-01 1.051173152E-03 5.19770570E-02 + 3.59922947E-01 1.02835949E-01 1.051584138E-03 5.19770622E-02 + 3.60026225E-01 1.02865460E-01 1.051998071E-03 5.19770674E-02 + 3.60129503E-01 1.02894970E-01 1.052414968E-03 5.19770727E-02 + 3.60232781E-01 1.02924480E-01 1.052834845E-03 5.19770779E-02 + 3.60336058E-01 1.02953991E-01 1.053257721E-03 5.19770832E-02 + 3.60439336E-01 1.02983501E-01 1.053683611E-03 5.19770884E-02 + 3.60542614E-01 1.03013012E-01 1.054112532E-03 5.19770937E-02 + 3.60645892E-01 1.03042522E-01 1.054544503E-03 5.19770990E-02 + 3.60749169E-01 1.03072033E-01 1.054979539E-03 5.19771043E-02 + 3.60852447E-01 1.03101543E-01 1.055417658E-03 5.19771097E-02 + 3.60955725E-01 1.03131054E-01 1.055858877E-03 5.19771150E-02 + 3.61059002E-01 1.03160564E-01 1.056303213E-03 5.19771203E-02 + 3.61162280E-01 1.03190075E-01 1.056750684E-03 5.19771257E-02 + 3.61265558E-01 1.03219585E-01 1.057201306E-03 5.19771311E-02 + 3.61368836E-01 1.03249096E-01 1.057655097E-03 5.19771364E-02 + 3.61472113E-01 1.03278606E-01 1.058112074E-03 5.19771419E-02 + 3.61575391E-01 1.03308117E-01 1.058572256E-03 5.19771473E-02 + 3.61678669E-01 1.03337627E-01 1.059035659E-03 5.19771527E-02 + 3.61781947E-01 1.03367138E-01 1.059502299E-03 5.19771581E-02 + 3.61885224E-01 1.03396648E-01 1.059972196E-03 5.19771636E-02 + 3.61988502E-01 1.03426159E-01 1.060445367E-03 5.19771690E-02 + 3.62091780E-01 1.03455669E-01 1.060921828E-03 5.19771745E-02 + 3.62195058E-01 1.03485180E-01 1.061401599E-03 5.19771800E-02 + 3.62298335E-01 1.03514690E-01 1.061884695E-03 5.19771855E-02 + 3.62401613E-01 1.03544201E-01 1.062371135E-03 5.19771911E-02 + 3.62504891E-01 1.03573711E-01 1.062860937E-03 5.19771966E-02 + 3.62608169E-01 1.03603222E-01 1.063354118E-03 5.19772021E-02 + 3.62711446E-01 1.03632733E-01 1.063850696E-03 5.19772077E-02 + 3.62814724E-01 1.03662243E-01 1.064350689E-03 5.19772133E-02 + 3.62918002E-01 1.03691754E-01 1.064854114E-03 5.19772188E-02 + 3.63021280E-01 1.03721264E-01 1.065360990E-03 5.19772244E-02 + 3.63124557E-01 1.03750775E-01 1.065871333E-03 5.19772301E-02 + 3.63227835E-01 1.03780286E-01 1.066385163E-03 5.19772357E-02 + 3.63331113E-01 1.03809796E-01 1.066902496E-03 5.19772413E-02 + 3.63434391E-01 1.03839307E-01 1.067423351E-03 5.19772470E-02 + 3.63537668E-01 1.03868818E-01 1.067947745E-03 5.19772526E-02 + 3.63640946E-01 1.03898328E-01 1.068475697E-03 5.19772583E-02 + 3.63744224E-01 1.03927839E-01 1.069007225E-03 5.19772640E-02 + 3.63847502E-01 1.03957350E-01 1.069542346E-03 5.19772697E-02 + 3.63950779E-01 1.03986860E-01 1.070081079E-03 5.19772755E-02 + 3.64054057E-01 1.04016371E-01 1.070623441E-03 5.19772812E-02 + 3.64157335E-01 1.04045882E-01 1.071169451E-03 5.19772869E-02 + 3.64260613E-01 1.04075392E-01 1.071719126E-03 5.19772927E-02 + 3.64363890E-01 1.04104903E-01 1.072272485E-03 5.19772985E-02 + 3.64467168E-01 1.04134414E-01 1.072829545E-03 5.19773043E-02 + 3.64570446E-01 1.04163924E-01 1.073390325E-03 5.19773101E-02 + 3.64673724E-01 1.04193435E-01 1.073954844E-03 5.19773159E-02 + 3.64777001E-01 1.04222946E-01 1.074523118E-03 5.19773217E-02 + 3.64880279E-01 1.04252457E-01 1.075095167E-03 5.19773276E-02 + 3.64983557E-01 1.04281967E-01 1.075671007E-03 5.19773335E-02 + 3.65086835E-01 1.04311478E-01 1.076250658E-03 5.19773393E-02 + 3.65190112E-01 1.04340989E-01 1.076834138E-03 5.19773452E-02 + 3.65293390E-01 1.04370500E-01 1.077421465E-03 5.19773511E-02 + 3.65396668E-01 1.04400010E-01 1.078012656E-03 5.19773570E-02 + 3.65499946E-01 1.04429521E-01 1.078607731E-03 5.19773630E-02 + 3.65603223E-01 1.04459032E-01 1.079206707E-03 5.19773689E-02 + 3.65706501E-01 1.04488543E-01 1.079809602E-03 5.19773749E-02 + 3.65809779E-01 1.04518054E-01 1.080416435E-03 5.19773809E-02 + 3.65913057E-01 1.04547564E-01 1.081027223E-03 5.19773869E-02 + 3.66016334E-01 1.04577075E-01 1.081641986E-03 5.19773928E-02 + 3.66119612E-01 1.04606586E-01 1.082260741E-03 5.19773989E-02 + 3.66222890E-01 1.04636097E-01 1.082883506E-03 5.19774049E-02 + 3.66326168E-01 1.04665608E-01 1.083510300E-03 5.19774110E-02 + 3.66429445E-01 1.04695119E-01 1.084141141E-03 5.19774170E-02 + 3.66532723E-01 1.04724630E-01 1.084776047E-03 5.19774231E-02 + 3.66636001E-01 1.04754140E-01 1.085415036E-03 5.19774292E-02 + 3.66739279E-01 1.04783651E-01 1.086058126E-03 5.19774353E-02 + 3.66842556E-01 1.04813162E-01 1.086705336E-03 5.19774414E-02 + 3.66945834E-01 1.04842673E-01 1.087356683E-03 5.19774475E-02 + 3.67049112E-01 1.04872184E-01 1.088012186E-03 5.19774537E-02 + 3.67152390E-01 1.04901695E-01 1.088671863E-03 5.19774599E-02 + 3.67255667E-01 1.04931206E-01 1.089335732E-03 5.19774660E-02 + 3.67358945E-01 1.04960717E-01 1.090003811E-03 5.19774722E-02 + 3.67462223E-01 1.04990228E-01 1.090676119E-03 5.19774785E-02 + 3.67565501E-01 1.05019739E-01 1.091352673E-03 5.19774847E-02 + 3.67668778E-01 1.05049250E-01 1.092033492E-03 5.19774909E-02 + 3.67772056E-01 1.05078761E-01 1.092718593E-03 5.19774972E-02 + 3.67875334E-01 1.05108272E-01 1.093407994E-03 5.19775034E-02 + 3.67978612E-01 1.05137783E-01 1.094101715E-03 5.19775097E-02 + 3.68081889E-01 1.05167294E-01 1.094799772E-03 5.19775160E-02 + 3.68185167E-01 1.05196805E-01 1.095502183E-03 5.19775223E-02 + 3.68288445E-01 1.05226316E-01 1.096208967E-03 5.19775286E-02 + 3.68391723E-01 1.05255827E-01 1.096920142E-03 5.19775350E-02 + 3.68495000E-01 1.05285338E-01 1.097635725E-03 5.19775414E-02 + 3.68598278E-01 1.05314849E-01 1.098355734E-03 5.19775477E-02 + 3.68701556E-01 1.05344360E-01 1.099080189E-03 5.19775541E-02 + 3.68804833E-01 1.05373871E-01 1.099809105E-03 5.19775605E-02 + 3.68908111E-01 1.05403382E-01 1.100542501E-03 5.19775669E-02 + 3.69011389E-01 1.05432893E-01 1.101280395E-03 5.19775734E-02 + 3.69114667E-01 1.05462404E-01 1.102022804E-03 5.19775798E-02 + 3.69217944E-01 1.05491915E-01 1.102769747E-03 5.19775863E-02 + 3.69321222E-01 1.05521426E-01 1.103521241E-03 5.19775928E-02 + 3.69424500E-01 1.05550937E-01 1.104277304E-03 5.19775993E-02 + 3.69527778E-01 1.05580448E-01 1.105037953E-03 5.19776058E-02 + 3.69631055E-01 1.05609959E-01 1.105803206E-03 5.19776123E-02 + 3.69734333E-01 1.05639470E-01 1.106573081E-03 5.19776189E-02 + 3.69837611E-01 1.05668982E-01 1.107347595E-03 5.19776254E-02 + 3.69940889E-01 1.05698493E-01 1.108126766E-03 5.19776320E-02 + 3.70044166E-01 1.05728004E-01 1.108910611E-03 5.19776386E-02 + 3.70147444E-01 1.05757515E-01 1.109699148E-03 5.19776452E-02 + 3.70250722E-01 1.05787026E-01 1.110492393E-03 5.19776518E-02 + 3.70354000E-01 1.05816537E-01 1.111290366E-03 5.19776585E-02 + 3.70457277E-01 1.05846048E-01 1.112093082E-03 5.19776651E-02 + 3.70560555E-01 1.05875560E-01 1.112900559E-03 5.19776718E-02 + 3.70663833E-01 1.05905071E-01 1.113712814E-03 5.19776785E-02 + 3.70767111E-01 1.05934582E-01 1.114529865E-03 5.19776852E-02 + 3.70870388E-01 1.05964093E-01 1.115351729E-03 5.19776919E-02 + 3.70973666E-01 1.05993605E-01 1.116178422E-03 5.19776986E-02 + 3.71076944E-01 1.06023116E-01 1.117009962E-03 5.19777054E-02 + 3.71180222E-01 1.06052627E-01 1.117846366E-03 5.19777121E-02 + 3.71283499E-01 1.06082138E-01 1.118687651E-03 5.19777189E-02 + 3.71386777E-01 1.06111649E-01 1.119533834E-03 5.19777257E-02 + 3.71490055E-01 1.06141161E-01 1.120384931E-03 5.19777325E-02 + 3.71593333E-01 1.06170672E-01 1.121240960E-03 5.19777393E-02 + 3.71696610E-01 1.06200183E-01 1.122101937E-03 5.19777462E-02 + 3.71799888E-01 1.06229695E-01 1.122967879E-03 5.19777531E-02 + 3.71903166E-01 1.06259206E-01 1.123838802E-03 5.19777599E-02 + 3.72006444E-01 1.06288717E-01 1.124714724E-03 5.19777668E-02 + 3.72109721E-01 1.06318229E-01 1.125595661E-03 5.19777737E-02 + 3.72212999E-01 1.06347740E-01 1.126481629E-03 5.19777807E-02 + 3.72316277E-01 1.06377251E-01 1.127372645E-03 5.19777876E-02 + 3.72419555E-01 1.06406763E-01 1.128268724E-03 5.19777946E-02 + 3.72522832E-01 1.06436274E-01 1.129169884E-03 5.19778015E-02 + 3.72626110E-01 1.06465785E-01 1.130076141E-03 5.19778085E-02 + 3.72729388E-01 1.06495297E-01 1.130987511E-03 5.19778155E-02 + 3.72832666E-01 1.06524808E-01 1.131904009E-03 5.19778225E-02 + 3.72935943E-01 1.06554319E-01 1.132825653E-03 5.19778296E-02 + 3.73039221E-01 1.06583831E-01 1.133752457E-03 5.19778366E-02 + 3.73142499E-01 1.06613342E-01 1.134684439E-03 5.19778437E-02 + 3.73245777E-01 1.06642854E-01 1.135621614E-03 5.19778508E-02 + 3.73349054E-01 1.06672365E-01 1.136563997E-03 5.19778579E-02 + 3.73452332E-01 1.06701876E-01 1.137511605E-03 5.19778651E-02 + 3.73555610E-01 1.06731388E-01 1.138464453E-03 5.19778722E-02 + 3.73658888E-01 1.06760899E-01 1.139422558E-03 5.19778793E-02 + 3.73762165E-01 1.06790411E-01 1.140385933E-03 5.19778865E-02 + 3.73865443E-01 1.06819922E-01 1.141354595E-03 5.19778937E-02 + 3.73968721E-01 1.06849434E-01 1.142328559E-03 5.19779009E-02 + 3.74071999E-01 1.06878945E-01 1.143307841E-03 5.19779082E-02 + 3.74175276E-01 1.06908457E-01 1.144292456E-03 5.19779154E-02 + 3.74278554E-01 1.06937968E-01 1.145282419E-03 5.19779227E-02 + 3.74381832E-01 1.06967480E-01 1.146277745E-03 5.19779299E-02 + 3.74485110E-01 1.06996991E-01 1.147278448E-03 5.19779372E-02 + 3.74588387E-01 1.07026503E-01 1.148284545E-03 5.19779445E-02 + 3.74691665E-01 1.07056014E-01 1.149296050E-03 5.19779519E-02 + 3.74794943E-01 1.07085526E-01 1.150312979E-03 5.19779592E-02 + 3.74898221E-01 1.07115038E-01 1.151335344E-03 5.19779666E-02 + 3.75001498E-01 1.07144549E-01 1.152363162E-03 5.19779739E-02 + 3.75104776E-01 1.07174061E-01 1.153396447E-03 5.19779813E-02 + 3.75208054E-01 1.07203572E-01 1.154435212E-03 5.19779888E-02 + 3.75311332E-01 1.07233084E-01 1.155479474E-03 5.19779962E-02 + 3.75414609E-01 1.07262596E-01 1.156529245E-03 5.19780036E-02 + 3.75517887E-01 1.07292107E-01 1.157584542E-03 5.19780111E-02 + 3.75621165E-01 1.07321619E-01 1.158645376E-03 5.19780186E-02 + 3.75724443E-01 1.07351130E-01 1.159711763E-03 5.19780261E-02 + 3.75827720E-01 1.07380642E-01 1.160783717E-03 5.19780336E-02 + 3.75930998E-01 1.07410154E-01 1.161861251E-03 5.19780411E-02 + 3.76034276E-01 1.07439665E-01 1.162944380E-03 5.19780487E-02 + 3.76137554E-01 1.07469177E-01 1.164033117E-03 5.19780563E-02 + 3.76240831E-01 1.07498689E-01 1.165127476E-03 5.19780639E-02 + 3.76344109E-01 1.07528201E-01 1.166227470E-03 5.19780715E-02 + 3.76447387E-01 1.07557712E-01 1.167333113E-03 5.19780791E-02 + 3.76550664E-01 1.07587224E-01 1.168444418E-03 5.19780867E-02 + 3.76653942E-01 1.07616736E-01 1.169561400E-03 5.19780944E-02 + 3.76757220E-01 1.07646247E-01 1.170684069E-03 5.19781021E-02 + 3.76860498E-01 1.07675759E-01 1.171812442E-03 5.19781098E-02 + 3.76963775E-01 1.07705271E-01 1.172946529E-03 5.19781175E-02 + 3.77067053E-01 1.07734783E-01 1.174086344E-03 5.19781252E-02 + 3.77170331E-01 1.07764295E-01 1.175231901E-03 5.19781330E-02 + 3.77273609E-01 1.07793806E-01 1.176383211E-03 5.19781407E-02 + 3.77376886E-01 1.07823318E-01 1.177540288E-03 5.19781485E-02 + 3.77480164E-01 1.07852830E-01 1.178703144E-03 5.19781563E-02 + 3.77583442E-01 1.07882342E-01 1.179871792E-03 5.19781642E-02 + 3.77686720E-01 1.07911854E-01 1.181046243E-03 5.19781720E-02 + 3.77789997E-01 1.07941365E-01 1.182226512E-03 5.19781798E-02 + 3.77893275E-01 1.07970877E-01 1.183412609E-03 5.19781877E-02 + 3.77996553E-01 1.08000389E-01 1.184604547E-03 5.19781956E-02 + 3.78099831E-01 1.08029901E-01 1.185802338E-03 5.19782035E-02 + 3.78203108E-01 1.08059413E-01 1.187005993E-03 5.19782115E-02 + 3.78306386E-01 1.08088925E-01 1.188215525E-03 5.19782194E-02 + 3.78409664E-01 1.08118437E-01 1.189430945E-03 5.19782274E-02 + 3.78512942E-01 1.08147949E-01 1.190652269E-03 5.19782354E-02 + 3.78616219E-01 1.08177461E-01 1.191879504E-03 5.19782434E-02 + 3.78719497E-01 1.08206973E-01 1.193112660E-03 5.19782514E-02 + 3.78822775E-01 1.08236484E-01 1.194351751E-03 5.19782595E-02 + 3.78926053E-01 1.08265996E-01 1.195596785E-03 5.19782675E-02 + 3.79029330E-01 1.08295508E-01 1.196847781E-03 5.19782756E-02 + 3.79132608E-01 1.08325020E-01 1.198104748E-03 5.19782837E-02 + 3.79235886E-01 1.08354532E-01 1.199367686E-03 5.19782918E-02 + 3.79339164E-01 1.08384044E-01 1.200636623E-03 5.19783000E-02 + 3.79442441E-01 1.08413556E-01 1.201911559E-03 5.19783081E-02 + 3.79545719E-01 1.08443068E-01 1.203192502E-03 5.19783163E-02 + 3.79648997E-01 1.08472580E-01 1.204479471E-03 5.19783245E-02 + 3.79752275E-01 1.08502092E-01 1.205772473E-03 5.19783327E-02 + 3.79855552E-01 1.08531605E-01 1.207071522E-03 5.19783409E-02 + 3.79958830E-01 1.08561117E-01 1.208376625E-03 5.19783492E-02 + 3.80062108E-01 1.08590629E-01 1.209687788E-03 5.19783575E-02 + 3.80165386E-01 1.08620141E-01 1.211005024E-03 5.19783657E-02 + 3.80268663E-01 1.08649653E-01 1.212328352E-03 5.19783741E-02 + 3.80371941E-01 1.08679165E-01 1.213657767E-03 5.19783824E-02 + 3.80475219E-01 1.08708677E-01 1.214993293E-03 5.19783907E-02 + 3.80578497E-01 1.08738189E-01 1.216334930E-03 5.19783991E-02 + 3.80681774E-01 1.08767701E-01 1.217682686E-03 5.19784075E-02 + 3.80785052E-01 1.08797213E-01 1.219036584E-03 5.19784159E-02 + 3.80888330E-01 1.08826726E-01 1.220396618E-03 5.19784243E-02 + 3.80991608E-01 1.08856238E-01 1.221762812E-03 5.19784328E-02 + 3.81094885E-01 1.08885750E-01 1.223135161E-03 5.19784412E-02 + 3.81198163E-01 1.08915262E-01 1.224513681E-03 5.19784497E-02 + 3.81301441E-01 1.08944774E-01 1.225898386E-03 5.19784582E-02 + 3.81404719E-01 1.08974287E-01 1.227289280E-03 5.19784667E-02 + 3.81507996E-01 1.09003799E-01 1.228686369E-03 5.19784753E-02 + 3.81611274E-01 1.09033311E-01 1.230089665E-03 5.19784838E-02 + 3.81714552E-01 1.09062823E-01 1.231499171E-03 5.19784924E-02 + 3.81817830E-01 1.09092336E-01 1.232914908E-03 5.19785010E-02 + 3.81921107E-01 1.09121848E-01 1.234336878E-03 5.19785096E-02 + 3.82024385E-01 1.09151360E-01 1.235765087E-03 5.19785183E-02 + 3.82127663E-01 1.09180872E-01 1.237199547E-03 5.19785269E-02 + 3.82230941E-01 1.09210385E-01 1.238640267E-03 5.19785356E-02 + 3.82334218E-01 1.09239897E-01 1.240087247E-03 5.19785443E-02 + 3.82437496E-01 1.09269409E-01 1.241540503E-03 5.19785530E-02 + 3.82540774E-01 1.09298922E-01 1.243000040E-03 5.19785618E-02 + 3.82644052E-01 1.09328434E-01 1.244465868E-03 5.19785705E-02 + 3.82747329E-01 1.09357946E-01 1.245937998E-03 5.19785793E-02 + 3.82850607E-01 1.09387459E-01 1.247416428E-03 5.19785881E-02 + 3.82953885E-01 1.09416971E-01 1.248901167E-03 5.19785969E-02 + 3.83057163E-01 1.09446484E-01 1.250392233E-03 5.19786058E-02 + 3.83160440E-01 1.09475996E-01 1.251889629E-03 5.19786146E-02 + 3.83263718E-01 1.09505508E-01 1.253393352E-03 5.19786235E-02 + 3.83366996E-01 1.09535021E-01 1.254903425E-03 5.19786324E-02 + 3.83470274E-01 1.09564533E-01 1.256419839E-03 5.19786414E-02 + 3.83573551E-01 1.09594046E-01 1.257942617E-03 5.19786503E-02 + 3.83676829E-01 1.09623558E-01 1.259471754E-03 5.19786593E-02 + 3.83780107E-01 1.09653071E-01 1.261007268E-03 5.19786682E-02 + 3.83883385E-01 1.09682583E-01 1.262549154E-03 5.19786772E-02 + 3.83986662E-01 1.09712096E-01 1.264097422E-03 5.19786863E-02 + 3.84089940E-01 1.09741608E-01 1.265652082E-03 5.19786953E-02 + 3.84193218E-01 1.09771121E-01 1.267213142E-03 5.19787044E-02 + 3.84296496E-01 1.09800633E-01 1.268780599E-03 5.19787135E-02 + 3.84399773E-01 1.09830146E-01 1.270354474E-03 5.19787226E-02 + 3.84503051E-01 1.09859658E-01 1.271934758E-03 5.19787317E-02 + 3.84606329E-01 1.09889171E-01 1.273521465E-03 5.19787409E-02 + 3.84709606E-01 1.09918683E-01 1.275114605E-03 5.19787500E-02 + 3.84812884E-01 1.09948196E-01 1.276714172E-03 5.19787592E-02 + 3.84916162E-01 1.09977709E-01 1.278320183E-03 5.19787684E-02 + 3.85019440E-01 1.10007221E-01 1.279932638E-03 5.19787777E-02 + 3.85122717E-01 1.10036734E-01 1.281551547E-03 5.19787869E-02 + 3.85225995E-01 1.10066247E-01 1.283176911E-03 5.19787962E-02 + 3.85329273E-01 1.10095759E-01 1.284808746E-03 5.19788055E-02 + 3.85432551E-01 1.10125272E-01 1.286447038E-03 5.19788148E-02 + 3.85535828E-01 1.10154785E-01 1.288091810E-03 5.19788242E-02 + 3.85639106E-01 1.10184297E-01 1.289743056E-03 5.19788335E-02 + 3.85742384E-01 1.10213810E-01 1.291400792E-03 5.19788429E-02 + 3.85845662E-01 1.10243323E-01 1.293065011E-03 5.19788523E-02 + 3.85948939E-01 1.10272835E-01 1.294735728E-03 5.19788617E-02 + 3.86052217E-01 1.10302348E-01 1.296412944E-03 5.19788712E-02 + 3.86155495E-01 1.10331861E-01 1.298096667E-03 5.19788806E-02 + 3.86258773E-01 1.10361374E-01 1.299786897E-03 5.19788901E-02 + 3.86362050E-01 1.10390886E-01 1.301483635E-03 5.19788996E-02 + 3.86465328E-01 1.10420399E-01 1.303186903E-03 5.19789092E-02 + 3.86568606E-01 1.10449912E-01 1.304896686E-03 5.19789187E-02 + 3.86671884E-01 1.10479425E-01 1.306612999E-03 5.19789283E-02 + 3.86775161E-01 1.10508938E-01 1.308335843E-03 5.19789379E-02 + 3.86878439E-01 1.10538450E-01 1.310065224E-03 5.19789475E-02 + 3.86981717E-01 1.10567963E-01 1.311801142E-03 5.19789572E-02 + 3.87084995E-01 1.10597476E-01 1.313543613E-03 5.19789668E-02 + 3.87188272E-01 1.10626989E-01 1.315292627E-03 5.19789765E-02 + 3.87291550E-01 1.10656502E-01 1.317048200E-03 5.19789862E-02 + 3.87394828E-01 1.10686015E-01 1.318810324E-03 5.19789959E-02 + 3.87498106E-01 1.10715528E-01 1.320579013E-03 5.19790057E-02 + 3.87601383E-01 1.10745041E-01 1.322354266E-03 5.19790155E-02 + 3.87704661E-01 1.10774554E-01 1.324136083E-03 5.19790253E-02 + 3.87807939E-01 1.10804067E-01 1.325924477E-03 5.19790351E-02 + 3.87911217E-01 1.10833579E-01 1.327719448E-03 5.19790449E-02 + 3.88014494E-01 1.10863092E-01 1.329520995E-03 5.19790548E-02 + 3.88117772E-01 1.10892605E-01 1.331329132E-03 5.19790647E-02 + 3.88221050E-01 1.10922118E-01 1.333143849E-03 5.19790746E-02 + 3.88324328E-01 1.10951631E-01 1.334965162E-03 5.19790845E-02 + 3.88427605E-01 1.10981144E-01 1.336793060E-03 5.19790945E-02 + 3.88530883E-01 1.11010658E-01 1.338627558E-03 5.19791044E-02 + 3.88634161E-01 1.11040171E-01 1.340468662E-03 5.19791144E-02 + 3.88737439E-01 1.11069684E-01 1.342316363E-03 5.19791245E-02 + 3.88840716E-01 1.11099197E-01 1.344170666E-03 5.19791345E-02 + 3.88943994E-01 1.11128710E-01 1.346031586E-03 5.19791446E-02 + 3.89047272E-01 1.11158223E-01 1.347899112E-03 5.19791547E-02 + 3.89150550E-01 1.11187736E-01 1.349773259E-03 5.19791648E-02 + 3.89253827E-01 1.11217249E-01 1.351654023E-03 5.19791749E-02 + 3.89357105E-01 1.11246762E-01 1.353541404E-03 5.19791851E-02 + 3.89460383E-01 1.11276275E-01 1.355435407E-03 5.19791952E-02 + 3.89563661E-01 1.11305789E-01 1.357336038E-03 5.19792054E-02 + 3.89666938E-01 1.11335302E-01 1.359243293E-03 5.19792157E-02 + 3.89770216E-01 1.11364815E-01 1.361157180E-03 5.19792259E-02 + 3.89873494E-01 1.11394328E-01 1.363077702E-03 5.19792362E-02 + 3.89976772E-01 1.11423841E-01 1.365004857E-03 5.19792465E-02 + 3.90080049E-01 1.11453355E-01 1.366938660E-03 5.19792568E-02 + 3.90183327E-01 1.11482868E-01 1.368879091E-03 5.19792671E-02 + 3.90286605E-01 1.11512381E-01 1.370826171E-03 5.19792775E-02 + 3.90389883E-01 1.11541894E-01 1.372779890E-03 5.19792879E-02 + 3.90493160E-01 1.11571408E-01 1.374740260E-03 5.19792983E-02 + 3.90596438E-01 1.11600921E-01 1.376707279E-03 5.19793087E-02 + 3.90699716E-01 1.11630434E-01 1.378680952E-03 5.19793192E-02 + 3.90802994E-01 1.11659948E-01 1.380661275E-03 5.19793297E-02 + 3.90906271E-01 1.11689461E-01 1.382648247E-03 5.19793402E-02 + 3.91009549E-01 1.11718974E-01 1.384641886E-03 5.19793507E-02 + 3.91112827E-01 1.11748488E-01 1.386642175E-03 5.19793613E-02 + 3.91216105E-01 1.11778001E-01 1.388649126E-03 5.19793718E-02 + 3.91319382E-01 1.11807515E-01 1.390662743E-03 5.19793824E-02 + 3.91422660E-01 1.11837028E-01 1.392683023E-03 5.19793931E-02 + 3.91525938E-01 1.11866541E-01 1.394709964E-03 5.19794037E-02 + 3.91629216E-01 1.11896055E-01 1.396743576E-03 5.19794144E-02 + 3.91732493E-01 1.11925568E-01 1.398783858E-03 5.19794251E-02 + 3.91835771E-01 1.11955082E-01 1.400830805E-03 5.19794358E-02 + 3.91939049E-01 1.11984595E-01 1.402884429E-03 5.19794466E-02 + 3.92042327E-01 1.12014109E-01 1.404944719E-03 5.19794573E-02 + 3.92145604E-01 1.12043622E-01 1.407011688E-03 5.19794681E-02 + 3.92248882E-01 1.12073136E-01 1.409085339E-03 5.19794789E-02 + 3.92352160E-01 1.12102649E-01 1.411165661E-03 5.19794898E-02 + 3.92455437E-01 1.12132163E-01 1.413252657E-03 5.19795006E-02 + 3.92558715E-01 1.12161676E-01 1.415346341E-03 5.19795115E-02 + 3.92661993E-01 1.12191190E-01 1.417446699E-03 5.19795224E-02 + 3.92765271E-01 1.12220704E-01 1.419553745E-03 5.19795334E-02 + 3.92868548E-01 1.12250217E-01 1.421667473E-03 5.19795443E-02 + 3.92971826E-01 1.12279731E-01 1.423787889E-03 5.19795553E-02 + 3.93075104E-01 1.12309244E-01 1.425914979E-03 5.19795663E-02 + 3.93178382E-01 1.12338758E-01 1.428048764E-03 5.19795774E-02 + 3.93281659E-01 1.12368272E-01 1.430189240E-03 5.19795884E-02 + 3.93384937E-01 1.12397785E-01 1.432336394E-03 5.19795995E-02 + 3.93488215E-01 1.12427299E-01 1.434490246E-03 5.19796106E-02 + 3.93591493E-01 1.12456813E-01 1.436650783E-03 5.19796218E-02 + 3.93694770E-01 1.12486327E-01 1.438818018E-03 5.19796329E-02 + 3.93798048E-01 1.12515840E-01 1.440991939E-03 5.19796441E-02 + 3.93901326E-01 1.12545354E-01 1.443172555E-03 5.19796553E-02 + 3.94004604E-01 1.12574868E-01 1.445359864E-03 5.19796665E-02 + 3.94107881E-01 1.12604382E-01 1.447553869E-03 5.19796778E-02 + 3.94211159E-01 1.12633895E-01 1.449754565E-03 5.19796891E-02 + 3.94314437E-01 1.12663409E-01 1.451961964E-03 5.19797004E-02 + 3.94417715E-01 1.12692923E-01 1.454176053E-03 5.19797117E-02 + 3.94520992E-01 1.12722437E-01 1.456396844E-03 5.19797231E-02 + 3.94624270E-01 1.12751951E-01 1.458624332E-03 5.19797345E-02 + 3.94727548E-01 1.12781465E-01 1.460858511E-03 5.19797459E-02 + 3.94830826E-01 1.12810979E-01 1.463099403E-03 5.19797573E-02 + 3.94934103E-01 1.12840492E-01 1.465346985E-03 5.19797688E-02 + 3.95037381E-01 1.12870006E-01 1.467601270E-03 5.19797803E-02 + 3.95140659E-01 1.12899520E-01 1.469862252E-03 5.19797918E-02 + 3.95243937E-01 1.12929034E-01 1.472129943E-03 5.19798033E-02 + 3.95347214E-01 1.12958548E-01 1.474404329E-03 5.19798149E-02 + 3.95450492E-01 1.12988062E-01 1.476685422E-03 5.19798265E-02 + 3.95553770E-01 1.13017576E-01 1.478973218E-03 5.19798381E-02 + 3.95657048E-01 1.13047090E-01 1.481267711E-03 5.19798497E-02 + 3.95760325E-01 1.13076604E-01 1.483568912E-03 5.19798614E-02 + 3.95863603E-01 1.13106118E-01 1.485876816E-03 5.19798731E-02 + 3.95966881E-01 1.13135632E-01 1.488191427E-03 5.19798848E-02 + 3.96070159E-01 1.13165146E-01 1.490512747E-03 5.19798966E-02 + 3.96173436E-01 1.13194660E-01 1.492840764E-03 5.19799083E-02 + 3.96276714E-01 1.13224174E-01 1.495175488E-03 5.19799201E-02 + 3.96379992E-01 1.13253689E-01 1.497516922E-03 5.19799320E-02 + 3.96483270E-01 1.13283203E-01 1.499865054E-03 5.19799438E-02 + 3.96586547E-01 1.13312717E-01 1.502219902E-03 5.19799557E-02 + 3.96689825E-01 1.13342231E-01 1.504581453E-03 5.19799676E-02 + 3.96793103E-01 1.13371745E-01 1.506949710E-03 5.19799795E-02 + 3.96896381E-01 1.13401259E-01 1.509324668E-03 5.19799915E-02 + 3.96999658E-01 1.13430774E-01 1.511706346E-03 5.19800035E-02 + 3.97102936E-01 1.13460288E-01 1.514094722E-03 5.19800155E-02 + 3.97206214E-01 1.13489802E-01 1.516489816E-03 5.19800275E-02 + 3.97309492E-01 1.13519316E-01 1.518891606E-03 5.19800396E-02 + 3.97412769E-01 1.13548831E-01 1.521300111E-03 5.19800517E-02 + 3.97516047E-01 1.13578345E-01 1.523715326E-03 5.19800638E-02 + 3.97619325E-01 1.13607859E-01 1.526137253E-03 5.19800759E-02 + 3.97722603E-01 1.13637373E-01 1.528565888E-03 5.19800881E-02 + 3.97825880E-01 1.13666888E-01 1.531001224E-03 5.19801003E-02 + 3.97929158E-01 1.13696402E-01 1.533443282E-03 5.19801125E-02 + 3.98032436E-01 1.13725916E-01 1.535892039E-03 5.19801247E-02 + 3.98135714E-01 1.13755431E-01 1.538347515E-03 5.19801370E-02 + 3.98238991E-01 1.13784945E-01 1.540809695E-03 5.19801493E-02 + 3.98342269E-01 1.13814460E-01 1.543278583E-03 5.19801617E-02 + 3.98445547E-01 1.13843974E-01 1.545754189E-03 5.19801740E-02 + 3.98548825E-01 1.13873488E-01 1.548236500E-03 5.19801864E-02 + 3.98652102E-01 1.13903003E-01 1.550725527E-03 5.19801988E-02 + 3.98755380E-01 1.13932517E-01 1.553221265E-03 5.19802113E-02 + 3.98858658E-01 1.13962032E-01 1.555723715E-03 5.19802237E-02 + 3.98961936E-01 1.13991546E-01 1.558232873E-03 5.19802362E-02 + 3.99065213E-01 1.14021061E-01 1.560748741E-03 5.19802487E-02 + 3.99168491E-01 1.14050575E-01 1.563271322E-03 5.19802613E-02 + 3.99271769E-01 1.14080090E-01 1.565800619E-03 5.19802739E-02 + 3.99375047E-01 1.14109605E-01 1.568336626E-03 5.19802865E-02 + 3.99478324E-01 1.14139119E-01 1.570879346E-03 5.19802991E-02 + 3.99581602E-01 1.14168634E-01 1.573428781E-03 5.19803118E-02 + 3.99684880E-01 1.14198148E-01 1.575984927E-03 5.19803245E-02 + 3.99788158E-01 1.14227663E-01 1.578547784E-03 5.19803372E-02 + 3.99891435E-01 1.14257178E-01 1.581117358E-03 5.19803499E-02 + 3.99994713E-01 1.14286692E-01 1.583693641E-03 5.19803627E-02 + 4.00097991E-01 1.14316207E-01 1.586276636E-03 5.19803755E-02 + 4.00201268E-01 1.14345722E-01 1.588866347E-03 5.19803883E-02 + 4.00304546E-01 1.14375236E-01 1.591462775E-03 5.19804012E-02 + 4.00407824E-01 1.14404751E-01 1.594065916E-03 5.19804141E-02 + 4.00511102E-01 1.14434266E-01 1.596675772E-03 5.19804270E-02 + 4.00614379E-01 1.14463781E-01 1.599292345E-03 5.19804399E-02 + 4.00717657E-01 1.14493295E-01 1.601915631E-03 5.19804529E-02 + 4.00820935E-01 1.14522810E-01 1.604545631E-03 5.19804659E-02 + 4.00924213E-01 1.14552325E-01 1.607182349E-03 5.19804789E-02 + 4.01027490E-01 1.14581840E-01 1.609825787E-03 5.19804920E-02 + 4.01130768E-01 1.14611355E-01 1.612475931E-03 5.19805051E-02 + 4.01234046E-01 1.14640870E-01 1.615132801E-03 5.19805182E-02 + 4.01337324E-01 1.14670384E-01 1.617796383E-03 5.19805313E-02 + 4.01440601E-01 1.14699899E-01 1.620466687E-03 5.19805445E-02 + 4.01543879E-01 1.14729414E-01 1.623143700E-03 5.19805577E-02 + 4.01647157E-01 1.14758929E-01 1.625827442E-03 5.19805709E-02 + 4.01750435E-01 1.14788444E-01 1.628517889E-03 5.19805842E-02 + 4.01853712E-01 1.14817959E-01 1.631215070E-03 5.19805975E-02 + 4.01956990E-01 1.14847474E-01 1.633918954E-03 5.19806108E-02 + 4.02060268E-01 1.14876989E-01 1.636629569E-03 5.19806241E-02 + 4.02163546E-01 1.14906504E-01 1.639346901E-03 5.19806375E-02 + 4.02266823E-01 1.14936019E-01 1.642070953E-03 5.19806509E-02 + 4.02370101E-01 1.14965534E-01 1.644801719E-03 5.19806643E-02 + 4.02473379E-01 1.14995049E-01 1.647539219E-03 5.19806778E-02 + 4.02576657E-01 1.15024564E-01 1.650283430E-03 5.19806913E-02 + 4.02679934E-01 1.15054080E-01 1.653034373E-03 5.19807048E-02 + 4.02783212E-01 1.15083595E-01 1.655792032E-03 5.19807183E-02 + 4.02886490E-01 1.15113110E-01 1.658556410E-03 5.19807319E-02 + 4.02989768E-01 1.15142625E-01 1.661327521E-03 5.19807455E-02 + 4.03093045E-01 1.15172140E-01 1.664105348E-03 5.19807592E-02 + 4.03196323E-01 1.15201655E-01 1.666889903E-03 5.19807728E-02 + 4.03299601E-01 1.15231171E-01 1.669681182E-03 5.19807865E-02 + 4.03402879E-01 1.15260686E-01 1.672479186E-03 5.19808003E-02 + 4.03506156E-01 1.15290201E-01 1.675283919E-03 5.19808140E-02 + 4.03609434E-01 1.15319716E-01 1.678095375E-03 5.19808278E-02 + 4.03712712E-01 1.15349232E-01 1.680913565E-03 5.19808416E-02 + 4.03815990E-01 1.15378747E-01 1.683738485E-03 5.19808555E-02 + 4.03919267E-01 1.15408262E-01 1.686570128E-03 5.19808694E-02 + 4.04022545E-01 1.15437778E-01 1.689408497E-03 5.19808833E-02 + 4.04125823E-01 1.15467293E-01 1.692253604E-03 5.19808972E-02 + 4.04229101E-01 1.15496808E-01 1.695105444E-03 5.19809112E-02 + 4.04332378E-01 1.15526324E-01 1.697964010E-03 5.19809252E-02 + 4.04435656E-01 1.15555839E-01 1.700829307E-03 5.19809392E-02 + 4.04538934E-01 1.15585355E-01 1.703701345E-03 5.19809533E-02 + 4.04642212E-01 1.15614870E-01 1.706580110E-03 5.19809674E-02 + 4.04745489E-01 1.15644385E-01 1.709465614E-03 5.19809815E-02 + 4.04848767E-01 1.15673901E-01 1.712357852E-03 5.19809956E-02 + 4.04952045E-01 1.15703416E-01 1.715256826E-03 5.19810098E-02 + 4.05055323E-01 1.15732932E-01 1.718162541E-03 5.19810240E-02 + 4.05158600E-01 1.15762447E-01 1.721074999E-03 5.19810383E-02 + 4.05261878E-01 1.15791963E-01 1.723994194E-03 5.19810525E-02 + 4.05365156E-01 1.15821479E-01 1.726920120E-03 5.19810669E-02 + 4.05468434E-01 1.15850994E-01 1.729852800E-03 5.19810812E-02 + 4.05571711E-01 1.15880510E-01 1.732792218E-03 5.19810956E-02 + 4.05674989E-01 1.15910025E-01 1.735738377E-03 5.19811100E-02 + 4.05778267E-01 1.15939541E-01 1.738691282E-03 5.19811244E-02 + 4.05881545E-01 1.15969057E-01 1.741650934E-03 5.19811389E-02 + 4.05984822E-01 1.15998572E-01 1.744617329E-03 5.19811533E-02 + 4.06088100E-01 1.16028088E-01 1.747590470E-03 5.19811679E-02 + 4.06191378E-01 1.16057604E-01 1.750570370E-03 5.19811824E-02 + 4.06294656E-01 1.16087120E-01 1.753557013E-03 5.19811970E-02 + 4.06397933E-01 1.16116635E-01 1.756550413E-03 5.19812116E-02 + 4.06501211E-01 1.16146151E-01 1.759550562E-03 5.19812263E-02 + 4.06604489E-01 1.16175667E-01 1.762557466E-03 5.19812410E-02 + 4.06707767E-01 1.16205183E-01 1.765571119E-03 5.19812557E-02 + 4.06811044E-01 1.16234699E-01 1.768591532E-03 5.19812704E-02 + 4.06914322E-01 1.16264214E-01 1.771618701E-03 5.19812852E-02 + 4.07017600E-01 1.16293730E-01 1.774652638E-03 5.19813000E-02 + 4.07120878E-01 1.16323246E-01 1.777693329E-03 5.19813149E-02 + 4.07224155E-01 1.16352762E-01 1.780740776E-03 5.19813297E-02 + 4.07327433E-01 1.16382278E-01 1.783794993E-03 5.19813446E-02 + 4.07430711E-01 1.16411794E-01 1.786855975E-03 5.19813596E-02 + 4.07533989E-01 1.16441310E-01 1.789923724E-03 5.19813745E-02 + 4.07637266E-01 1.16470826E-01 1.792998236E-03 5.19813895E-02 + 4.07740544E-01 1.16500342E-01 1.796079523E-03 5.19814046E-02 + 4.07843822E-01 1.16529858E-01 1.799167570E-03 5.19814197E-02 + 4.07947099E-01 1.16559374E-01 1.802262400E-03 5.19814347E-02 + 4.08050377E-01 1.16588890E-01 1.805363998E-03 5.19814499E-02 + 4.08153655E-01 1.16618406E-01 1.808472377E-03 5.19814650E-02 + 4.08256933E-01 1.16647922E-01 1.811587523E-03 5.19814802E-02 + 4.08360210E-01 1.16677439E-01 1.814709456E-03 5.19814955E-02 + 4.08463488E-01 1.16706955E-01 1.817838164E-03 5.19815107E-02 + 4.08566766E-01 1.16736471E-01 1.820973659E-03 5.19815260E-02 + 4.08670044E-01 1.16765987E-01 1.824115935E-03 5.19815414E-02 + 4.08773321E-01 1.16795503E-01 1.827264997E-03 5.19815567E-02 + 4.08876599E-01 1.16825019E-01 1.830420848E-03 5.19815721E-02 + 4.08979877E-01 1.16854536E-01 1.833583483E-03 5.19815876E-02 + 4.09083155E-01 1.16884052E-01 1.836752916E-03 5.19816030E-02 + 4.09186432E-01 1.16913568E-01 1.839929131E-03 5.19816185E-02 + 4.09289710E-01 1.16943085E-01 1.843112151E-03 5.19816340E-02 + 4.09392988E-01 1.16972601E-01 1.846301961E-03 5.19816496E-02 + 4.09496266E-01 1.17002117E-01 1.849498576E-03 5.19816652E-02 + 4.09599543E-01 1.17031634E-01 1.852701989E-03 5.19816808E-02 + 4.09702821E-01 1.17061150E-01 1.855912205E-03 5.19816965E-02 + 4.09806099E-01 1.17090666E-01 1.859129219E-03 5.19817122E-02 + 4.09909377E-01 1.17120183E-01 1.862353053E-03 5.19817279E-02 + 4.10012654E-01 1.17149699E-01 1.865583683E-03 5.19817437E-02 + 4.10115932E-01 1.17179216E-01 1.868821132E-03 5.19817595E-02 + 4.10219210E-01 1.17208732E-01 1.872065396E-03 5.19817753E-02 + 4.10322488E-01 1.17238249E-01 1.875316468E-03 5.19817912E-02 + 4.10425765E-01 1.17267765E-01 1.878574363E-03 5.19818071E-02 + 4.10529043E-01 1.17297282E-01 1.881839074E-03 5.19818230E-02 + 4.10632321E-01 1.17326798E-01 1.885110608E-03 5.19818390E-02 + 4.10735599E-01 1.17356315E-01 1.888388967E-03 5.19818550E-02 + 4.10838876E-01 1.17385832E-01 1.891674147E-03 5.19818710E-02 + 4.10942154E-01 1.17415348E-01 1.894966162E-03 5.19818871E-02 + 4.11045432E-01 1.17444865E-01 1.898265015E-03 5.19819032E-02 + 4.11148710E-01 1.17474382E-01 1.901570693E-03 5.19819193E-02 + 4.11251987E-01 1.17503898E-01 1.904883209E-03 5.19819355E-02 + 4.11355265E-01 1.17533415E-01 1.908202558E-03 5.19819517E-02 + 4.11458543E-01 1.17562932E-01 1.911528754E-03 5.19819679E-02 + 4.11561821E-01 1.17592449E-01 1.914861801E-03 5.19819842E-02 + 4.11665098E-01 1.17621965E-01 1.918201686E-03 5.19820005E-02 + 4.11768376E-01 1.17651482E-01 1.921548421E-03 5.19820169E-02 + 4.11871654E-01 1.17680999E-01 1.924902003E-03 5.19820332E-02 + 4.11974932E-01 1.17710516E-01 1.928262444E-03 5.19820496E-02 + 4.12078209E-01 1.17740033E-01 1.931629741E-03 5.19820661E-02 + 4.12181487E-01 1.17769550E-01 1.935003897E-03 5.19820826E-02 + 4.12284765E-01 1.17799067E-01 1.938384917E-03 5.19820991E-02 + 4.12388043E-01 1.17828583E-01 1.941772797E-03 5.19821157E-02 + 4.12491320E-01 1.17858100E-01 1.945167551E-03 5.19821323E-02 + 4.12594598E-01 1.17887617E-01 1.948569173E-03 5.19821489E-02 + 4.12697876E-01 1.17917134E-01 1.951977669E-03 5.19821655E-02 + 4.12801154E-01 1.17946651E-01 1.955393043E-03 5.19821822E-02 + 4.12904431E-01 1.17976168E-01 1.958815300E-03 5.19821990E-02 + 4.13007709E-01 1.18005686E-01 1.962244435E-03 5.19822157E-02 + 4.13110987E-01 1.18035203E-01 1.965680453E-03 5.19822325E-02 + 4.13214265E-01 1.18064720E-01 1.969123358E-03 5.19822494E-02 + 4.13317542E-01 1.18094237E-01 1.972573156E-03 5.19822663E-02 + 4.13420820E-01 1.18123754E-01 1.976029852E-03 5.19822832E-02 + 4.13524098E-01 1.18153271E-01 1.979493440E-03 5.19823001E-02 + 4.13627376E-01 1.18182788E-01 1.982963925E-03 5.19823171E-02 + 4.13730653E-01 1.18212306E-01 1.986441323E-03 5.19823341E-02 + 4.13833931E-01 1.18241823E-01 1.989925618E-03 5.19823512E-02 + 4.13937209E-01 1.18271340E-01 1.993416826E-03 5.19823683E-02 + 4.14040487E-01 1.18300857E-01 1.996914951E-03 5.19823854E-02 + 4.14143764E-01 1.18330375E-01 2.000419989E-03 5.19824026E-02 + 4.14247042E-01 1.18359892E-01 2.003931954E-03 5.19824198E-02 + 4.14350320E-01 1.18389409E-01 2.007450832E-03 5.19824370E-02 + 4.14453598E-01 1.18418927E-01 2.010976648E-03 5.19824543E-02 + 4.14556875E-01 1.18448444E-01 2.014509387E-03 5.19824716E-02 + 4.14660153E-01 1.18477961E-01 2.018049054E-03 5.19824889E-02 + 4.14763431E-01 1.18507479E-01 2.021595665E-03 5.19825063E-02 + 4.14866709E-01 1.18536996E-01 2.025149214E-03 5.19825238E-02 + 4.14969986E-01 1.18566514E-01 2.028709707E-03 5.19825412E-02 + 4.15073264E-01 1.18596031E-01 2.032277140E-03 5.19825587E-02 + 4.15176542E-01 1.18625549E-01 2.035851536E-03 5.19825762E-02 + 4.15279820E-01 1.18655066E-01 2.039432873E-03 5.19825938E-02 + 4.15383097E-01 1.18684584E-01 2.043021183E-03 5.19826114E-02 + 4.15486375E-01 1.18714102E-01 2.046616445E-03 5.19826291E-02 + 4.15589653E-01 1.18743619E-01 2.050218672E-03 5.19826467E-02 + 4.15692931E-01 1.18773137E-01 2.053827870E-03 5.19826645E-02 + 4.15796208E-01 1.18802655E-01 2.057444035E-03 5.19826822E-02 + 4.15899486E-01 1.18832172E-01 2.061067182E-03 5.19827000E-02 + 4.16002764E-01 1.18861690E-01 2.064697305E-03 5.19827178E-02 + 4.16106041E-01 1.18891208E-01 2.068334422E-03 5.19827357E-02 + 4.16209319E-01 1.18920725E-01 2.071978516E-03 5.19827536E-02 + 4.16312597E-01 1.18950243E-01 2.075629605E-03 5.19827716E-02 + 4.16415875E-01 1.18979761E-01 2.079287692E-03 5.19827895E-02 + 4.16519152E-01 1.19009279E-01 2.082952774E-03 5.19828076E-02 + 4.16622430E-01 1.19038797E-01 2.086624867E-03 5.19828256E-02 + 4.16725708E-01 1.19068315E-01 2.090303955E-03 5.19828437E-02 + 4.16828986E-01 1.19097832E-01 2.093990065E-03 5.19828619E-02 + 4.16932263E-01 1.19127350E-01 2.097683192E-03 5.19828800E-02 + 4.17035541E-01 1.19156868E-01 2.101383331E-03 5.19828982E-02 + 4.17138819E-01 1.19186386E-01 2.105090499E-03 5.19829165E-02 + 4.17242097E-01 1.19215904E-01 2.108804691E-03 5.19829348E-02 + 4.17345374E-01 1.19245422E-01 2.112525912E-03 5.19829531E-02 + 4.17448652E-01 1.19274940E-01 2.116254179E-03 5.19829715E-02 + 4.17551930E-01 1.19304458E-01 2.119989477E-03 5.19829899E-02 + 4.17655208E-01 1.19333976E-01 2.123731832E-03 5.19830083E-02 + 4.17758485E-01 1.19363495E-01 2.127481220E-03 5.19830268E-02 + 4.17861763E-01 1.19393013E-01 2.131237676E-03 5.19830453E-02 + 4.17965041E-01 1.19422531E-01 2.135001186E-03 5.19830639E-02 + 4.18068319E-01 1.19452049E-01 2.138771746E-03 5.19830825E-02 + 4.18171596E-01 1.19481567E-01 2.142549383E-03 5.19831011E-02 + 4.18274874E-01 1.19511086E-01 2.146334091E-03 5.19831198E-02 + 4.18378152E-01 1.19540604E-01 2.150125876E-03 5.19831385E-02 + 4.18481430E-01 1.19570122E-01 2.153924735E-03 5.19831573E-02 + 4.18584707E-01 1.19599640E-01 2.157730684E-03 5.19831761E-02 + 4.18687985E-01 1.19629159E-01 2.161543718E-03 5.19831949E-02 + 4.18791263E-01 1.19658677E-01 2.165363844E-03 5.19832138E-02 + 4.18894541E-01 1.19688195E-01 2.169191076E-03 5.19832327E-02 + 4.18997818E-01 1.19717714E-01 2.173025402E-03 5.19832516E-02 + 4.19101096E-01 1.19747232E-01 2.176866838E-03 5.19832706E-02 + 4.19204374E-01 1.19776751E-01 2.180715389E-03 5.19832897E-02 + 4.19307652E-01 1.19806269E-01 2.184571052E-03 5.19833087E-02 + 4.19410929E-01 1.19835788E-01 2.188433841E-03 5.19833278E-02 + 4.19514207E-01 1.19865306E-01 2.192303755E-03 5.19833470E-02 + 4.19617485E-01 1.19894825E-01 2.196180798E-03 5.19833662E-02 + 4.19720763E-01 1.19924343E-01 2.200064978E-03 5.19833854E-02 + 4.19824040E-01 1.19953862E-01 2.203956299E-03 5.19834047E-02 + 4.19927318E-01 1.19983381E-01 2.207854768E-03 5.19834240E-02 + 4.20030596E-01 1.20012899E-01 2.211760382E-03 5.19834434E-02 + 4.20133874E-01 1.20042418E-01 2.215673156E-03 5.19834628E-02 + 4.20237151E-01 1.20071937E-01 2.219593088E-03 5.19834822E-02 + 4.20340429E-01 1.20101455E-01 2.223520192E-03 5.19835017E-02 + 4.20443707E-01 1.20130974E-01 2.227454455E-03 5.19835212E-02 + 4.20546985E-01 1.20160493E-01 2.231395904E-03 5.19835407E-02 + 4.20650262E-01 1.20190012E-01 2.235344525E-03 5.19835603E-02 + 4.20753540E-01 1.20219530E-01 2.239300334E-03 5.19835800E-02 + 4.20856818E-01 1.20249049E-01 2.243263338E-03 5.19835997E-02 + 4.20960096E-01 1.20278568E-01 2.247233542E-03 5.19836194E-02 + 4.21063373E-01 1.20308087E-01 2.251210934E-03 5.19836391E-02 + 4.21166651E-01 1.20337606E-01 2.255195539E-03 5.19836589E-02 + 4.21269929E-01 1.20367125E-01 2.259187364E-03 5.19836788E-02 + 4.21373207E-01 1.20396644E-01 2.263186396E-03 5.19836987E-02 + 4.21476484E-01 1.20426163E-01 2.267192651E-03 5.19837186E-02 + 4.21579762E-01 1.20455682E-01 2.271206135E-03 5.19837386E-02 + 4.21683040E-01 1.20485201E-01 2.275226854E-03 5.19837586E-02 + 4.21786318E-01 1.20514720E-01 2.279254806E-03 5.19837786E-02 + 4.21889595E-01 1.20544239E-01 2.283290007E-03 5.19837987E-02 + 4.21992873E-01 1.20573758E-01 2.287332463E-03 5.19838189E-02 + 4.22096151E-01 1.20603277E-01 2.291382161E-03 5.19838391E-02 + 4.22199429E-01 1.20632797E-01 2.295439127E-03 5.19838593E-02 + 4.22302706E-01 1.20662316E-01 2.299503358E-03 5.19838795E-02 + 4.22405984E-01 1.20691835E-01 2.303574861E-03 5.19838998E-02 + 4.22509262E-01 1.20721354E-01 2.307653632E-03 5.19839202E-02 + 4.22612540E-01 1.20750874E-01 2.311739698E-03 5.19839406E-02 + 4.22715817E-01 1.20780393E-01 2.315833045E-03 5.19839610E-02 + 4.22819095E-01 1.20809912E-01 2.319933690E-03 5.19839815E-02 + 4.22922373E-01 1.20839432E-01 2.324041631E-03 5.19840020E-02 + 4.23025651E-01 1.20868951E-01 2.328156872E-03 5.19840226E-02 + 4.23128928E-01 1.20898471E-01 2.332279432E-03 5.19840432E-02 + 4.23232206E-01 1.20927990E-01 2.336409307E-03 5.19840638E-02 + 4.23335484E-01 1.20957509E-01 2.340546504E-03 5.19840845E-02 + 4.23438762E-01 1.20987029E-01 2.344691029E-03 5.19841052E-02 + 4.23542039E-01 1.21016548E-01 2.348842889E-03 5.19841260E-02 + 4.23645317E-01 1.21046068E-01 2.353002081E-03 5.19841468E-02 + 4.23748595E-01 1.21075588E-01 2.357168632E-03 5.19841677E-02 + 4.23851872E-01 1.21105107E-01 2.361342529E-03 5.19841886E-02 + 4.23955150E-01 1.21134627E-01 2.365523778E-03 5.19842095E-02 + 4.24058428E-01 1.21164147E-01 2.369712397E-03 5.19842305E-02 + 4.24161706E-01 1.21193666E-01 2.373908381E-03 5.19842516E-02 + 4.24264983E-01 1.21223186E-01 2.378111749E-03 5.19842726E-02 + 4.24368261E-01 1.21252706E-01 2.382322497E-03 5.19842938E-02 + 4.24471539E-01 1.21282225E-01 2.386540622E-03 5.19843149E-02 + 4.24574817E-01 1.21311745E-01 2.390766151E-03 5.19843361E-02 + 4.24678094E-01 1.21341265E-01 2.394999080E-03 5.19843574E-02 + 4.24781372E-01 1.21370785E-01 2.399239418E-03 5.19843787E-02 + 4.24884650E-01 1.21400305E-01 2.403487160E-03 5.19844000E-02 + 4.24987928E-01 1.21429825E-01 2.407742324E-03 5.19844214E-02 + 4.25091205E-01 1.21459345E-01 2.412004917E-03 5.19844428E-02 + 4.25194483E-01 1.21488865E-01 2.416274936E-03 5.19844643E-02 + 4.25297761E-01 1.21518385E-01 2.420552387E-03 5.19844858E-02 + 4.25401039E-01 1.21547905E-01 2.424837289E-03 5.19845074E-02 + 4.25504316E-01 1.21577425E-01 2.429129647E-03 5.19845290E-02 + 4.25607594E-01 1.21606945E-01 2.433429450E-03 5.19845506E-02 + 4.25710872E-01 1.21636465E-01 2.437736724E-03 5.19845723E-02 + 4.25814150E-01 1.21665985E-01 2.442051467E-03 5.19845941E-02 + 4.25917427E-01 1.21695505E-01 2.446373675E-03 5.19846159E-02 + 4.26020705E-01 1.21725025E-01 2.450703375E-03 5.19846377E-02 + 4.26123983E-01 1.21754546E-01 2.455040566E-03 5.19846596E-02 + 4.26227261E-01 1.21784066E-01 2.459385243E-03 5.19846815E-02 + 4.26330538E-01 1.21813586E-01 2.463737425E-03 5.19847035E-02 + 4.26433816E-01 1.21843107E-01 2.468097118E-03 5.19847255E-02 + 4.26537094E-01 1.21872627E-01 2.472464330E-03 5.19847475E-02 + 4.26640372E-01 1.21902147E-01 2.476839058E-03 5.19847696E-02 + 4.26743649E-01 1.21931668E-01 2.481221309E-03 5.19847918E-02 + 4.26846927E-01 1.21961188E-01 2.485611100E-03 5.19848140E-02 + 4.26950205E-01 1.21990708E-01 2.490008429E-03 5.19848362E-02 + 4.27053483E-01 1.22020229E-01 2.494413313E-03 5.19848585E-02 + 4.27156760E-01 1.22049749E-01 2.498825750E-03 5.19848808E-02 + 4.27260038E-01 1.22079270E-01 2.503245746E-03 5.19849032E-02 + 4.27363316E-01 1.22108791E-01 2.507673309E-03 5.19849256E-02 + 4.27466594E-01 1.22138311E-01 2.512108447E-03 5.19849481E-02 + 4.27569871E-01 1.22167832E-01 2.516551176E-03 5.19849706E-02 + 4.27673149E-01 1.22197352E-01 2.521001485E-03 5.19849932E-02 + 4.27776427E-01 1.22226873E-01 2.525459390E-03 5.19850158E-02 + 4.27879705E-01 1.22256394E-01 2.529924899E-03 5.19850384E-02 + 4.27982982E-01 1.22285915E-01 2.534398019E-03 5.19850611E-02 + 4.28086260E-01 1.22315435E-01 2.538878758E-03 5.19850839E-02 + 4.28189538E-01 1.22344956E-01 2.543367123E-03 5.19851067E-02 + 4.28292816E-01 1.22374477E-01 2.547863113E-03 5.19851295E-02 + 4.28396093E-01 1.22403998E-01 2.552366733E-03 5.19851524E-02 + 4.28499371E-01 1.22433519E-01 2.556878012E-03 5.19851753E-02 + 4.28602649E-01 1.22463040E-01 2.561396937E-03 5.19851983E-02 + 4.28705927E-01 1.22492561E-01 2.565923517E-03 5.19852213E-02 + 4.28809204E-01 1.22522082E-01 2.570457767E-03 5.19852444E-02 + 4.28912482E-01 1.22551603E-01 2.574999686E-03 5.19852675E-02 + 4.29015760E-01 1.22581124E-01 2.579549292E-03 5.19852907E-02 + 4.29119038E-01 1.22610645E-01 2.584106581E-03 5.19853139E-02 + 4.29222315E-01 1.22640166E-01 2.588671573E-03 5.19853372E-02 + 4.29325593E-01 1.22669687E-01 2.593244253E-03 5.19853605E-02 + 4.29428871E-01 1.22699208E-01 2.597824650E-03 5.19853839E-02 + 4.29532149E-01 1.22728729E-01 2.602412762E-03 5.19854073E-02 + 4.29635426E-01 1.22758250E-01 2.607008605E-03 5.19854307E-02 + 4.29738704E-01 1.22787772E-01 2.611612168E-03 5.19854542E-02 + 4.29841982E-01 1.22817293E-01 2.616223479E-03 5.19854778E-02 + 4.29945260E-01 1.22846814E-01 2.620842525E-03 5.19855014E-02 + 4.30048537E-01 1.22876336E-01 2.625469333E-03 5.19855251E-02 + 4.30151815E-01 1.22905857E-01 2.630103902E-03 5.19855487E-02 + 4.30255093E-01 1.22935378E-01 2.634746229E-03 5.19855725E-02 + 4.30358371E-01 1.22964900E-01 2.639396342E-03 5.19855963E-02 + 4.30461648E-01 1.22994421E-01 2.644054238E-03 5.19856201E-02 + 4.30564926E-01 1.23023943E-01 2.648719916E-03 5.19856440E-02 + 4.30668204E-01 1.23053464E-01 2.653393403E-03 5.19856680E-02 + 4.30771482E-01 1.23082986E-01 2.658074687E-03 5.19856920E-02 + 4.30874759E-01 1.23112507E-01 2.662763795E-03 5.19857160E-02 + 4.30978037E-01 1.23142029E-01 2.667460716E-03 5.19857401E-02 + 4.31081315E-01 1.23171551E-01 2.672165468E-03 5.19857642E-02 + 4.31184593E-01 1.23201072E-01 2.676878047E-03 5.19857884E-02 + 4.31287870E-01 1.23230594E-01 2.681598483E-03 5.19858126E-02 + 4.31391148E-01 1.23260116E-01 2.686326762E-03 5.19858369E-02 + 4.31494426E-01 1.23289638E-01 2.691062903E-03 5.19858613E-02 + 4.31597703E-01 1.23319159E-01 2.695806914E-03 5.19858856E-02 + 4.31700981E-01 1.23348681E-01 2.700558802E-03 5.19859101E-02 + 4.31804259E-01 1.23378203E-01 2.705318565E-03 5.19859346E-02 + 4.31907537E-01 1.23407725E-01 2.710086222E-03 5.19859591E-02 + 4.32010814E-01 1.23437247E-01 2.714861779E-03 5.19859837E-02 + 4.32114092E-01 1.23466769E-01 2.719645236E-03 5.19860083E-02 + 4.32217370E-01 1.23496291E-01 2.724436610E-03 5.19860330E-02 + 4.32320648E-01 1.23525813E-01 2.729235909E-03 5.19860577E-02 + 4.32423925E-01 1.23555335E-01 2.734043141E-03 5.19860825E-02 + 4.32527203E-01 1.23584857E-01 2.738858304E-03 5.19861073E-02 + 4.32630481E-01 1.23614379E-01 2.743681415E-03 5.19861322E-02 + 4.32733759E-01 1.23643901E-01 2.748512474E-03 5.19861572E-02 + 4.32837036E-01 1.23673424E-01 2.753351507E-03 5.19861821E-02 + 4.32940314E-01 1.23702946E-01 2.758198504E-03 5.19862072E-02 + 4.33043592E-01 1.23732468E-01 2.763053471E-03 5.19862323E-02 + 4.33146870E-01 1.23761990E-01 2.767916437E-03 5.19862574E-02 + 4.33250147E-01 1.23791513E-01 2.772787391E-03 5.19862826E-02 + 4.33353425E-01 1.23821035E-01 2.777666349E-03 5.19863078E-02 + 4.33456703E-01 1.23850557E-01 2.782553311E-03 5.19863331E-02 + 4.33559981E-01 1.23880080E-01 2.787448294E-03 5.19863585E-02 + 4.33663258E-01 1.23909602E-01 2.792351307E-03 5.19863839E-02 + 4.33766536E-01 1.23939125E-01 2.797262356E-03 5.19864093E-02 + 4.33869814E-01 1.23968647E-01 2.802181442E-03 5.19864348E-02 + 4.33973092E-01 1.23998170E-01 2.807108591E-03 5.19864604E-02 + 4.34076369E-01 1.24027692E-01 2.812043792E-03 5.19864860E-02 + 4.34179647E-01 1.24057215E-01 2.816987053E-03 5.19865116E-02 + 4.34282925E-01 1.24086738E-01 2.821938402E-03 5.19865373E-02 + 4.34386203E-01 1.24116260E-01 2.826897827E-03 5.19865631E-02 + 4.34489480E-01 1.24145783E-01 2.831865347E-03 5.19865889E-02 + 4.34592758E-01 1.24175306E-01 2.836840970E-03 5.19866147E-02 + 4.34696036E-01 1.24204829E-01 2.841824704E-03 5.19866407E-02 + 4.34799314E-01 1.24234351E-01 2.846816556E-03 5.19866666E-02 + 4.34902591E-01 1.24263874E-01 2.851816536E-03 5.19866926E-02 + 4.35005869E-01 1.24293397E-01 2.856824651E-03 5.19867187E-02 + 4.35109147E-01 1.24322920E-01 2.861840911E-03 5.19867448E-02 + 4.35212425E-01 1.24352443E-01 2.866865312E-03 5.19867710E-02 + 4.35315702E-01 1.24381966E-01 2.871897883E-03 5.19867972E-02 + 4.35418980E-01 1.24411489E-01 2.876938623E-03 5.19868235E-02 + 4.35522258E-01 1.24441012E-01 2.881987540E-03 5.19868499E-02 + 4.35625536E-01 1.24470535E-01 2.887044632E-03 5.19868762E-02 + 4.35728813E-01 1.24500058E-01 2.892109937E-03 5.19869027E-02 + 4.35832091E-01 1.24529581E-01 2.897183434E-03 5.19869292E-02 + 4.35935369E-01 1.24559105E-01 2.902265141E-03 5.19869557E-02 + 4.36038647E-01 1.24588628E-01 2.907355077E-03 5.19869823E-02 + 4.36141924E-01 1.24618151E-01 2.912453239E-03 5.19870090E-02 + 4.36245202E-01 1.24647674E-01 2.917559636E-03 5.19870357E-02 + 4.36348480E-01 1.24677198E-01 2.922674286E-03 5.19870625E-02 + 4.36451758E-01 1.24706721E-01 2.927797188E-03 5.19870893E-02 + 4.36555035E-01 1.24736244E-01 2.932928351E-03 5.19871162E-02 + 4.36658313E-01 1.24765768E-01 2.938067791E-03 5.19871431E-02 + 4.36761591E-01 1.24795291E-01 2.943215519E-03 5.19871701E-02 + 4.36864869E-01 1.24824815E-01 2.948371531E-03 5.19871971E-02 + 4.36968146E-01 1.24854338E-01 2.953535838E-03 5.19872242E-02 + 4.37071424E-01 1.24883862E-01 2.958708456E-03 5.19872513E-02 + 4.37174702E-01 1.24913386E-01 2.963889395E-03 5.19872785E-02 + 4.37277980E-01 1.24942909E-01 2.969078663E-03 5.19873058E-02 + 4.37381257E-01 1.24972433E-01 2.974276259E-03 5.19873331E-02 + 4.37484535E-01 1.25001957E-01 2.979482210E-03 5.19873604E-02 + 4.37587813E-01 1.25031480E-01 2.984696505E-03 5.19873879E-02 + 4.37691091E-01 1.25061004E-01 2.989919163E-03 5.19874153E-02 + 4.37794368E-01 1.25090528E-01 2.995150193E-03 5.19874429E-02 + 4.37897646E-01 1.25120052E-01 3.000389602E-03 5.19874704E-02 + 4.38000924E-01 1.25149576E-01 3.005637399E-03 5.19874981E-02 + 4.38104202E-01 1.25179100E-01 3.010893603E-03 5.19875258E-02 + 4.38207479E-01 1.25208624E-01 3.016158202E-03 5.19875535E-02 + 4.38310757E-01 1.25238148E-01 3.021431225E-03 5.19875813E-02 + 4.38414035E-01 1.25267672E-01 3.026712670E-03 5.19876092E-02 + 4.38517313E-01 1.25297196E-01 3.032002556E-03 5.19876371E-02 + 4.38620590E-01 1.25326720E-01 3.037300881E-03 5.19876651E-02 + 4.38723868E-01 1.25356244E-01 3.042607664E-03 5.19876931E-02 + 4.38827146E-01 1.25385768E-01 3.047922904E-03 5.19877212E-02 + 4.38930424E-01 1.25415292E-01 3.053246618E-03 5.19877493E-02 + 4.39033701E-01 1.25444817E-01 3.058578807E-03 5.19877775E-02 + 4.39136979E-01 1.25474341E-01 3.063919497E-03 5.19878058E-02 + 4.39240257E-01 1.25503865E-01 3.069268678E-03 5.19878341E-02 + 4.39343534E-01 1.25533390E-01 3.074626368E-03 5.19878624E-02 + 4.39446812E-01 1.25562914E-01 3.079992577E-03 5.19878909E-02 + 4.39550090E-01 1.25592438E-01 3.085367312E-03 5.19879193E-02 + 4.39653368E-01 1.25621963E-01 3.090750592E-03 5.19879479E-02 + 4.39756645E-01 1.25651487E-01 3.096142406E-03 5.19879765E-02 + 4.39859923E-01 1.25681012E-01 3.101542782E-03 5.19880051E-02 + 4.39963201E-01 1.25710537E-01 3.106951720E-03 5.19880338E-02 + 4.40066479E-01 1.25740061E-01 3.112369237E-03 5.19880626E-02 + 4.40169756E-01 1.25769586E-01 3.117795333E-03 5.19880914E-02 + 4.40273034E-01 1.25799110E-01 3.123230025E-03 5.19881203E-02 + 4.40376312E-01 1.25828635E-01 3.128673324E-03 5.19881492E-02 + 4.40479590E-01 1.25858160E-01 3.134125227E-03 5.19881782E-02 + 4.40582867E-01 1.25887685E-01 3.139585753E-03 5.19882073E-02 + 4.40686145E-01 1.25917210E-01 3.145054921E-03 5.19882364E-02 + 4.40789423E-01 1.25946735E-01 3.150532720E-03 5.19882656E-02 + 4.40892701E-01 1.25976259E-01 3.156019168E-03 5.19882948E-02 + 4.40995978E-01 1.26005784E-01 3.161514283E-03 5.19883241E-02 + 4.41099256E-01 1.26035309E-01 3.167018056E-03 5.19883534E-02 + 4.41202534E-01 1.26064834E-01 3.172530524E-03 5.19883828E-02 + 4.41305812E-01 1.26094359E-01 3.178051666E-03 5.19884123E-02 + 4.41409089E-01 1.26123885E-01 3.183581521E-03 5.19884418E-02 + 4.41512367E-01 1.26153410E-01 3.189120078E-03 5.19884714E-02 + 4.41615645E-01 1.26182935E-01 3.194667345E-03 5.19885010E-02 + 4.41718923E-01 1.26212460E-01 3.200223351E-03 5.19885307E-02 + 4.41822200E-01 1.26241985E-01 3.205788086E-03 5.19885605E-02 + 4.41925478E-01 1.26271511E-01 3.211361577E-03 5.19885903E-02 + 4.42028756E-01 1.26301036E-01 3.216943824E-03 5.19886202E-02 + 4.42132034E-01 1.26330561E-01 3.222534835E-03 5.19886501E-02 + 4.42235311E-01 1.26360087E-01 3.228134619E-03 5.19886801E-02 + 4.42338589E-01 1.26389612E-01 3.233743196E-03 5.19887102E-02 + 4.42441867E-01 1.26419138E-01 3.239360573E-03 5.19887403E-02 + 4.42545145E-01 1.26448663E-01 3.244986749E-03 5.19887704E-02 + 4.42648422E-01 1.26478189E-01 3.250621745E-03 5.19888007E-02 + 4.42751700E-01 1.26507715E-01 3.256265557E-03 5.19888310E-02 + 4.42854978E-01 1.26537240E-01 3.261918216E-03 5.19888613E-02 + 4.42958256E-01 1.26566766E-01 3.267579719E-03 5.19888917E-02 + 4.43061533E-01 1.26596292E-01 3.273250087E-03 5.19889222E-02 + 4.43164811E-01 1.26625817E-01 3.278929307E-03 5.19889527E-02 + 4.43268089E-01 1.26655343E-01 3.284617409E-03 5.19889833E-02 + 4.43371367E-01 1.26684869E-01 3.290314401E-03 5.19890140E-02 + 4.43474644E-01 1.26714395E-01 3.296020282E-03 5.19890447E-02 + 4.43577922E-01 1.26743921E-01 3.301735072E-03 5.19890755E-02 + 4.43681200E-01 1.26773447E-01 3.307458779E-03 5.19891063E-02 + 4.43784478E-01 1.26802973E-01 3.313191412E-03 5.19891372E-02 + 4.43887755E-01 1.26832499E-01 3.318932980E-03 5.19891682E-02 + 4.43991033E-01 1.26862025E-01 3.324683501E-03 5.19891992E-02 + 4.44094311E-01 1.26891551E-01 3.330442976E-03 5.19892303E-02 + 4.44197589E-01 1.26921077E-01 3.336211412E-03 5.19892614E-02 + 4.44300866E-01 1.26950604E-01 3.341988829E-03 5.19892926E-02 + 4.44404144E-01 1.26980130E-01 3.347775235E-03 5.19893239E-02 + 4.44507422E-01 1.27009656E-01 3.353570640E-03 5.19893552E-02 + 4.44610700E-01 1.27039182E-01 3.359375052E-03 5.19893866E-02 + 4.44713977E-01 1.27068709E-01 3.365188481E-03 5.19894181E-02 + 4.44817255E-01 1.27098235E-01 3.371010945E-03 5.19894496E-02 + 4.44920533E-01 1.27127762E-01 3.376842443E-03 5.19894812E-02 + 4.45023811E-01 1.27157288E-01 3.382682985E-03 5.19895128E-02 + 4.45127088E-01 1.27186815E-01 3.388532589E-03 5.19895445E-02 + 4.45230366E-01 1.27216341E-01 3.394391275E-03 5.19895763E-02 + 4.45333644E-01 1.27245868E-01 3.400259030E-03 5.19896081E-02 + 4.45436922E-01 1.27275394E-01 3.406135875E-03 5.19896400E-02 + 4.45540199E-01 1.27304921E-01 3.412021818E-03 5.19896720E-02 + 4.45643477E-01 1.27334448E-01 3.417916879E-03 5.19897040E-02 + 4.45746755E-01 1.27363975E-01 3.423821065E-03 5.19897361E-02 + 4.45850033E-01 1.27393502E-01 3.429734377E-03 5.19897682E-02 + 4.45953310E-01 1.27423028E-01 3.435656834E-03 5.19898004E-02 + 4.46056588E-01 1.27452555E-01 3.441588444E-03 5.19898327E-02 + 4.46159866E-01 1.27482082E-01 3.447529216E-03 5.19898650E-02 + 4.46263144E-01 1.27511609E-01 3.453479169E-03 5.19898974E-02 + 4.46366421E-01 1.27541136E-01 3.459438304E-03 5.19899299E-02 + 4.46469699E-01 1.27570663E-01 3.465406627E-03 5.19899624E-02 + 4.46572977E-01 1.27600190E-01 3.471384170E-03 5.19899950E-02 + 4.46676255E-01 1.27629718E-01 3.477370920E-03 5.19900277E-02 + 4.46779532E-01 1.27659245E-01 3.483366896E-03 5.19900604E-02 + 4.46882810E-01 1.27688772E-01 3.489372119E-03 5.19900932E-02 + 4.46986088E-01 1.27718299E-01 3.495386586E-03 5.19901260E-02 + 4.47089366E-01 1.27747827E-01 3.501410308E-03 5.19901589E-02 + 4.47192643E-01 1.27777354E-01 3.507443302E-03 5.19901919E-02 + 4.47295921E-01 1.27806882E-01 3.513485579E-03 5.19902249E-02 + 4.47399199E-01 1.27836409E-01 3.519537147E-03 5.19902580E-02 + 4.47502476E-01 1.27865936E-01 3.525598015E-03 5.19902912E-02 + 4.47605754E-01 1.27895464E-01 3.531668203E-03 5.19903244E-02 + 4.47709032E-01 1.27924992E-01 3.537747709E-03 5.19903578E-02 + 4.47812310E-01 1.27954519E-01 3.543836553E-03 5.19903911E-02 + 4.47915587E-01 1.27984047E-01 3.549934734E-03 5.19904246E-02 + 4.48018865E-01 1.28013575E-01 3.556042281E-03 5.19904581E-02 + 4.48122143E-01 1.28043102E-01 3.562159183E-03 5.19904916E-02 + 4.48225421E-01 1.28072630E-01 3.568285479E-03 5.19905252E-02 + 4.48328698E-01 1.28102158E-01 3.574421148E-03 5.19905589E-02 + 4.48431976E-01 1.28131686E-01 3.580566230E-03 5.19905927E-02 + 4.48535254E-01 1.28161214E-01 3.586720714E-03 5.19906265E-02 + 4.48638532E-01 1.28190742E-01 3.592884619E-03 5.19906604E-02 + 4.48741809E-01 1.28220270E-01 3.599057963E-03 5.19906944E-02 + 4.48845087E-01 1.28249798E-01 3.605240747E-03 5.19907284E-02 + 4.48948365E-01 1.28279326E-01 3.611432989E-03 5.19907625E-02 + 4.49051643E-01 1.28308854E-01 3.617634689E-03 5.19907967E-02 + 4.49154920E-01 1.28338382E-01 3.623845876E-03 5.19908309E-02 + 4.49258198E-01 1.28367911E-01 3.630066538E-03 5.19908652E-02 + 4.49361476E-01 1.28397439E-01 3.636296705E-03 5.19908996E-02 + 4.49464754E-01 1.28426967E-01 3.642536377E-03 5.19909340E-02 + 4.49568031E-01 1.28456496E-01 3.648785582E-03 5.19909685E-02 + 4.49671309E-01 1.28486024E-01 3.655044310E-03 5.19910030E-02 + 4.49774587E-01 1.28515553E-01 3.661312580E-03 5.19910377E-02 + 4.49877865E-01 1.28545081E-01 3.667590401E-03 5.19910724E-02 + 4.49981142E-01 1.28574610E-01 3.673877792E-03 5.19911071E-02 + 4.50084420E-01 1.28604138E-01 3.680174763E-03 5.19911420E-02 + 4.50187698E-01 1.28633667E-01 3.686481312E-03 5.19911769E-02 + 4.50290976E-01 1.28663196E-01 3.692797470E-03 5.19912119E-02 + 4.50394253E-01 1.28692724E-01 3.699123235E-03 5.19912469E-02 + 4.50497531E-01 1.28722253E-01 3.705458616E-03 5.19912820E-02 + 4.50600809E-01 1.28751782E-01 3.711803633E-03 5.19913172E-02 + 4.50704087E-01 1.28781311E-01 3.718158296E-03 5.19913524E-02 + 4.50807364E-01 1.28810840E-01 3.724522612E-03 5.19913877E-02 + 4.50910642E-01 1.28840369E-01 3.730896592E-03 5.19914231E-02 + 4.51013920E-01 1.28869898E-01 3.737280245E-03 5.19914586E-02 + 4.51117198E-01 1.28899427E-01 3.743673599E-03 5.19914941E-02 + 4.51220475E-01 1.28928956E-01 3.750076645E-03 5.19915297E-02 + 4.51323753E-01 1.28958485E-01 3.756489402E-03 5.19915653E-02 + 4.51427031E-01 1.28988014E-01 3.762911888E-03 5.19916011E-02 + 4.51530309E-01 1.29017543E-01 3.769344104E-03 5.19916369E-02 + 4.51633586E-01 1.29047073E-01 3.775786068E-03 5.19916727E-02 + 4.51736864E-01 1.29076602E-01 3.782237790E-03 5.19917087E-02 + 4.51840142E-01 1.29106131E-01 3.788699278E-03 5.19917447E-02 + 4.51943420E-01 1.29135661E-01 3.795170553E-03 5.19917808E-02 + 4.52046697E-01 1.29165190E-01 3.801651614E-03 5.19918169E-02 + 4.52149975E-01 1.29194720E-01 3.808142480E-03 5.19918531E-02 + 4.52253253E-01 1.29224249E-01 3.814643159E-03 5.19918894E-02 + 4.52356531E-01 1.29253779E-01 3.821153663E-03 5.19919258E-02 + 4.52459808E-01 1.29283309E-01 3.827674009E-03 5.19919622E-02 + 4.52563086E-01 1.29312838E-01 3.834204208E-03 5.19919987E-02 + 4.52666364E-01 1.29342368E-01 3.840744257E-03 5.19920353E-02 + 4.52769642E-01 1.29371898E-01 3.847294188E-03 5.19920719E-02 + 4.52872919E-01 1.29401428E-01 3.853853999E-03 5.19921086E-02 + 4.52976197E-01 1.29430958E-01 3.860423710E-03 5.19921454E-02 + 4.53079475E-01 1.29460488E-01 3.867003319E-03 5.19921823E-02 + 4.53182753E-01 1.29490018E-01 3.873592857E-03 5.19922192E-02 + 4.53286030E-01 1.29519548E-01 3.880192322E-03 5.19922562E-02 + 4.53389308E-01 1.29549078E-01 3.886801734E-03 5.19922933E-02 + 4.53492586E-01 1.29578608E-01 3.893421092E-03 5.19923304E-02 + 4.53595864E-01 1.29608138E-01 3.900050426E-03 5.19923676E-02 + 4.53699141E-01 1.29637668E-01 3.906689725E-03 5.19924049E-02 + 4.53802419E-01 1.29667199E-01 3.913339028E-03 5.19924423E-02 + 4.53905697E-01 1.29696729E-01 3.919998325E-03 5.19924797E-02 + 4.54008975E-01 1.29726259E-01 3.926667635E-03 5.19925172E-02 + 4.54112252E-01 1.29755790E-01 3.933346968E-03 5.19925548E-02 + 4.54215530E-01 1.29785320E-01 3.940036342E-03 5.19925924E-02 + 4.54318808E-01 1.29814851E-01 3.946735758E-03 5.19926302E-02 + 4.54422086E-01 1.29844381E-01 3.953445244E-03 5.19926680E-02 + 4.54525363E-01 1.29873912E-01 3.960164800E-03 5.19927058E-02 + 4.54628641E-01 1.29903443E-01 3.966894436E-03 5.19927438E-02 + 4.54731919E-01 1.29932973E-01 3.973634170E-03 5.19927818E-02 + 4.54835197E-01 1.29962504E-01 3.980384013E-03 5.19928199E-02 + 4.54938474E-01 1.29992035E-01 3.987143974E-03 5.19928580E-02 + 4.55041752E-01 1.30021566E-01 3.993914071E-03 5.19928963E-02 + 4.55145030E-01 1.30051097E-01 4.000694305E-03 5.19929346E-02 + 4.55248307E-01 1.30080628E-01 4.007484704E-03 5.19929730E-02 + 4.55351585E-01 1.30110159E-01 4.014285269E-03 5.19930114E-02 + 4.55454863E-01 1.30139690E-01 4.021096009E-03 5.19930500E-02 + 4.55558141E-01 1.30169221E-01 4.027916943E-03 5.19930886E-02 + 4.55661418E-01 1.30198752E-01 4.034748090E-03 5.19931273E-02 + 4.55764696E-01 1.30228283E-01 4.041589440E-03 5.19931660E-02 + 4.55867974E-01 1.30257814E-01 4.048441033E-03 5.19932049E-02 + 4.55971252E-01 1.30287346E-01 4.055302858E-03 5.19932438E-02 + 4.56074529E-01 1.30316877E-01 4.062174934E-03 5.19932827E-02 + 4.56177807E-01 1.30346409E-01 4.069057270E-03 5.19933218E-02 + 4.56281085E-01 1.30375940E-01 4.075949897E-03 5.19933609E-02 + 4.56384363E-01 1.30405472E-01 4.082852804E-03 5.19934001E-02 + 4.56487640E-01 1.30435003E-01 4.089766009E-03 5.19934394E-02 + 4.56590918E-01 1.30464535E-01 4.096689533E-03 5.19934788E-02 + 4.56694196E-01 1.30494066E-01 4.103623385E-03 5.19935182E-02 + 4.56797474E-01 1.30523598E-01 4.110567575E-03 5.19935577E-02 + 4.56900751E-01 1.30553130E-01 4.117522111E-03 5.19935973E-02 + 4.57004029E-01 1.30582662E-01 4.124487014E-03 5.19936370E-02 + 4.57107307E-01 1.30612194E-01 4.131462293E-03 5.19936767E-02 + 4.57210585E-01 1.30641726E-01 4.138447947E-03 5.19937165E-02 + 4.57313862E-01 1.30671258E-01 4.145444016E-03 5.19937564E-02 + 4.57417140E-01 1.30700790E-01 4.152450490E-03 5.19937964E-02 + 4.57520418E-01 1.30730322E-01 4.159467387E-03 5.19938364E-02 + 4.57623696E-01 1.30759854E-01 4.166494717E-03 5.19938766E-02 + 4.57726973E-01 1.30789386E-01 4.173532500E-03 5.19939168E-02 + 4.57830251E-01 1.30818918E-01 4.180580746E-03 5.19939570E-02 + 4.57933529E-01 1.30848450E-01 4.187639463E-03 5.19939974E-02 + 4.58036807E-01 1.30877983E-01 4.194708672E-03 5.19940378E-02 + 4.58140084E-01 1.30907515E-01 4.201788381E-03 5.19940783E-02 + 4.58243362E-01 1.30937048E-01 4.208878590E-03 5.19941189E-02 + 4.58346640E-01 1.30966580E-01 4.215979330E-03 5.19941596E-02 + 4.58449918E-01 1.30996113E-01 4.223090608E-03 5.19942003E-02 + 4.58553195E-01 1.31025645E-01 4.230212426E-03 5.19942411E-02 + 4.58656473E-01 1.31055178E-01 4.237344811E-03 5.19942820E-02 + 4.58759751E-01 1.31084711E-01 4.244487765E-03 5.19943230E-02 + 4.58863029E-01 1.31114243E-01 4.251641316E-03 5.19943641E-02 + 4.58966306E-01 1.31143776E-01 4.258805453E-03 5.19944052E-02 + 4.59069584E-01 1.31173309E-01 4.265980217E-03 5.19944464E-02 + 4.59172862E-01 1.31202842E-01 4.273165588E-03 5.19944877E-02 + 4.59276140E-01 1.31232375E-01 4.280361603E-03 5.19945291E-02 + 4.59379417E-01 1.31261908E-01 4.287568273E-03 5.19945705E-02 + 4.59482695E-01 1.31291441E-01 4.294785599E-03 5.19946121E-02 + 4.59585973E-01 1.31320974E-01 4.302013598E-03 5.19946537E-02 + 4.59689251E-01 1.31350508E-01 4.309252290E-03 5.19946954E-02 + 4.59792528E-01 1.31380041E-01 4.316501676E-03 5.19947371E-02 + 4.59895806E-01 1.31409574E-01 4.323761785E-03 5.19947790E-02 + 4.59999084E-01 1.31439107E-01 4.331032605E-03 5.19948209E-02 + 4.60102362E-01 1.31468641E-01 4.338314178E-03 5.19948629E-02 + 4.60205639E-01 1.31498174E-01 4.345606492E-03 5.19949050E-02 + 4.60308917E-01 1.31527708E-01 4.352909577E-03 5.19949472E-02 + 4.60412195E-01 1.31557241E-01 4.360223432E-03 5.19949894E-02 + 4.60515473E-01 1.31586775E-01 4.367548077E-03 5.19950318E-02 + 4.60618750E-01 1.31616309E-01 4.374883522E-03 5.19950742E-02 + 4.60722028E-01 1.31645842E-01 4.382229787E-03 5.19951167E-02 + 4.60825306E-01 1.31675376E-01 4.389586889E-03 5.19951592E-02 + 4.60928584E-01 1.31704910E-01 4.396954821E-03 5.19952019E-02 + 4.61031861E-01 1.31734444E-01 4.404333610E-03 5.19952446E-02 + 4.61135139E-01 1.31763978E-01 4.411723256E-03 5.19952874E-02 + 4.61238417E-01 1.31793512E-01 4.419123800E-03 5.19953303E-02 + 4.61341695E-01 1.31823046E-01 4.426535220E-03 5.19953733E-02 + 4.61444972E-01 1.31852580E-01 4.433957556E-03 5.19954164E-02 + 4.61548250E-01 1.31882114E-01 4.441390808E-03 5.19954595E-02 + 4.61651528E-01 1.31911649E-01 4.448834986E-03 5.19955028E-02 + 4.61754806E-01 1.31941183E-01 4.456290118E-03 5.19955461E-02 + 4.61858083E-01 1.31970717E-01 4.463756205E-03 5.19955895E-02 + 4.61961361E-01 1.32000252E-01 4.471233256E-03 5.19956329E-02 + 4.62064639E-01 1.32029786E-01 4.478721301E-03 5.19956765E-02 + 4.62167917E-01 1.32059321E-01 4.486220339E-03 5.19957201E-02 + 4.62271194E-01 1.32088855E-01 4.493730380E-03 5.19957639E-02 + 4.62374472E-01 1.32118390E-01 4.501251454E-03 5.19958077E-02 + 4.62477750E-01 1.32147924E-01 4.508783560E-03 5.19958515E-02 + 4.62581028E-01 1.32177459E-01 4.516326718E-03 5.19958955E-02 + 4.62684305E-01 1.32206994E-01 4.523880927E-03 5.19959396E-02 + 4.62787583E-01 1.32236529E-01 4.531446227E-03 5.19959837E-02 + 4.62890861E-01 1.32266064E-01 4.539022607E-03 5.19960279E-02 + 4.62994138E-01 1.32295599E-01 4.546610088E-03 5.19960723E-02 + 4.63097416E-01 1.32325134E-01 4.554208689E-03 5.19961166E-02 + 4.63200694E-01 1.32354669E-01 4.561818419E-03 5.19961611E-02 + 4.63303972E-01 1.32384204E-01 4.569439288E-03 5.19962057E-02 + 4.63407249E-01 1.32413739E-01 4.577071316E-03 5.19962503E-02 + 4.63510527E-01 1.32443275E-01 4.584714513E-03 5.19962951E-02 + 4.63613805E-01 1.32472810E-01 4.592368887E-03 5.19963399E-02 + 4.63717083E-01 1.32502345E-01 4.600034459E-03 5.19963848E-02 + 4.63820360E-01 1.32531881E-01 4.607711238E-03 5.19964298E-02 + 4.63923638E-01 1.32561416E-01 4.615399234E-03 5.19964748E-02 + 4.64026916E-01 1.32590952E-01 4.623098476E-03 5.19965200E-02 + 4.64130194E-01 1.32620487E-01 4.630808955E-03 5.19965652E-02 + 4.64233471E-01 1.32650023E-01 4.638530700E-03 5.19966106E-02 + 4.64336749E-01 1.32679559E-01 4.646263720E-03 5.19966560E-02 + 4.64440027E-01 1.32709094E-01 4.654008034E-03 5.19967015E-02 + 4.64543305E-01 1.32738630E-01 4.661763644E-03 5.19967471E-02 + 4.64646582E-01 1.32768166E-01 4.669530568E-03 5.19967927E-02 + 4.64749860E-01 1.32797702E-01 4.677308826E-03 5.19968385E-02 + 4.64853138E-01 1.32827238E-01 4.685098428E-03 5.19968843E-02 + 4.64956416E-01 1.32856774E-01 4.692899383E-03 5.19969303E-02 + 4.65059693E-01 1.32886310E-01 4.700711711E-03 5.19969763E-02 + 4.65162971E-01 1.32915847E-01 4.708535412E-03 5.19970224E-02 + 4.65266249E-01 1.32945383E-01 4.716370525E-03 5.19970686E-02 + 4.65369527E-01 1.32974919E-01 4.724217041E-03 5.19971149E-02 + 4.65472804E-01 1.33004456E-01 4.732074977E-03 5.19971612E-02 + 4.65576082E-01 1.33033992E-01 4.739944355E-03 5.19972077E-02 + 4.65679360E-01 1.33063529E-01 4.747825184E-03 5.19972542E-02 + 4.65782638E-01 1.33093065E-01 4.755717474E-03 5.19973009E-02 + 4.65885915E-01 1.33122602E-01 4.763621244E-03 5.19973476E-02 + 4.65989193E-01 1.33152138E-01 4.771536504E-03 5.19973944E-02 + 4.66092471E-01 1.33181675E-01 4.779463274E-03 5.19974413E-02 + 4.66195749E-01 1.33211212E-01 4.787401563E-03 5.19974883E-02 + 4.66299026E-01 1.33240749E-01 4.795351381E-03 5.19975353E-02 + 4.66402304E-01 1.33270286E-01 4.803312748E-03 5.19975825E-02 + 4.66505582E-01 1.33299823E-01 4.811285684E-03 5.19976298E-02 + 4.66608860E-01 1.33329360E-01 4.819270187E-03 5.19976771E-02 + 4.66712137E-01 1.33358897E-01 4.827266278E-03 5.19977245E-02 + 4.66815415E-01 1.33388434E-01 4.835273967E-03 5.19977720E-02 + 4.66918693E-01 1.33417971E-01 4.843293283E-03 5.19978196E-02 + 4.67021971E-01 1.33447509E-01 4.851324215E-03 5.19978673E-02 + 4.67125248E-01 1.33477046E-01 4.859366804E-03 5.19979151E-02 + 4.67228526E-01 1.33506583E-01 4.867421040E-03 5.19979630E-02 + 4.67331804E-01 1.33536121E-01 4.875486951E-03 5.19980110E-02 + 4.67435082E-01 1.33565658E-01 4.883564548E-03 5.19980590E-02 + 4.67538359E-01 1.33595196E-01 4.891653841E-03 5.19981072E-02 + 4.67641637E-01 1.33624734E-01 4.899754858E-03 5.19981554E-02 + 4.67744915E-01 1.33654271E-01 4.907867590E-03 5.19982037E-02 + 4.67848193E-01 1.33683809E-01 4.915992067E-03 5.19982522E-02 + 4.67951470E-01 1.33713347E-01 4.924128298E-03 5.19983007E-02 + 4.68054748E-01 1.33742885E-01 4.932276292E-03 5.19983493E-02 + 4.68158026E-01 1.33772423E-01 4.940436080E-03 5.19983980E-02 + 4.68261304E-01 1.33801961E-01 4.948607662E-03 5.19984468E-02 + 4.68364581E-01 1.33831499E-01 4.956791046E-03 5.19984956E-02 + 4.68467859E-01 1.33861037E-01 4.964986264E-03 5.19985446E-02 + 4.68571137E-01 1.33890575E-01 4.973193323E-03 5.19985937E-02 + 4.68674415E-01 1.33920114E-01 4.981412235E-03 5.19986428E-02 + 4.68777692E-01 1.33949652E-01 4.989643009E-03 5.19986921E-02 + 4.68880970E-01 1.33979191E-01 4.997885664E-03 5.19987414E-02 + 4.68984248E-01 1.34008729E-01 5.006140211E-03 5.19987908E-02 + 4.69087526E-01 1.34038268E-01 5.014406678E-03 5.19988403E-02 + 4.69190803E-01 1.34067806E-01 5.022685067E-03 5.19988900E-02 + 4.69294081E-01 1.34097345E-01 5.030975386E-03 5.19989397E-02 + 4.69397359E-01 1.34126884E-01 5.039277665E-03 5.19989895E-02 + 4.69500637E-01 1.34156422E-01 5.047591904E-03 5.19990394E-02 + 4.69603914E-01 1.34185961E-01 5.055918133E-03 5.19990893E-02 + 4.69707192E-01 1.34215500E-01 5.064256351E-03 5.19991394E-02 + 4.69810470E-01 1.34245039E-01 5.072606578E-03 5.19991896E-02 + 4.69913748E-01 1.34274578E-01 5.080968825E-03 5.19992399E-02 + 4.70017025E-01 1.34304117E-01 5.089343110E-03 5.19992902E-02 + 4.70120303E-01 1.34333657E-01 5.097729453E-03 5.19993407E-02 + 4.70223581E-01 1.34363196E-01 5.106127864E-03 5.19993912E-02 + 4.70326859E-01 1.34392735E-01 5.114538354E-03 5.19994419E-02 + 4.70430136E-01 1.34422275E-01 5.122960931E-03 5.19994926E-02 + 4.70533414E-01 1.34451814E-01 5.131395625E-03 5.19995435E-02 + 4.70636692E-01 1.34481354E-01 5.139842436E-03 5.19995944E-02 + 4.70739969E-01 1.34510893E-01 5.148301394E-03 5.19996454E-02 + 4.70843247E-01 1.34540433E-01 5.156772499E-03 5.19996965E-02 + 4.70946525E-01 1.34569973E-01 5.165255780E-03 5.19997478E-02 + 4.71049803E-01 1.34599512E-01 5.173751237E-03 5.19997991E-02 + 4.71153080E-01 1.34629052E-01 5.182258891E-03 5.19998505E-02 + 4.71256358E-01 1.34658592E-01 5.190778749E-03 5.19999020E-02 + 4.71359636E-01 1.34688132E-01 5.199310833E-03 5.19999536E-02 + 4.71462914E-01 1.34717672E-01 5.207855162E-03 5.20000053E-02 + 4.71566191E-01 1.34747212E-01 5.216411747E-03 5.20000571E-02 + 4.71669469E-01 1.34776752E-01 5.224980595E-03 5.20001090E-02 + 4.71772747E-01 1.34806293E-01 5.233561728E-03 5.20001609E-02 + 4.71876025E-01 1.34835833E-01 5.242155166E-03 5.20002130E-02 + 4.71979302E-01 1.34865373E-01 5.250760907E-03 5.20002652E-02 + 4.72082580E-01 1.34894914E-01 5.259378982E-03 5.20003175E-02 + 4.72185858E-01 1.34924454E-01 5.268009390E-03 5.20003699E-02 + 4.72289136E-01 1.34953995E-01 5.276652162E-03 5.20004223E-02 + 4.72392413E-01 1.34983536E-01 5.285307296E-03 5.20004749E-02 + 4.72495691E-01 1.35013076E-01 5.293974824E-03 5.20005276E-02 + 4.72598969E-01 1.35042617E-01 5.302654754E-03 5.20005803E-02 + 4.72702247E-01 1.35072158E-01 5.311347096E-03 5.20006332E-02 + 4.72805524E-01 1.35101699E-01 5.320051870E-03 5.20006862E-02 + 4.72908802E-01 1.35131240E-01 5.328769086E-03 5.20007392E-02 + 4.73012080E-01 1.35160781E-01 5.337498764E-03 5.20007924E-02 + 4.73115358E-01 1.35190322E-01 5.346240913E-03 5.20008456E-02 + 4.73218635E-01 1.35219863E-01 5.354995544E-03 5.20008990E-02 + 4.73321913E-01 1.35249405E-01 5.363762695E-03 5.20009525E-02 + 4.73425191E-01 1.35278946E-01 5.372542358E-03 5.20010060E-02 + 4.73528469E-01 1.35308488E-01 5.381334550E-03 5.20010597E-02 + 4.73631746E-01 1.35338029E-01 5.390139294E-03 5.20011134E-02 + 4.73735024E-01 1.35367571E-01 5.398956597E-03 5.20011673E-02 + 4.73838302E-01 1.35397112E-01 5.407786480E-03 5.20012212E-02 + 4.73941580E-01 1.35426654E-01 5.416628963E-03 5.20012753E-02 + 4.74044857E-01 1.35456196E-01 5.425484045E-03 5.20013294E-02 + 4.74148135E-01 1.35485737E-01 5.434351757E-03 5.20013837E-02 + 4.74251413E-01 1.35515279E-01 5.443232097E-03 5.20014381E-02 + 4.74354691E-01 1.35544821E-01 5.452125097E-03 5.20014925E-02 + 4.74457968E-01 1.35574363E-01 5.461030765E-03 5.20015471E-02 + 4.74561246E-01 1.35603906E-01 5.469949112E-03 5.20016017E-02 + 4.74664524E-01 1.35633448E-01 5.478880167E-03 5.20016565E-02 + 4.74767802E-01 1.35662990E-01 5.487823919E-03 5.20017114E-02 + 4.74871079E-01 1.35692532E-01 5.496780410E-03 5.20017663E-02 + 4.74974357E-01 1.35722075E-01 5.505749649E-03 5.20018214E-02 + 4.75077635E-01 1.35751617E-01 5.514731634E-03 5.20018766E-02 + 4.75180913E-01 1.35781160E-01 5.523726398E-03 5.20019318E-02 + 4.75284190E-01 1.35810702E-01 5.532733948E-03 5.20019872E-02 + 4.75387468E-01 1.35840245E-01 5.541754305E-03 5.20020427E-02 + 4.75490746E-01 1.35869788E-01 5.550787478E-03 5.20020982E-02 + 4.75594024E-01 1.35899331E-01 5.559833488E-03 5.20021539E-02 + 4.75697301E-01 1.35928874E-01 5.568892345E-03 5.20022097E-02 + 4.75800579E-01 1.35958417E-01 5.577964067E-03 5.20022656E-02 + 4.75903857E-01 1.35987960E-01 5.587048665E-03 5.20023216E-02 + 4.76007135E-01 1.36017503E-01 5.596146159E-03 5.20023777E-02 + 4.76110412E-01 1.36047046E-01 5.605256559E-03 5.20024339E-02 + 4.76213690E-01 1.36076589E-01 5.614379894E-03 5.20024902E-02 + 4.76316968E-01 1.36106132E-01 5.623516164E-03 5.20025466E-02 + 4.76420246E-01 1.36135676E-01 5.632665388E-03 5.20026031E-02 + 4.76523523E-01 1.36165219E-01 5.641827588E-03 5.20026597E-02 + 4.76626801E-01 1.36194763E-01 5.651002772E-03 5.20027164E-02 + 4.76730079E-01 1.36224307E-01 5.660190961E-03 5.20027732E-02 + 4.76833357E-01 1.36253850E-01 5.669392164E-03 5.20028302E-02 + 4.76936634E-01 1.36283394E-01 5.678606401E-03 5.20028872E-02 + 4.77039912E-01 1.36312938E-01 5.687833681E-03 5.20029443E-02 + 4.77143190E-01 1.36342482E-01 5.697074026E-03 5.20030016E-02 + 4.77246468E-01 1.36372026E-01 5.706327453E-03 5.20030589E-02 + 4.77349745E-01 1.36401570E-01 5.715593975E-03 5.20031164E-02 + 4.77453023E-01 1.36431114E-01 5.724873609E-03 5.20031739E-02 + 4.77556301E-01 1.36460658E-01 5.734166356E-03 5.20032316E-02 + 4.77659579E-01 1.36490203E-01 5.743472256E-03 5.20032894E-02 + 4.77762856E-01 1.36519747E-01 5.752791309E-03 5.20033472E-02 + 4.77866134E-01 1.36549291E-01 5.762123534E-03 5.20034052E-02 + 4.77969412E-01 1.36578836E-01 5.771468942E-03 5.20034633E-02 + 4.78072690E-01 1.36608381E-01 5.780827561E-03 5.20035215E-02 + 4.78175967E-01 1.36637925E-01 5.790199393E-03 5.20035798E-02 + 4.78279245E-01 1.36667470E-01 5.799584456E-03 5.20036382E-02 + 4.78382523E-01 1.36697015E-01 5.808982781E-03 5.20036968E-02 + 4.78485801E-01 1.36726560E-01 5.818394357E-03 5.20037554E-02 + 4.78589078E-01 1.36756105E-01 5.827819224E-03 5.20038141E-02 + 4.78692356E-01 1.36785650E-01 5.837257383E-03 5.20038730E-02 + 4.78795634E-01 1.36815195E-01 5.846708853E-03 5.20039319E-02 + 4.78898911E-01 1.36844740E-01 5.856173653E-03 5.20039910E-02 + 4.79002189E-01 1.36874285E-01 5.865651804E-03 5.20040501E-02 + 4.79105467E-01 1.36903831E-01 5.875143305E-03 5.20041094E-02 + 4.79208745E-01 1.36933376E-01 5.884648187E-03 5.20041688E-02 + 4.79312022E-01 1.36962922E-01 5.894166449E-03 5.20042283E-02 + 4.79415300E-01 1.36992467E-01 5.903698131E-03 5.20042879E-02 + 4.79518578E-01 1.37022013E-01 5.913243233E-03 5.20043476E-02 + 4.79621856E-01 1.37051559E-01 5.922801764E-03 5.20044074E-02 + 4.79725133E-01 1.37081104E-01 5.932373765E-03 5.20044674E-02 + 4.79828411E-01 1.37110650E-01 5.941959225E-03 5.20045274E-02 + 4.79931689E-01 1.37140196E-01 5.951558174E-03 5.20045876E-02 + 4.80034967E-01 1.37169742E-01 5.961170623E-03 5.20046478E-02 + 4.80138244E-01 1.37199289E-01 5.970796590E-03 5.20047082E-02 + 4.80241522E-01 1.37228835E-01 5.980436096E-03 5.20047687E-02 + 4.80344800E-01 1.37258381E-01 5.990089141E-03 5.20048293E-02 + 4.80448078E-01 1.37287927E-01 5.999755764E-03 5.20048900E-02 + 4.80551355E-01 1.37317474E-01 6.009435955E-03 5.20049508E-02 + 4.80654633E-01 1.37347020E-01 6.019129755E-03 5.20050117E-02 + 4.80757911E-01 1.37376567E-01 6.028837162E-03 5.20050728E-02 + 4.80861189E-01 1.37406114E-01 6.038558208E-03 5.20051339E-02 + 4.80964466E-01 1.37435660E-01 6.048292891E-03 5.20051952E-02 + 4.81067744E-01 1.37465207E-01 6.058041231E-03 5.20052565E-02 + 4.81171022E-01 1.37494754E-01 6.067803260E-03 5.20053180E-02 + 4.81274300E-01 1.37524301E-01 6.077578975E-03 5.20053796E-02 + 4.81377577E-01 1.37553848E-01 6.087368407E-03 5.20054413E-02 + 4.81480855E-01 1.37583395E-01 6.097171557E-03 5.20055032E-02 + 4.81584133E-01 1.37612943E-01 6.106988453E-03 5.20055651E-02 + 4.81687411E-01 1.37642490E-01 6.116819116E-03 5.20056272E-02 + 4.81790688E-01 1.37672037E-01 6.126663536E-03 5.20056893E-02 + 4.81893966E-01 1.37701585E-01 6.136521761E-03 5.20057516E-02 + 4.81997244E-01 1.37731132E-01 6.146393784E-03 5.20058140E-02 + 4.82100522E-01 1.37760680E-01 6.156279632E-03 5.20058765E-02 + 4.82203799E-01 1.37790228E-01 6.166179327E-03 5.20059391E-02 + 4.82307077E-01 1.37819776E-01 6.176092867E-03 5.20060018E-02 + 4.82410355E-01 1.37849324E-01 6.186020283E-03 5.20060647E-02 + 4.82513633E-01 1.37878871E-01 6.195961594E-03 5.20061277E-02 + 4.82616910E-01 1.37908420E-01 6.205916802E-03 5.20061907E-02 + 4.82720188E-01 1.37937968E-01 6.215885934E-03 5.20062539E-02 + 4.82823466E-01 1.37967516E-01 6.225868992E-03 5.20063172E-02 + 4.82926744E-01 1.37997064E-01 6.235866014E-03 5.20063807E-02 + 4.83030021E-01 1.38026613E-01 6.245877002E-03 5.20064442E-02 + 4.83133299E-01 1.38056161E-01 6.255901985E-03 5.20065078E-02 + 4.83236577E-01 1.38085710E-01 6.265940962E-03 5.20065716E-02 + 4.83339855E-01 1.38115258E-01 6.275993964E-03 5.20066355E-02 + 4.83443132E-01 1.38144807E-01 6.286060990E-03 5.20066995E-02 + 4.83546410E-01 1.38174356E-01 6.296142080E-03 5.20067636E-02 + 4.83649688E-01 1.38203905E-01 6.306237235E-03 5.20068279E-02 + 4.83752966E-01 1.38233453E-01 6.316346473E-03 5.20068922E-02 + 4.83856243E-01 1.38263003E-01 6.326469806E-03 5.20069567E-02 + 4.83959521E-01 1.38292552E-01 6.336607273E-03 5.20070213E-02 + 4.84062799E-01 1.38322101E-01 6.346758863E-03 5.20070860E-02 + 4.84166077E-01 1.38351650E-01 6.356924606E-03 5.20071508E-02 + 4.84269354E-01 1.38381200E-01 6.367104513E-03 5.20072157E-02 + 4.84372632E-01 1.38410749E-01 6.377298614E-03 5.20072808E-02 + 4.84475910E-01 1.38440299E-01 6.387506907E-03 5.20073460E-02 + 4.84579188E-01 1.38469848E-01 6.397729424E-03 5.20074112E-02 + 4.84682465E-01 1.38499398E-01 6.407966163E-03 5.20074767E-02 + 4.84785743E-01 1.38528948E-01 6.418217166E-03 5.20075422E-02 + 4.84889021E-01 1.38558498E-01 6.428482431E-03 5.20076078E-02 + 4.84992299E-01 1.38588048E-01 6.438761979E-03 5.20076736E-02 + 4.85095576E-01 1.38617598E-01 6.449055829E-03 5.20077395E-02 + 4.85198854E-01 1.38647148E-01 6.459364001E-03 5.20078055E-02 + 4.85302132E-01 1.38676698E-01 6.469686506E-03 5.20078716E-02 + 4.85405410E-01 1.38706248E-01 6.480023353E-03 5.20079379E-02 + 4.85508687E-01 1.38735799E-01 6.490374582E-03 5.20080042E-02 + 4.85611965E-01 1.38765349E-01 6.500740183E-03 5.20080707E-02 + 4.85715243E-01 1.38794900E-01 6.511120195E-03 5.20081373E-02 + 4.85818521E-01 1.38824450E-01 6.521514619E-03 5.20082041E-02 + 4.85921798E-01 1.38854001E-01 6.531923475E-03 5.20082709E-02 + 4.86025076E-01 1.38883552E-01 6.542346792E-03 5.20083379E-02 + 4.86128354E-01 1.38913103E-01 6.552784571E-03 5.20084050E-02 + 4.86231632E-01 1.38942654E-01 6.563236841E-03 5.20084722E-02 + 4.86334909E-01 1.38972205E-01 6.573703611E-03 5.20085395E-02 + 4.86438187E-01 1.39001756E-01 6.584184903E-03 5.20086070E-02 + 4.86541465E-01 1.39031307E-01 6.594680726E-03 5.20086746E-02 + 4.86644742E-01 1.39060859E-01 6.605191110E-03 5.20087423E-02 + 4.86748020E-01 1.39090410E-01 6.615716054E-03 5.20088101E-02 + 4.86851298E-01 1.39119962E-01 6.626255599E-03 5.20088780E-02 + 4.86954576E-01 1.39149513E-01 6.636809734E-03 5.20089461E-02 + 4.87057853E-01 1.39179065E-01 6.647378500E-03 5.20090143E-02 + 4.87161131E-01 1.39208617E-01 6.657961905E-03 5.20090826E-02 + 4.87264409E-01 1.39238169E-01 6.668559961E-03 5.20091510E-02 + 4.87367687E-01 1.39267721E-01 6.679172698E-03 5.20092196E-02 + 4.87470964E-01 1.39297273E-01 6.689800114E-03 5.20092883E-02 + 4.87574242E-01 1.39326825E-01 6.700442249E-03 5.20093571E-02 + 4.87677520E-01 1.39356377E-01 6.711099095E-03 5.20094260E-02 + 4.87780798E-01 1.39385929E-01 6.721770690E-03 5.20094951E-02 + 4.87884075E-01 1.39415482E-01 6.732457045E-03 5.20095643E-02 + 4.87987353E-01 1.39445034E-01 6.743158179E-03 5.20096336E-02 + 4.88090631E-01 1.39474587E-01 6.753874102E-03 5.20097030E-02 + 4.88193909E-01 1.39504139E-01 6.764604825E-03 5.20097725E-02 + 4.88297186E-01 1.39533692E-01 6.775350387E-03 5.20098422E-02 + 4.88400464E-01 1.39563245E-01 6.786110788E-03 5.20099120E-02 + 4.88503742E-01 1.39592798E-01 6.796886058E-03 5.20099820E-02 + 4.88607020E-01 1.39622351E-01 6.807676206E-03 5.20100520E-02 + 4.88710297E-01 1.39651904E-01 6.818481244E-03 5.20101222E-02 + 4.88813575E-01 1.39681457E-01 6.829301200E-03 5.20101925E-02 + 4.88916853E-01 1.39711011E-01 6.840136094E-03 5.20102630E-02 + 4.89020131E-01 1.39740564E-01 6.850985927E-03 5.20103335E-02 + 4.89123408E-01 1.39770118E-01 6.861850729E-03 5.20104042E-02 + 4.89226686E-01 1.39799671E-01 6.872730518E-03 5.20104750E-02 + 4.89329964E-01 1.39829225E-01 6.883625296E-03 5.20105460E-02 + 4.89433242E-01 1.39858779E-01 6.894535102E-03 5.20106171E-02 + 4.89536519E-01 1.39888332E-01 6.905459946E-03 5.20106883E-02 + 4.89639797E-01 1.39917886E-01 6.916399837E-03 5.20107596E-02 + 4.89743075E-01 1.39947440E-01 6.927354807E-03 5.20108310E-02 + 4.89846353E-01 1.39976995E-01 6.938324854E-03 5.20109026E-02 + 4.89949630E-01 1.40006549E-01 6.949310019E-03 5.20109743E-02 + 4.90052908E-01 1.40036103E-01 6.960310301E-03 5.20110462E-02 + 4.90156186E-01 1.40065658E-01 6.971325721E-03 5.20111182E-02 + 4.90259464E-01 1.40095212E-01 6.982356298E-03 5.20111903E-02 + 4.90362741E-01 1.40124767E-01 6.993402062E-03 5.20112625E-02 + 4.90466019E-01 1.40154321E-01 7.004463014E-03 5.20113348E-02 + 4.90569297E-01 1.40183876E-01 7.015539173E-03 5.20114073E-02 + 4.90672575E-01 1.40213431E-01 7.026630568E-03 5.20114800E-02 + 4.90775852E-01 1.40242986E-01 7.037737201E-03 5.20115527E-02 + 4.90879130E-01 1.40272541E-01 7.048859110E-03 5.20116256E-02 + 4.90982408E-01 1.40302096E-01 7.059996286E-03 5.20116986E-02 + 4.91085686E-01 1.40331652E-01 7.071148779E-03 5.20117717E-02 + 4.91188963E-01 1.40361207E-01 7.082316578E-03 5.20118450E-02 + 4.91292241E-01 1.40390762E-01 7.093499713E-03 5.20119184E-02 + 4.91395519E-01 1.40420318E-01 7.104698206E-03 5.20119920E-02 + 4.91498797E-01 1.40449874E-01 7.115912064E-03 5.20120656E-02 + 4.91602074E-01 1.40479429E-01 7.127141318E-03 5.20121394E-02 + 4.91705352E-01 1.40508985E-01 7.138385969E-03 5.20122134E-02 + 4.91808630E-01 1.40538541E-01 7.149646056E-03 5.20122874E-02 + 4.91911908E-01 1.40568097E-01 7.160921579E-03 5.20123616E-02 + 4.92015185E-01 1.40597653E-01 7.172212557E-03 5.20124359E-02 + 4.92118463E-01 1.40627209E-01 7.183519022E-03 5.20125104E-02 + 4.92221741E-01 1.40656766E-01 7.194840982E-03 5.20125850E-02 + 4.92325019E-01 1.40686322E-01 7.206178448E-03 5.20126597E-02 + 4.92428296E-01 1.40715879E-01 7.217531449E-03 5.20127346E-02 + 4.92531574E-01 1.40745435E-01 7.228900006E-03 5.20128096E-02 + 4.92634852E-01 1.40774992E-01 7.240284128E-03 5.20128847E-02 + 4.92738130E-01 1.40804549E-01 7.251683835E-03 5.20129600E-02 + 4.92841407E-01 1.40834106E-01 7.263099138E-03 5.20130354E-02 + 4.92944685E-01 1.40863663E-01 7.274530076E-03 5.20131109E-02 + 4.93047963E-01 1.40893220E-01 7.285976649E-03 5.20131866E-02 + 4.93151241E-01 1.40922777E-01 7.297438877E-03 5.20132624E-02 + 4.93254518E-01 1.40952334E-01 7.308916780E-03 5.20133383E-02 + 4.93357796E-01 1.40981891E-01 7.320410378E-03 5.20134144E-02 + 4.93461074E-01 1.41011449E-01 7.331919691E-03 5.20134906E-02 + 4.93564352E-01 1.41041007E-01 7.343444738E-03 5.20135669E-02 + 4.93667629E-01 1.41070564E-01 7.354985530E-03 5.20136434E-02 + 4.93770907E-01 1.41100122E-01 7.366542087E-03 5.20137200E-02 + 4.93874185E-01 1.41129680E-01 7.378114428E-03 5.20137968E-02 + 4.93977463E-01 1.41159238E-01 7.389702573E-03 5.20138737E-02 + 4.94080740E-01 1.41188796E-01 7.401306543E-03 5.20139507E-02 + 4.94184018E-01 1.41218354E-01 7.412926357E-03 5.20140279E-02 + 4.94287296E-01 1.41247912E-01 7.424562025E-03 5.20141052E-02 + 4.94390573E-01 1.41277471E-01 7.436213568E-03 5.20141826E-02 + 4.94493851E-01 1.41307029E-01 7.447881004E-03 5.20142602E-02 + 4.94597129E-01 1.41336588E-01 7.459564355E-03 5.20143379E-02 + 4.94700407E-01 1.41366146E-01 7.471263629E-03 5.20144158E-02 + 4.94803684E-01 1.41395705E-01 7.482978867E-03 5.20144937E-02 + 4.94906962E-01 1.41425264E-01 7.494710069E-03 5.20145719E-02 + 4.95010240E-01 1.41454823E-01 7.506457254E-03 5.20146501E-02 + 4.95113518E-01 1.41484382E-01 7.518220444E-03 5.20147286E-02 + 4.95216795E-01 1.41513941E-01 7.529999656E-03 5.20148071E-02 + 4.95320073E-01 1.41543501E-01 7.541794913E-03 5.20148858E-02 + 4.95423351E-01 1.41573060E-01 7.553606232E-03 5.20149646E-02 + 4.95526629E-01 1.41602620E-01 7.565433625E-03 5.20150436E-02 + 4.95629906E-01 1.41632179E-01 7.577277122E-03 5.20151227E-02 + 4.95733184E-01 1.41661739E-01 7.589136731E-03 5.20152019E-02 + 4.95836462E-01 1.41691299E-01 7.601012474E-03 5.20152813E-02 + 4.95939740E-01 1.41720858E-01 7.612904369E-03 5.20153609E-02 + 4.96043017E-01 1.41750418E-01 7.624812438E-03 5.20154405E-02 + 4.96146295E-01 1.41779979E-01 7.636736700E-03 5.20155203E-02 + 4.96249573E-01 1.41809539E-01 7.648677164E-03 5.20156003E-02 + 4.96352851E-01 1.41839099E-01 7.660633862E-03 5.20156804E-02 + 4.96456128E-01 1.41868660E-01 7.672606802E-03 5.20157606E-02 + 4.96559406E-01 1.41898220E-01 7.684596004E-03 5.20158410E-02 + 4.96662684E-01 1.41927781E-01 7.696601490E-03 5.20159215E-02 + 4.96765962E-01 1.41957341E-01 7.708623288E-03 5.20160022E-02 + 4.96869239E-01 1.41986902E-01 7.720661398E-03 5.20160830E-02 + 4.96972517E-01 1.42016463E-01 7.732715851E-03 5.20161640E-02 + 4.97075795E-01 1.42046024E-01 7.744786666E-03 5.20162450E-02 + 4.97179073E-01 1.42075585E-01 7.756873854E-03 5.20163263E-02 + 4.97282350E-01 1.42105147E-01 7.768977434E-03 5.20164077E-02 + 4.97385628E-01 1.42134708E-01 7.781097436E-03 5.20164892E-02 + 4.97488906E-01 1.42164269E-01 7.793233870E-03 5.20165709E-02 + 4.97592184E-01 1.42193831E-01 7.805386756E-03 5.20166527E-02 + 4.97695461E-01 1.42223393E-01 7.817556114E-03 5.20167346E-02 + 4.97798739E-01 1.42252954E-01 7.829741954E-03 5.20168167E-02 + 4.97902017E-01 1.42282516E-01 7.841944316E-03 5.20168990E-02 + 4.98005295E-01 1.42312078E-01 7.854163200E-03 5.20169814E-02 + 4.98108572E-01 1.42341640E-01 7.866398635E-03 5.20170639E-02 + 4.98211850E-01 1.42371203E-01 7.878650632E-03 5.20171466E-02 + 4.98315128E-01 1.42400765E-01 7.890919211E-03 5.20172294E-02 + 4.98418406E-01 1.42430327E-01 7.903204401E-03 5.20173124E-02 + 4.98521683E-01 1.42459890E-01 7.915506213E-03 5.20173955E-02 + 4.98624961E-01 1.42489452E-01 7.927824667E-03 5.20174788E-02 + 4.98728239E-01 1.42519015E-01 7.940159781E-03 5.20175622E-02 + 4.98831517E-01 1.42548578E-01 7.952511578E-03 5.20176458E-02 + 4.98934794E-01 1.42578141E-01 7.964880075E-03 5.20177295E-02 + 4.99038072E-01 1.42607704E-01 7.977265293E-03 5.20178134E-02 + 4.99141350E-01 1.42637267E-01 7.989667243E-03 5.20178974E-02 + 4.99244628E-01 1.42666831E-01 8.002085954E-03 5.20179815E-02 + 4.99347905E-01 1.42696394E-01 8.014521436E-03 5.20180658E-02 + 4.99451183E-01 1.42725957E-01 8.026973719E-03 5.20181503E-02 + 4.99554461E-01 1.42755521E-01 8.039442813E-03 5.20182349E-02 + 4.99657739E-01 1.42785085E-01 8.051928748E-03 5.20183196E-02 + 4.99761016E-01 1.42814649E-01 8.064431523E-03 5.20184045E-02 + 4.99864294E-01 1.42844213E-01 8.076951180E-03 5.20184896E-02 + 4.99967572E-01 1.42873777E-01 8.089487727E-03 5.20185748E-02 + 5.00070850E-01 1.42903341E-01 8.102041185E-03 5.20186601E-02 + 5.00174127E-01 1.42932905E-01 8.114611573E-03 5.20187456E-02 + 5.00277405E-01 1.42962469E-01 8.127198912E-03 5.20188313E-02 + 5.00380683E-01 1.42992034E-01 8.139803221E-03 5.20189171E-02 + 5.00483961E-01 1.43021598E-01 8.152424511E-03 5.20190030E-02 + 5.00587238E-01 1.43051163E-01 8.165062822E-03 5.20190891E-02 + 5.00690516E-01 1.43080728E-01 8.177718152E-03 5.20191754E-02 + 5.00793794E-01 1.43110293E-01 8.190390523E-03 5.20192618E-02 + 5.00897072E-01 1.43139858E-01 8.203079965E-03 5.20193483E-02 + 5.01000349E-01 1.43169423E-01 8.215786496E-03 5.20194350E-02 + 5.01103627E-01 1.43198988E-01 8.228510128E-03 5.20195219E-02 + 5.01206905E-01 1.43228554E-01 8.241250889E-03 5.20196089E-02 + 5.01310183E-01 1.43258119E-01 8.254008791E-03 5.20196961E-02 + 5.01413460E-01 1.43287685E-01 8.266783863E-03 5.20197834E-02 + 5.01516738E-01 1.43317251E-01 8.279576115E-03 5.20198709E-02 + 5.01620016E-01 1.43346816E-01 8.292385566E-03 5.20199585E-02 + 5.01723294E-01 1.43376382E-01 8.305212247E-03 5.20200463E-02 + 5.01826571E-01 1.43405948E-01 8.318056159E-03 5.20201342E-02 + 5.01929849E-01 1.43435515E-01 8.330917340E-03 5.20202223E-02 + 5.02033127E-01 1.43465081E-01 8.343795800E-03 5.20203105E-02 + 5.02136404E-01 1.43494647E-01 8.356691571E-03 5.20203989E-02 + 5.02239682E-01 1.43524214E-01 8.369604650E-03 5.20204875E-02 + 5.02342960E-01 1.43553780E-01 8.382535080E-03 5.20205762E-02 + 5.02446238E-01 1.43583347E-01 8.395482859E-03 5.20206651E-02 + 5.02549515E-01 1.43612914E-01 8.408448027E-03 5.20207541E-02 + 5.02652793E-01 1.43642481E-01 8.421430595E-03 5.20208433E-02 + 5.02756071E-01 1.43672048E-01 8.434430582E-03 5.20209326E-02 + 5.02859349E-01 1.43701615E-01 8.447448009E-03 5.20210221E-02 + 5.02962626E-01 1.43731183E-01 8.460482884E-03 5.20211117E-02 + 5.03065904E-01 1.43760750E-01 8.473535249E-03 5.20212015E-02 + 5.03169182E-01 1.43790318E-01 8.486605113E-03 5.20212915E-02 + 5.03272460E-01 1.43819885E-01 8.499692497E-03 5.20213816E-02 + 5.03375737E-01 1.43849453E-01 8.512797419E-03 5.20214719E-02 + 5.03479015E-01 1.43879021E-01 8.525919900E-03 5.20215623E-02 + 5.03582293E-01 1.43908589E-01 8.539059961E-03 5.20216529E-02 + 5.03685571E-01 1.43938157E-01 8.552217620E-03 5.20217436E-02 + 5.03788848E-01 1.43967725E-01 8.565392898E-03 5.20218345E-02 + 5.03892126E-01 1.43997294E-01 8.578585815E-03 5.20219256E-02 + 5.03995404E-01 1.44026862E-01 8.591796391E-03 5.20220168E-02 + 5.04098682E-01 1.44056431E-01 8.605024646E-03 5.20221082E-02 + 5.04201959E-01 1.44086000E-01 8.618270599E-03 5.20221997E-02 + 5.04305237E-01 1.44115569E-01 8.631534271E-03 5.20222914E-02 + 5.04408515E-01 1.44145138E-01 8.644815682E-03 5.20223833E-02 + 5.04511793E-01 1.44174707E-01 8.658114861E-03 5.20224753E-02 + 5.04615070E-01 1.44204276E-01 8.671431809E-03 5.20225675E-02 + 5.04718348E-01 1.44233845E-01 8.684766565E-03 5.20226598E-02 + 5.04821626E-01 1.44263415E-01 8.698119130E-03 5.20227524E-02 + 5.04924904E-01 1.44292984E-01 8.711489543E-03 5.20228450E-02 + 5.05028181E-01 1.44322554E-01 8.724877815E-03 5.20229378E-02 + 5.05131459E-01 1.44352124E-01 8.738283975E-03 5.20230308E-02 + 5.05234737E-01 1.44381694E-01 8.751708023E-03 5.20231240E-02 + 5.05338015E-01 1.44411264E-01 8.765150000E-03 5.20232173E-02 + 5.05441292E-01 1.44440834E-01 8.778609914E-03 5.20233108E-02 + 5.05544570E-01 1.44470404E-01 8.792087797E-03 5.20234044E-02 + 5.05647848E-01 1.44499974E-01 8.805583658E-03 5.20234982E-02 + 5.05751126E-01 1.44529545E-01 8.819097527E-03 5.20235922E-02 + 5.05854403E-01 1.44559116E-01 8.832629415E-03 5.20236863E-02 + 5.05957681E-01 1.44588686E-01 8.846179340E-03 5.20237806E-02 + 5.06060959E-01 1.44618257E-01 8.859747333E-03 5.20238750E-02 + 5.06164237E-01 1.44647828E-01 8.873333414E-03 5.20239697E-02 + 5.06267514E-01 1.44677399E-01 8.886937603E-03 5.20240645E-02 + 5.06370792E-01 1.44706971E-01 8.900559910E-03 5.20241594E-02 + 5.06474070E-01 1.44736542E-01 8.914200364E-03 5.20242545E-02 + 5.06577348E-01 1.44766114E-01 8.927858987E-03 5.20243498E-02 + 5.06680625E-01 1.44795685E-01 8.941535797E-03 5.20244452E-02 + 5.06783903E-01 1.44825257E-01 8.955230815E-03 5.20245409E-02 + 5.06887181E-01 1.44854829E-01 8.968944050E-03 5.20246366E-02 + 5.06990459E-01 1.44884401E-01 8.982675543E-03 5.20247326E-02 + 5.07093736E-01 1.44913973E-01 8.996425314E-03 5.20248287E-02 + 5.07197014E-01 1.44943545E-01 9.010193362E-03 5.20249250E-02 + 5.07300292E-01 1.44973118E-01 9.023979728E-03 5.20250214E-02 + 5.07403570E-01 1.45002690E-01 9.037784421E-03 5.20251180E-02 + 5.07506847E-01 1.45032263E-01 9.051607462E-03 5.20252148E-02 + 5.07610125E-01 1.45061835E-01 9.065448880E-03 5.20253117E-02 + 5.07713403E-01 1.45091408E-01 9.079308696E-03 5.20254088E-02 + 5.07816681E-01 1.45120981E-01 9.093186918E-03 5.20255061E-02 + 5.07919958E-01 1.45150554E-01 9.107083578E-03 5.20256036E-02 + 5.08023236E-01 1.45180128E-01 9.120998696E-03 5.20257012E-02 + 5.08126514E-01 1.45209701E-01 9.134932290E-03 5.20257990E-02 + 5.08229792E-01 1.45239275E-01 9.148884382E-03 5.20258970E-02 + 5.08333069E-01 1.45268848E-01 9.162854991E-03 5.20259951E-02 + 5.08436347E-01 1.45298422E-01 9.176844146E-03 5.20260934E-02 + 5.08539625E-01 1.45327996E-01 9.190851849E-03 5.20261918E-02 + 5.08642903E-01 1.45357570E-01 9.204878139E-03 5.20262905E-02 + 5.08746180E-01 1.45387144E-01 9.218923036E-03 5.20263893E-02 + 5.08849458E-01 1.45416718E-01 9.232986550E-03 5.20264883E-02 + 5.08952736E-01 1.45446293E-01 9.247068711E-03 5.20265874E-02 + 5.09056014E-01 1.45475867E-01 9.261169529E-03 5.20266867E-02 + 5.09159291E-01 1.45505442E-01 9.275289044E-03 5.20267862E-02 + 5.09262569E-01 1.45535017E-01 9.289427255E-03 5.20268859E-02 + 5.09365847E-01 1.45564592E-01 9.303584204E-03 5.20269858E-02 + 5.09469125E-01 1.45594167E-01 9.317759899E-03 5.20270858E-02 + 5.09572402E-01 1.45623742E-01 9.331954361E-03 5.20271859E-02 + 5.09675680E-01 1.45653317E-01 9.346167619E-03 5.20272863E-02 + 5.09778958E-01 1.45682893E-01 9.360399694E-03 5.20273868E-02 + 5.09882236E-01 1.45712468E-01 9.374650596E-03 5.20274875E-02 + 5.09985513E-01 1.45742044E-01 9.388920354E-03 5.20275884E-02 + 5.10088791E-01 1.45771620E-01 9.403208979E-03 5.20276895E-02 + 5.10192069E-01 1.45801196E-01 9.417516511E-03 5.20277907E-02 + 5.10295346E-01 1.45830772E-01 9.431842969E-03 5.20278921E-02 + 5.10398624E-01 1.45860348E-01 9.446188353E-03 5.20279937E-02 + 5.10501902E-01 1.45889924E-01 9.460552704E-03 5.20280954E-02 + 5.10605180E-01 1.45919501E-01 9.474936042E-03 5.20281974E-02 + 5.10708457E-01 1.45949077E-01 9.489338375E-03 5.20282995E-02 + 5.10811735E-01 1.45978654E-01 9.503759735E-03 5.20284017E-02 + 5.10915013E-01 1.46008231E-01 9.518200151E-03 5.20285042E-02 + 5.11018291E-01 1.46037808E-01 9.532659624E-03 5.20286068E-02 + 5.11121568E-01 1.46067385E-01 9.547138193E-03 5.20287096E-02 + 5.11224846E-01 1.46096962E-01 9.561635868E-03 5.20288126E-02 + 5.11328124E-01 1.46126540E-01 9.576152679E-03 5.20289158E-02 + 5.11431402E-01 1.46156117E-01 9.590688637E-03 5.20290191E-02 + 5.11534679E-01 1.46185695E-01 9.605243780E-03 5.20291226E-02 + 5.11637957E-01 1.46215273E-01 9.619818110E-03 5.20292263E-02 + 5.11741235E-01 1.46244851E-01 9.634411665E-03 5.20293302E-02 + 5.11844513E-01 1.46274429E-01 9.649024457E-03 5.20294343E-02 + 5.11947790E-01 1.46304007E-01 9.663656515E-03 5.20295385E-02 + 5.12051068E-01 1.46333585E-01 9.678307848E-03 5.20296429E-02 + 5.12154346E-01 1.46363164E-01 9.692978488E-03 5.20297475E-02 + 5.12257624E-01 1.46392742E-01 9.707668464E-03 5.20298523E-02 + 5.12360901E-01 1.46422321E-01 9.722377775E-03 5.20299572E-02 + 5.12464179E-01 1.46451900E-01 9.737106462E-03 5.20300623E-02 + 5.12567457E-01 1.46481479E-01 9.751854535E-03 5.20301677E-02 + 5.12670735E-01 1.46511058E-01 9.766622024E-03 5.20302731E-02 + 5.12774012E-01 1.46540637E-01 9.781408949E-03 5.20303788E-02 + 5.12877290E-01 1.46570217E-01 9.796215329E-03 5.20304847E-02 + 5.12980568E-01 1.46599796E-01 9.811041196E-03 5.20305907E-02 + 5.13083846E-01 1.46629376E-01 9.825886547E-03 5.20306969E-02 + 5.13187123E-01 1.46658956E-01 9.840751435E-03 5.20308033E-02 + 5.13290401E-01 1.46688536E-01 9.855635858E-03 5.20309099E-02 + 5.13393679E-01 1.46718116E-01 9.870539847E-03 5.20310167E-02 + 5.13496957E-01 1.46747696E-01 9.885463421E-03 5.20311236E-02 + 5.13600234E-01 1.46777277E-01 9.900406611E-03 5.20312308E-02 + 5.13703512E-01 1.46806857E-01 9.915369426E-03 5.20313381E-02 + 5.13806790E-01 1.46836438E-01 9.930351897E-03 5.20314456E-02 + 5.13910068E-01 1.46866019E-01 9.945354043E-03 5.20315533E-02 + 5.14013345E-01 1.46895600E-01 9.960375895E-03 5.20316611E-02 + 5.14116623E-01 1.46925181E-01 9.975417452E-03 5.20317692E-02 + 5.14219901E-01 1.46954762E-01 9.990478755E-03 5.20318774E-02 + 5.14323179E-01 1.46984343E-01 1.000531020E-02 5.20319858E-02 + 5.14426456E-01 1.47013925E-01 1.002041220E-02 5.20320945E-02 + 5.14529734E-01 1.47043507E-01 1.003553400E-02 5.20322033E-02 + 5.14633012E-01 1.47073088E-01 1.005067560E-02 5.20323122E-02 + 5.14736290E-01 1.47102670E-01 1.006583710E-02 5.20324214E-02 + 5.14839567E-01 1.47132252E-01 1.008101840E-02 5.20325308E-02 + 5.14942845E-01 1.47161835E-01 1.009621960E-02 5.20326403E-02 + 5.15046123E-01 1.47191417E-01 1.011144070E-02 5.20327500E-02 + 5.15149401E-01 1.47220999E-01 1.012668180E-02 5.20328599E-02 + 5.15252678E-01 1.47250582E-01 1.014194280E-02 5.20329700E-02 + 5.15355956E-01 1.47280165E-01 1.015722380E-02 5.20330803E-02 + 5.15459234E-01 1.47309748E-01 1.017252480E-02 5.20331908E-02 + 5.15562512E-01 1.47339331E-01 1.018784580E-02 5.20333015E-02 + 5.15665789E-01 1.47368914E-01 1.020318690E-02 5.20334123E-02 + 5.15769067E-01 1.47398497E-01 1.021854800E-02 5.20335234E-02 + 5.15872345E-01 1.47428081E-01 1.023392920E-02 5.20336346E-02 + 5.15975623E-01 1.47457665E-01 1.024933060E-02 5.20337461E-02 + 5.16078900E-01 1.47487248E-01 1.026475210E-02 5.20338577E-02 + 5.16182178E-01 1.47516832E-01 1.028019370E-02 5.20339695E-02 + 5.16285456E-01 1.47546416E-01 1.029565550E-02 5.20340815E-02 + 5.16388734E-01 1.47576001E-01 1.031113760E-02 5.20341937E-02 + 5.16492011E-01 1.47605585E-01 1.032663980E-02 5.20343060E-02 + 5.16595289E-01 1.47635169E-01 1.034216230E-02 5.20344186E-02 + 5.16698567E-01 1.47664754E-01 1.035770510E-02 5.20345314E-02 + 5.16801845E-01 1.47694339E-01 1.037326820E-02 5.20346443E-02 + 5.16905122E-01 1.47723924E-01 1.038885150E-02 5.20347575E-02 + 5.17008400E-01 1.47753509E-01 1.040445530E-02 5.20348708E-02 + 5.17111678E-01 1.47783094E-01 1.042007930E-02 5.20349844E-02 + 5.17214956E-01 1.47812680E-01 1.043572380E-02 5.20350981E-02 + 5.17318233E-01 1.47842265E-01 1.045138870E-02 5.20352120E-02 + 5.17421511E-01 1.47871851E-01 1.046707400E-02 5.20353261E-02 + 5.17524789E-01 1.47901437E-01 1.048277980E-02 5.20354404E-02 + 5.17628067E-01 1.47931023E-01 1.049850600E-02 5.20355549E-02 + 5.17731344E-01 1.47960609E-01 1.051425270E-02 5.20356696E-02 + 5.17834622E-01 1.47990195E-01 1.053002000E-02 5.20357845E-02 + 5.17937900E-01 1.48019781E-01 1.054580780E-02 5.20358996E-02 + 5.18041177E-01 1.48049368E-01 1.056161610E-02 5.20360149E-02 + 5.18144455E-01 1.48078955E-01 1.057744510E-02 5.20361304E-02 + 5.18247733E-01 1.48108542E-01 1.059329470E-02 5.20362461E-02 + 5.18351011E-01 1.48138129E-01 1.060916490E-02 5.20363619E-02 + 5.18454288E-01 1.48167716E-01 1.062505570E-02 5.20364780E-02 + 5.18557566E-01 1.48197303E-01 1.064096720E-02 5.20365943E-02 + 5.18660844E-01 1.48226890E-01 1.065689950E-02 5.20367107E-02 + 5.18764122E-01 1.48256478E-01 1.067285250E-02 5.20368274E-02 + 5.18867399E-01 1.48286066E-01 1.068882620E-02 5.20369443E-02 + 5.18970677E-01 1.48315654E-01 1.070482070E-02 5.20370613E-02 + 5.19073955E-01 1.48345242E-01 1.072083600E-02 5.20371786E-02 + 5.19177233E-01 1.48374830E-01 1.073687210E-02 5.20372960E-02 + 5.19280510E-01 1.48404418E-01 1.075292900E-02 5.20374137E-02 + 5.19383788E-01 1.48434007E-01 1.076900680E-02 5.20375315E-02 + 5.19487066E-01 1.48463596E-01 1.078510560E-02 5.20376496E-02 + 5.19590344E-01 1.48493185E-01 1.080122520E-02 5.20377678E-02 + 5.19693621E-01 1.48522774E-01 1.081736570E-02 5.20378863E-02 + 5.19796899E-01 1.48552363E-01 1.083352720E-02 5.20380050E-02 + 5.19900177E-01 1.48581952E-01 1.084970970E-02 5.20381238E-02 + 5.20003455E-01 1.48611541E-01 1.086591320E-02 5.20382429E-02 + 5.20106732E-01 1.48641131E-01 1.088213770E-02 5.20383621E-02 + 5.20210010E-01 1.48670721E-01 1.089838330E-02 5.20384816E-02 + 5.20313288E-01 1.48700311E-01 1.091465000E-02 5.20386013E-02 + 5.20416566E-01 1.48729901E-01 1.093093770E-02 5.20387211E-02 + 5.20519843E-01 1.48759491E-01 1.094724660E-02 5.20388412E-02 + 5.20623121E-01 1.48789081E-01 1.096357660E-02 5.20389615E-02 + 5.20726399E-01 1.48818672E-01 1.097992780E-02 5.20390819E-02 + 5.20829677E-01 1.48848263E-01 1.099630010E-02 5.20392026E-02 + 5.20932954E-01 1.48877853E-01 1.101269370E-02 5.20393235E-02 + 5.21036232E-01 1.48907444E-01 1.102910860E-02 5.20394446E-02 + 5.21139510E-01 1.48937036E-01 1.104554460E-02 5.20395659E-02 + 5.21242788E-01 1.48966627E-01 1.106200200E-02 5.20396874E-02 + 5.21346065E-01 1.48996218E-01 1.107848070E-02 5.20398091E-02 + 5.21449343E-01 1.49025810E-01 1.109498070E-02 5.20399310E-02 + 5.21552621E-01 1.49055402E-01 1.111150210E-02 5.20400531E-02 + 5.21655899E-01 1.49084994E-01 1.112804480E-02 5.20401754E-02 + 5.21759176E-01 1.49114586E-01 1.114460900E-02 5.20402979E-02 + 5.21862454E-01 1.49144178E-01 1.116119450E-02 5.20404207E-02 + 5.21965732E-01 1.49173770E-01 1.117780160E-02 5.20405436E-02 + 5.22069010E-01 1.49203363E-01 1.119443010E-02 5.20406668E-02 + 5.22172287E-01 1.49232956E-01 1.121108010E-02 5.20407901E-02 + 5.22275565E-01 1.49262549E-01 1.122775160E-02 5.20409137E-02 + 5.22378843E-01 1.49292142E-01 1.124444470E-02 5.20410375E-02 + 5.22482121E-01 1.49321735E-01 1.126115930E-02 5.20411614E-02 + 5.22585398E-01 1.49351328E-01 1.127789550E-02 5.20412856E-02 + 5.22688676E-01 1.49380922E-01 1.129465340E-02 5.20414100E-02 + 5.22791954E-01 1.49410516E-01 1.131143290E-02 5.20415346E-02 + 5.22895232E-01 1.49440109E-01 1.132823400E-02 5.20416595E-02 + 5.22998509E-01 1.49469703E-01 1.134505680E-02 5.20417845E-02 + 5.23101787E-01 1.49499298E-01 1.136190140E-02 5.20419097E-02 + 5.23205065E-01 1.49528892E-01 1.137876770E-02 5.20420352E-02 + 5.23308343E-01 1.49558486E-01 1.139565570E-02 5.20421608E-02 + 5.23411620E-01 1.49588081E-01 1.141256550E-02 5.20422867E-02 + 5.23514898E-01 1.49617676E-01 1.142949720E-02 5.20424128E-02 + 5.23618176E-01 1.49647271E-01 1.144645070E-02 5.20425391E-02 + 5.23721454E-01 1.49676866E-01 1.146342600E-02 5.20426656E-02 + 5.23824731E-01 1.49706461E-01 1.148042320E-02 5.20427923E-02 + 5.23928009E-01 1.49736057E-01 1.149744230E-02 5.20429192E-02 + 5.24031287E-01 1.49765653E-01 1.151448330E-02 5.20430464E-02 + 5.24134565E-01 1.49795248E-01 1.153154630E-02 5.20431738E-02 + 5.24237842E-01 1.49824844E-01 1.154863130E-02 5.20433013E-02 + 5.24341120E-01 1.49854440E-01 1.156573820E-02 5.20434291E-02 + 5.24444398E-01 1.49884037E-01 1.158286720E-02 5.20435571E-02 + 5.24547676E-01 1.49913633E-01 1.160001830E-02 5.20436853E-02 + 5.24650953E-01 1.49943230E-01 1.161719140E-02 5.20438138E-02 + 5.24754231E-01 1.49972827E-01 1.163438660E-02 5.20439424E-02 + 5.24857509E-01 1.50002424E-01 1.165160390E-02 5.20440713E-02 + 5.24960787E-01 1.50032021E-01 1.166884340E-02 5.20442004E-02 + 5.25064064E-01 1.50061618E-01 1.168610500E-02 5.20443297E-02 + 5.25167342E-01 1.50091216E-01 1.170338890E-02 5.20444592E-02 + 5.25270620E-01 1.50120813E-01 1.172069500E-02 5.20445889E-02 + 5.25373898E-01 1.50150411E-01 1.173802330E-02 5.20447189E-02 + 5.25477175E-01 1.50180009E-01 1.175537380E-02 5.20448490E-02 + 5.25580453E-01 1.50209607E-01 1.177274670E-02 5.20449794E-02 + 5.25683731E-01 1.50239205E-01 1.179014190E-02 5.20451100E-02 + 5.25787008E-01 1.50268804E-01 1.180755940E-02 5.20452409E-02 + 5.25890286E-01 1.50298403E-01 1.182499930E-02 5.20453719E-02 + 5.25993564E-01 1.50328001E-01 1.184246160E-02 5.20455032E-02 + 5.26096842E-01 1.50357600E-01 1.185994630E-02 5.20456346E-02 + 5.26200119E-01 1.50387200E-01 1.187745340E-02 5.20457663E-02 + 5.26303397E-01 1.50416799E-01 1.189498300E-02 5.20458983E-02 + 5.26406675E-01 1.50446398E-01 1.191253510E-02 5.20460304E-02 + 5.26509953E-01 1.50475998E-01 1.193010970E-02 5.20461628E-02 + 5.26613230E-01 1.50505598E-01 1.194770680E-02 5.20462954E-02 + 5.26716508E-01 1.50535198E-01 1.196532650E-02 5.20464282E-02 + 5.26819786E-01 1.50564798E-01 1.198296880E-02 5.20465612E-02 + 5.26923064E-01 1.50594398E-01 1.200063370E-02 5.20466945E-02 + 5.27026341E-01 1.50623999E-01 1.201832130E-02 5.20468279E-02 + 5.27129619E-01 1.50653600E-01 1.203603150E-02 5.20469616E-02 + 5.27232897E-01 1.50683201E-01 1.205376430E-02 5.20470955E-02 + 5.27336175E-01 1.50712802E-01 1.207151990E-02 5.20472297E-02 + 5.27439452E-01 1.50742403E-01 1.208929830E-02 5.20473641E-02 + 5.27542730E-01 1.50772004E-01 1.210709940E-02 5.20474987E-02 + 5.27646008E-01 1.50801606E-01 1.212492320E-02 5.20476335E-02 + 5.27749286E-01 1.50831207E-01 1.214276990E-02 5.20477685E-02 + 5.27852563E-01 1.50860809E-01 1.216063950E-02 5.20479038E-02 + 5.27955841E-01 1.50890411E-01 1.217853190E-02 5.20480393E-02 + 5.28059119E-01 1.50920014E-01 1.219644710E-02 5.20481750E-02 + 5.28162397E-01 1.50949616E-01 1.221438530E-02 5.20483109E-02 + 5.28265674E-01 1.50979219E-01 1.223234640E-02 5.20484471E-02 + 5.28368952E-01 1.51008822E-01 1.225033050E-02 5.20485835E-02 + 5.28472230E-01 1.51038425E-01 1.226833760E-02 5.20487201E-02 + 5.28575508E-01 1.51068028E-01 1.228636770E-02 5.20488570E-02 + 5.28678785E-01 1.51097631E-01 1.230442080E-02 5.20489941E-02 + 5.28782063E-01 1.51127235E-01 1.232249700E-02 5.20491314E-02 + 5.28885341E-01 1.51156838E-01 1.234059620E-02 5.20492689E-02 + 5.28988619E-01 1.51186442E-01 1.235871860E-02 5.20494067E-02 + 5.29091896E-01 1.51216046E-01 1.237686410E-02 5.20495447E-02 + 5.29195174E-01 1.51245650E-01 1.239503280E-02 5.20496829E-02 + 5.29298452E-01 1.51275255E-01 1.241322460E-02 5.20498214E-02 + 5.29401730E-01 1.51304859E-01 1.243143970E-02 5.20499601E-02 + 5.29505007E-01 1.51334464E-01 1.244967800E-02 5.20500990E-02 + 5.29608285E-01 1.51364069E-01 1.246793960E-02 5.20502382E-02 + 5.29711563E-01 1.51393674E-01 1.248622450E-02 5.20503775E-02 + 5.29814841E-01 1.51423279E-01 1.250453260E-02 5.20505172E-02 + 5.29918118E-01 1.51452885E-01 1.252286420E-02 5.20506570E-02 + 5.30021396E-01 1.51482491E-01 1.254121900E-02 5.20507971E-02 + 5.30124674E-01 1.51512096E-01 1.255959730E-02 5.20509374E-02 + 5.30227952E-01 1.51541702E-01 1.257799900E-02 5.20510779E-02 + 5.30331229E-01 1.51571309E-01 1.259642410E-02 5.20512187E-02 + 5.30434507E-01 1.51600915E-01 1.261487270E-02 5.20513597E-02 + 5.30537785E-01 1.51630522E-01 1.263334480E-02 5.20515010E-02 + 5.30641063E-01 1.51660128E-01 1.265184040E-02 5.20516425E-02 + 5.30744340E-01 1.51689735E-01 1.267035960E-02 5.20517842E-02 + 5.30847618E-01 1.51719342E-01 1.268890230E-02 5.20519261E-02 + 5.30950896E-01 1.51748950E-01 1.270746860E-02 5.20520683E-02 + 5.31054174E-01 1.51778557E-01 1.272605860E-02 5.20522107E-02 + 5.31157451E-01 1.51808165E-01 1.274467210E-02 5.20523534E-02 + 5.31260729E-01 1.51837773E-01 1.276330940E-02 5.20524963E-02 + 5.31364007E-01 1.51867381E-01 1.278197040E-02 5.20526394E-02 + 5.31467285E-01 1.51896989E-01 1.280065500E-02 5.20527828E-02 + 5.31570562E-01 1.51926597E-01 1.281936350E-02 5.20529264E-02 + 5.31673840E-01 1.51956206E-01 1.283809570E-02 5.20530702E-02 + 5.31777118E-01 1.51985815E-01 1.285685170E-02 5.20532143E-02 + 5.31880396E-01 1.52015424E-01 1.287563150E-02 5.20533587E-02 + 5.31983673E-01 1.52045033E-01 1.289443520E-02 5.20535032E-02 + 5.32086951E-01 1.52074642E-01 1.291326270E-02 5.20536480E-02 + 5.32190229E-01 1.52104252E-01 1.293211420E-02 5.20537931E-02 + 5.32293507E-01 1.52133861E-01 1.295098960E-02 5.20539383E-02 + 5.32396784E-01 1.52163471E-01 1.296988900E-02 5.20540839E-02 + 5.32500062E-01 1.52193081E-01 1.298881230E-02 5.20542296E-02 + 5.32603340E-01 1.52222691E-01 1.300775960E-02 5.20543756E-02 + 5.32706618E-01 1.52252302E-01 1.302673100E-02 5.20545219E-02 + 5.32809895E-01 1.52281913E-01 1.304572640E-02 5.20546684E-02 + 5.32913173E-01 1.52311523E-01 1.306474600E-02 5.20548151E-02 + 5.33016451E-01 1.52341134E-01 1.308378960E-02 5.20549621E-02 + 5.33119729E-01 1.52370746E-01 1.310285740E-02 5.20551093E-02 + 5.33223006E-01 1.52400357E-01 1.312194930E-02 5.20552567E-02 + 5.33326284E-01 1.52429969E-01 1.314106550E-02 5.20554044E-02 + 5.33429562E-01 1.52459580E-01 1.316020580E-02 5.20555524E-02 + 5.33532839E-01 1.52489192E-01 1.317937040E-02 5.20557006E-02 + 5.33636117E-01 1.52518805E-01 1.319855930E-02 5.20558490E-02 + 5.33739395E-01 1.52548417E-01 1.321777240E-02 5.20559977E-02 + 5.33842673E-01 1.52578030E-01 1.323700990E-02 5.20561466E-02 + 5.33945950E-01 1.52607642E-01 1.325627180E-02 5.20562958E-02 + 5.34049228E-01 1.52637255E-01 1.327555800E-02 5.20564452E-02 + 5.34152506E-01 1.52666868E-01 1.329486860E-02 5.20565949E-02 + 5.34255784E-01 1.52696482E-01 1.331420360E-02 5.20567448E-02 + 5.34359061E-01 1.52726095E-01 1.333356310E-02 5.20568949E-02 + 5.34462339E-01 1.52755709E-01 1.335294710E-02 5.20570453E-02 + 5.34565617E-01 1.52785323E-01 1.337235560E-02 5.20571960E-02 + 5.34668895E-01 1.52814937E-01 1.339178860E-02 5.20573469E-02 + 5.34772172E-01 1.52844551E-01 1.341124620E-02 5.20574980E-02 + 5.34875450E-01 1.52874166E-01 1.343072830E-02 5.20576494E-02 + 5.34978728E-01 1.52903780E-01 1.345023510E-02 5.20578011E-02 + 5.35082006E-01 1.52933395E-01 1.346976650E-02 5.20579530E-02 + 5.35185283E-01 1.52963010E-01 1.348932260E-02 5.20581051E-02 + 5.35288561E-01 1.52992626E-01 1.350890340E-02 5.20582575E-02 + 5.35391839E-01 1.53022241E-01 1.352850890E-02 5.20584102E-02 + 5.35495117E-01 1.53051857E-01 1.354813910E-02 5.20585631E-02 + 5.35598394E-01 1.53081473E-01 1.356779410E-02 5.20587162E-02 + 5.35701672E-01 1.53111089E-01 1.358747400E-02 5.20588696E-02 + 5.35804950E-01 1.53140705E-01 1.360717860E-02 5.20590233E-02 + 5.35908228E-01 1.53170321E-01 1.362690810E-02 5.20591772E-02 + 5.36011505E-01 1.53199938E-01 1.364666250E-02 5.20593314E-02 + 5.36114783E-01 1.53229555E-01 1.366644180E-02 5.20594858E-02 + 5.36218061E-01 1.53259172E-01 1.368624600E-02 5.20596404E-02 + 5.36321339E-01 1.53288789E-01 1.370607520E-02 5.20597954E-02 + 5.36424616E-01 1.53318407E-01 1.372592940E-02 5.20599505E-02 + 5.36527894E-01 1.53348024E-01 1.374580860E-02 5.20601060E-02 + 5.36631172E-01 1.53377642E-01 1.376571280E-02 5.20602617E-02 + 5.36734450E-01 1.53407260E-01 1.378564210E-02 5.20604176E-02 + 5.36837727E-01 1.53436879E-01 1.380559650E-02 5.20605738E-02 + 5.36941005E-01 1.53466497E-01 1.382557600E-02 5.20607303E-02 + 5.37044283E-01 1.53496116E-01 1.384558070E-02 5.20608870E-02 + 5.37147561E-01 1.53525735E-01 1.386561060E-02 5.20610439E-02 + 5.37250838E-01 1.53555354E-01 1.388566560E-02 5.20612012E-02 + 5.37354116E-01 1.53584973E-01 1.390574590E-02 5.20613587E-02 + 5.37457394E-01 1.53614592E-01 1.392585140E-02 5.20615164E-02 + 5.37560672E-01 1.53644212E-01 1.394598230E-02 5.20616744E-02 + 5.37663949E-01 1.53673832E-01 1.396613840E-02 5.20618327E-02 + 5.37767227E-01 1.53703452E-01 1.398631990E-02 5.20619912E-02 + 5.37870505E-01 1.53733072E-01 1.400652680E-02 5.20621500E-02 + 5.37973783E-01 1.53762693E-01 1.402675900E-02 5.20623090E-02 + 5.38077060E-01 1.53792314E-01 1.404701670E-02 5.20624683E-02 + 5.38180338E-01 1.53821935E-01 1.406729980E-02 5.20626279E-02 + 5.38283616E-01 1.53851556E-01 1.408760840E-02 5.20627877E-02 + 5.38386894E-01 1.53881177E-01 1.410794250E-02 5.20629478E-02 + 5.38490171E-01 1.53910799E-01 1.412830220E-02 5.20631081E-02 + 5.38593449E-01 1.53940420E-01 1.414868740E-02 5.20632687E-02 + 5.38696727E-01 1.53970042E-01 1.416909810E-02 5.20634296E-02 + 5.38800005E-01 1.53999664E-01 1.418953450E-02 5.20635907E-02 + 5.38903282E-01 1.54029287E-01 1.420999660E-02 5.20637521E-02 + 5.39006560E-01 1.54058909E-01 1.423048430E-02 5.20639138E-02 + 5.39109838E-01 1.54088532E-01 1.425099770E-02 5.20640757E-02 + 5.39213116E-01 1.54118155E-01 1.427153680E-02 5.20642379E-02 + 5.39316393E-01 1.54147778E-01 1.429210170E-02 5.20644004E-02 + 5.39419671E-01 1.54177402E-01 1.431269240E-02 5.20645631E-02 + 5.39522949E-01 1.54207025E-01 1.433330890E-02 5.20647261E-02 + 5.39626227E-01 1.54236649E-01 1.435395120E-02 5.20648893E-02 + 5.39729504E-01 1.54266273E-01 1.437461930E-02 5.20650529E-02 + 5.39832782E-01 1.54295898E-01 1.439531340E-02 5.20652167E-02 + 5.39936060E-01 1.54325522E-01 1.441603340E-02 5.20653807E-02 + 5.40039338E-01 1.54355147E-01 1.443677930E-02 5.20655450E-02 + 5.40142615E-01 1.54384772E-01 1.445755120E-02 5.20657096E-02 + 5.40245893E-01 1.54414397E-01 1.447834910E-02 5.20658745E-02 + 5.40349171E-01 1.54444022E-01 1.449917310E-02 5.20660396E-02 + 5.40452449E-01 1.54473648E-01 1.452002310E-02 5.20662050E-02 + 5.40555726E-01 1.54503273E-01 1.454089910E-02 5.20663707E-02 + 5.40659004E-01 1.54532899E-01 1.456180130E-02 5.20665366E-02 + 5.40762282E-01 1.54562525E-01 1.458272970E-02 5.20667028E-02 + 5.40865560E-01 1.54592152E-01 1.460368420E-02 5.20668693E-02 + 5.40968837E-01 1.54621778E-01 1.462466490E-02 5.20670361E-02 + 5.41072115E-01 1.54651405E-01 1.464567180E-02 5.20672031E-02 + 5.41175393E-01 1.54681032E-01 1.466670500E-02 5.20673704E-02 + 5.41278670E-01 1.54710660E-01 1.468776450E-02 5.20675379E-02 + 5.41381948E-01 1.54740287E-01 1.470885020E-02 5.20677058E-02 + 5.41485226E-01 1.54769915E-01 1.472996240E-02 5.20678739E-02 + 5.41588504E-01 1.54799543E-01 1.475110080E-02 5.20680423E-02 + 5.41691781E-01 1.54829171E-01 1.477226570E-02 5.20682109E-02 + 5.41795059E-01 1.54858799E-01 1.479345700E-02 5.20683799E-02 + 5.41898337E-01 1.54888428E-01 1.481467480E-02 5.20685491E-02 + 5.42001615E-01 1.54918056E-01 1.483591900E-02 5.20687186E-02 + 5.42104892E-01 1.54947685E-01 1.485718970E-02 5.20688883E-02 + 5.42208170E-01 1.54977315E-01 1.487848700E-02 5.20690584E-02 + 5.42311448E-01 1.55006944E-01 1.489981090E-02 5.20692287E-02 + 5.42414726E-01 1.55036574E-01 1.492116130E-02 5.20693993E-02 + 5.42518003E-01 1.55066204E-01 1.494253840E-02 5.20695701E-02 + 5.42621281E-01 1.55095834E-01 1.496394210E-02 5.20697413E-02 + 5.42724559E-01 1.55125464E-01 1.498537240E-02 5.20699127E-02 + 5.42827837E-01 1.55155095E-01 1.500682950E-02 5.20700844E-02 + 5.42931114E-01 1.55184725E-01 1.502831340E-02 5.20702564E-02 + 5.43034392E-01 1.55214356E-01 1.504982400E-02 5.20704286E-02 + 5.43137670E-01 1.55243987E-01 1.507136130E-02 5.20706012E-02 + 5.43240948E-01 1.55273619E-01 1.509292550E-02 5.20707740E-02 + 5.43344225E-01 1.55303251E-01 1.511451660E-02 5.20709471E-02 + 5.43447503E-01 1.55332882E-01 1.513613450E-02 5.20711205E-02 + 5.43550781E-01 1.55362515E-01 1.515777940E-02 5.20712941E-02 + 5.43654059E-01 1.55392147E-01 1.517945110E-02 5.20714681E-02 + 5.43757336E-01 1.55421779E-01 1.520114990E-02 5.20716423E-02 + 5.43860614E-01 1.55451412E-01 1.522287560E-02 5.20718168E-02 + 5.43963892E-01 1.55481045E-01 1.524462840E-02 5.20719916E-02 + 5.44067170E-01 1.55510678E-01 1.526640820E-02 5.20721667E-02 + 5.44170447E-01 1.55540312E-01 1.528821510E-02 5.20723420E-02 + 5.44273725E-01 1.55569945E-01 1.531004910E-02 5.20725177E-02 + 5.44377003E-01 1.55599579E-01 1.533191020E-02 5.20726936E-02 + 5.44480281E-01 1.55629214E-01 1.535379850E-02 5.20728698E-02 + 5.44583558E-01 1.55658848E-01 1.537571400E-02 5.20730463E-02 + 5.44686836E-01 1.55688482E-01 1.539765670E-02 5.20732231E-02 + 5.44790114E-01 1.55718117E-01 1.541962670E-02 5.20734002E-02 + 5.44893392E-01 1.55747752E-01 1.544162390E-02 5.20735775E-02 + 5.44996669E-01 1.55777388E-01 1.546364850E-02 5.20737552E-02 + 5.45099947E-01 1.55807023E-01 1.548570040E-02 5.20739331E-02 + 5.45203225E-01 1.55836659E-01 1.550777970E-02 5.20741113E-02 + 5.45306503E-01 1.55866295E-01 1.552988640E-02 5.20742898E-02 + 5.45409780E-01 1.55895931E-01 1.555202050E-02 5.20744686E-02 + 5.45513058E-01 1.55925567E-01 1.557418200E-02 5.20746477E-02 + 5.45616336E-01 1.55955204E-01 1.559637110E-02 5.20748271E-02 + 5.45719614E-01 1.55984841E-01 1.561858760E-02 5.20750067E-02 + 5.45822891E-01 1.56014478E-01 1.564083180E-02 5.20751867E-02 + 5.45926169E-01 1.56044115E-01 1.566310340E-02 5.20753669E-02 + 5.46029447E-01 1.56073753E-01 1.568540270E-02 5.20755474E-02 + 5.46132725E-01 1.56103391E-01 1.570772960E-02 5.20757283E-02 + 5.46236002E-01 1.56133029E-01 1.573008420E-02 5.20759094E-02 + 5.46339280E-01 1.56162667E-01 1.575246650E-02 5.20760908E-02 + 5.46442558E-01 1.56192306E-01 1.577487650E-02 5.20762725E-02 + 5.46545836E-01 1.56221944E-01 1.579731420E-02 5.20764545E-02 + 5.46649113E-01 1.56251583E-01 1.581977980E-02 5.20766368E-02 + 5.46752391E-01 1.56281223E-01 1.584227310E-02 5.20768194E-02 + 5.46855669E-01 1.56310862E-01 1.586479430E-02 5.20770022E-02 + 5.46958947E-01 1.56340502E-01 1.588734330E-02 5.20771854E-02 + 5.47062224E-01 1.56370142E-01 1.590992020E-02 5.20773689E-02 + 5.47165502E-01 1.56399782E-01 1.593252510E-02 5.20775526E-02 + 5.47268780E-01 1.56429422E-01 1.595515790E-02 5.20777367E-02 + 5.47372058E-01 1.56459063E-01 1.597781870E-02 5.20779211E-02 + 5.47475335E-01 1.56488704E-01 1.600050760E-02 5.20781057E-02 + 5.47578613E-01 1.56518345E-01 1.602322440E-02 5.20782907E-02 + 5.47681891E-01 1.56547986E-01 1.604596940E-02 5.20784759E-02 + 5.47785169E-01 1.56577628E-01 1.606874240E-02 5.20786615E-02 + 5.47888446E-01 1.56607270E-01 1.609154360E-02 5.20788473E-02 + 5.47991724E-01 1.56636912E-01 1.611437300E-02 5.20790334E-02 + 5.48095002E-01 1.56666554E-01 1.613723050E-02 5.20792199E-02 + 5.48198280E-01 1.56696197E-01 1.616011630E-02 5.20794066E-02 + 5.48301557E-01 1.56725840E-01 1.618303030E-02 5.20795937E-02 + 5.48404835E-01 1.56755483E-01 1.620597270E-02 5.20797810E-02 + 5.48508113E-01 1.56785126E-01 1.622894330E-02 5.20799687E-02 + 5.48611391E-01 1.56814769E-01 1.625194230E-02 5.20801566E-02 + 5.48714668E-01 1.56844413E-01 1.627496960E-02 5.20803449E-02 + 5.48817946E-01 1.56874057E-01 1.629802540E-02 5.20805334E-02 + 5.48921224E-01 1.56903701E-01 1.632110960E-02 5.20807223E-02 + 5.49024502E-01 1.56933346E-01 1.634422220E-02 5.20809114E-02 + 5.49127779E-01 1.56962991E-01 1.636736340E-02 5.20811009E-02 + 5.49231057E-01 1.56992636E-01 1.639053310E-02 5.20812906E-02 + 5.49334335E-01 1.57022281E-01 1.641373130E-02 5.20814807E-02 + 5.49437612E-01 1.57051926E-01 1.643695810E-02 5.20816711E-02 + 5.49540890E-01 1.57081572E-01 1.646021350E-02 5.20818618E-02 + 5.49644168E-01 1.57111218E-01 1.648349760E-02 5.20820528E-02 + 5.49747446E-01 1.57140864E-01 1.650681040E-02 5.20822440E-02 + 5.49850723E-01 1.57170511E-01 1.653015180E-02 5.20824356E-02 + 5.49954001E-01 1.57200157E-01 1.655352210E-02 5.20826276E-02 + 5.50057279E-01 1.57229804E-01 1.657692100E-02 5.20828198E-02 + 5.50160557E-01 1.57259452E-01 1.660034880E-02 5.20830123E-02 + 5.50263834E-01 1.57289099E-01 1.662380540E-02 5.20832051E-02 + 5.50367112E-01 1.57318747E-01 1.664729080E-02 5.20833983E-02 + 5.50470390E-01 1.57348395E-01 1.667080520E-02 5.20835917E-02 + 5.50573668E-01 1.57378043E-01 1.669434850E-02 5.20837855E-02 + 5.50676945E-01 1.57407691E-01 1.671792070E-02 5.20839795E-02 + 5.50780223E-01 1.57437340E-01 1.674152190E-02 5.20841739E-02 + 5.50883501E-01 1.57466989E-01 1.676515210E-02 5.20843686E-02 + 5.50986779E-01 1.57496638E-01 1.678881130E-02 5.20845636E-02 + 5.51090056E-01 1.57526288E-01 1.681249970E-02 5.20847589E-02 + 5.51193334E-01 1.57555937E-01 1.683621710E-02 5.20849546E-02 + 5.51296612E-01 1.57585587E-01 1.685996370E-02 5.20851505E-02 + 5.51399890E-01 1.57615238E-01 1.688373940E-02 5.20853468E-02 + 5.51503167E-01 1.57644888E-01 1.690754430E-02 5.20855433E-02 + 5.51606445E-01 1.57674539E-01 1.693137850E-02 5.20857402E-02 + 5.51709723E-01 1.57704190E-01 1.695524190E-02 5.20859374E-02 + 5.51813001E-01 1.57733841E-01 1.697913460E-02 5.20861349E-02 + 5.51916278E-01 1.57763493E-01 1.700305660E-02 5.20863328E-02 + 5.52019556E-01 1.57793144E-01 1.702700790E-02 5.20865309E-02 + 5.52122834E-01 1.57822796E-01 1.705098870E-02 5.20867294E-02 + 5.52226112E-01 1.57852449E-01 1.707499880E-02 5.20869282E-02 + 5.52329389E-01 1.57882101E-01 1.709903840E-02 5.20871272E-02 + 5.52432667E-01 1.57911754E-01 1.712310750E-02 5.20873267E-02 + 5.52535945E-01 1.57941407E-01 1.714720610E-02 5.20875264E-02 + 5.52639223E-01 1.57971060E-01 1.717133420E-02 5.20877264E-02 + 5.52742500E-01 1.58000714E-01 1.719549190E-02 5.20879268E-02 + 5.52845778E-01 1.58030368E-01 1.721967920E-02 5.20881275E-02 + 5.52949056E-01 1.58060022E-01 1.724389610E-02 5.20883285E-02 + 5.53052334E-01 1.58089676E-01 1.726814270E-02 5.20885298E-02 + 5.53155611E-01 1.58119331E-01 1.729241890E-02 5.20887315E-02 + 5.53258889E-01 1.58148985E-01 1.731672490E-02 5.20889335E-02 + 5.53362167E-01 1.58178640E-01 1.734106070E-02 5.20891358E-02 + 5.53465445E-01 1.58208296E-01 1.736542620E-02 5.20893384E-02 + 5.53568722E-01 1.58237951E-01 1.738982150E-02 5.20895413E-02 + 5.53672000E-01 1.58267607E-01 1.741424670E-02 5.20897446E-02 + 5.53775278E-01 1.58297263E-01 1.743870180E-02 5.20899482E-02 + 5.53878556E-01 1.58326920E-01 1.746318680E-02 5.20901521E-02 + 5.53981833E-01 1.58356577E-01 1.748770170E-02 5.20903563E-02 + 5.54085111E-01 1.58386234E-01 1.751224660E-02 5.20905609E-02 + 5.54188389E-01 1.58415891E-01 1.753682150E-02 5.20907658E-02 + 5.54291667E-01 1.58445548E-01 1.756142640E-02 5.20909710E-02 + 5.54394944E-01 1.58475206E-01 1.758606140E-02 5.20911765E-02 + 5.54498222E-01 1.58504864E-01 1.761072660E-02 5.20913824E-02 + 5.54601500E-01 1.58534522E-01 1.763542180E-02 5.20915886E-02 + 5.54704778E-01 1.58564181E-01 1.766014720E-02 5.20917951E-02 + 5.54808055E-01 1.58593840E-01 1.768490280E-02 5.20920020E-02 + 5.54911333E-01 1.58623499E-01 1.770968860E-02 5.20922092E-02 + 5.55014611E-01 1.58653158E-01 1.773450470E-02 5.20924167E-02 + 5.55117889E-01 1.58682818E-01 1.775935110E-02 5.20926245E-02 + 5.55221166E-01 1.58712477E-01 1.778422780E-02 5.20928327E-02 + 5.55324444E-01 1.58742138E-01 1.780913480E-02 5.20930412E-02 + 5.55427722E-01 1.58771798E-01 1.783407230E-02 5.20932500E-02 + 5.55531000E-01 1.58801459E-01 1.785904010E-02 5.20934592E-02 + 5.55634277E-01 1.58831120E-01 1.788403840E-02 5.20936687E-02 + 5.55737555E-01 1.58860781E-01 1.790906720E-02 5.20938785E-02 + 5.55840833E-01 1.58890442E-01 1.793412650E-02 5.20940887E-02 + 5.55944111E-01 1.58920104E-01 1.795921640E-02 5.20942992E-02 + 5.56047388E-01 1.58949766E-01 1.798433680E-02 5.20945100E-02 + 5.56150666E-01 1.58979428E-01 1.800948780E-02 5.20947211E-02 + 5.56253944E-01 1.59009091E-01 1.803466950E-02 5.20949326E-02 + 5.56357222E-01 1.59038754E-01 1.805988180E-02 5.20951445E-02 + 5.56460499E-01 1.59068417E-01 1.808512490E-02 5.20953567E-02 + 5.56563777E-01 1.59098080E-01 1.811039870E-02 5.20955692E-02 + 5.56667055E-01 1.59127744E-01 1.813570320E-02 5.20957820E-02 + 5.56770333E-01 1.59157408E-01 1.816103860E-02 5.20959952E-02 + 5.56873610E-01 1.59187072E-01 1.818640480E-02 5.20962087E-02 + 5.56976888E-01 1.59216737E-01 1.821180180E-02 5.20964226E-02 + 5.57080166E-01 1.59246401E-01 1.823722980E-02 5.20966367E-02 + 5.57183443E-01 1.59276067E-01 1.826268870E-02 5.20968513E-02 + 5.57286721E-01 1.59305732E-01 1.828817860E-02 5.20970662E-02 + 5.57389999E-01 1.59335397E-01 1.831369940E-02 5.20972814E-02 + 5.57493277E-01 1.59365063E-01 1.833925130E-02 5.20974969E-02 + 5.57596554E-01 1.59394730E-01 1.836483420E-02 5.20977128E-02 + 5.57699832E-01 1.59424396E-01 1.839044830E-02 5.20979291E-02 + 5.57803110E-01 1.59454063E-01 1.841609340E-02 5.20981456E-02 + 5.57906388E-01 1.59483730E-01 1.844176970E-02 5.20983626E-02 + 5.58009665E-01 1.59513397E-01 1.846747730E-02 5.20985798E-02 + 5.58112943E-01 1.59543065E-01 1.849321600E-02 5.20987974E-02 + 5.58216221E-01 1.59572732E-01 1.851898600E-02 5.20990154E-02 + 5.58319499E-01 1.59602400E-01 1.854478730E-02 5.20992337E-02 + 5.58422776E-01 1.59632069E-01 1.857061990E-02 5.20994523E-02 + 5.58526054E-01 1.59661738E-01 1.859648380E-02 5.20996713E-02 + 5.58629332E-01 1.59691407E-01 1.862237920E-02 5.20998906E-02 + 5.58732610E-01 1.59721076E-01 1.864830590E-02 5.21001103E-02 + 5.58835887E-01 1.59750745E-01 1.867426410E-02 5.21003304E-02 + 5.58939165E-01 1.59780415E-01 1.870025380E-02 5.21005507E-02 + 5.59042443E-01 1.59810085E-01 1.872627500E-02 5.21007715E-02 + 5.59145721E-01 1.59839756E-01 1.875232780E-02 5.21009925E-02 + 5.59248998E-01 1.59869426E-01 1.877841220E-02 5.21012139E-02 + 5.59352276E-01 1.59899097E-01 1.880452810E-02 5.21014357E-02 + 5.59455554E-01 1.59928769E-01 1.883067580E-02 5.21016578E-02 + 5.59558832E-01 1.59958440E-01 1.885685510E-02 5.21018803E-02 + 5.59662109E-01 1.59988112E-01 1.888306610E-02 5.21021031E-02 + 5.59765387E-01 1.60017784E-01 1.890930880E-02 5.21023263E-02 + 5.59868665E-01 1.60047456E-01 1.893558340E-02 5.21025498E-02 + 5.59971943E-01 1.60077129E-01 1.896188980E-02 5.21027737E-02 + 5.60075220E-01 1.60106802E-01 1.898822800E-02 5.21029979E-02 + 5.60178498E-01 1.60136475E-01 1.901459810E-02 5.21032225E-02 + 5.60281776E-01 1.60166149E-01 1.904100010E-02 5.21034474E-02 + 5.60385054E-01 1.60195823E-01 1.906743400E-02 5.21036727E-02 + 5.60488331E-01 1.60225497E-01 1.909390000E-02 5.21038984E-02 + 5.60591609E-01 1.60255171E-01 1.912039790E-02 5.21041244E-02 + 5.60694887E-01 1.60284846E-01 1.914692790E-02 5.21043507E-02 + 5.60798165E-01 1.60314521E-01 1.917349000E-02 5.21045774E-02 + 5.60901442E-01 1.60344196E-01 1.920008420E-02 5.21048045E-02 + 5.61004720E-01 1.60373872E-01 1.922671060E-02 5.21050319E-02 + 5.61107998E-01 1.60403548E-01 1.925336910E-02 5.21052597E-02 + 5.61211276E-01 1.60433224E-01 1.928005990E-02 5.21054878E-02 + 5.61314553E-01 1.60462900E-01 1.930678280E-02 5.21057163E-02 + 5.61417831E-01 1.60492577E-01 1.933353810E-02 5.21059452E-02 + 5.61521109E-01 1.60522254E-01 1.936032570E-02 5.21061744E-02 + 5.61624387E-01 1.60551932E-01 1.938714570E-02 5.21064040E-02 + 5.61727664E-01 1.60581609E-01 1.941399800E-02 5.21066339E-02 + 5.61830942E-01 1.60611287E-01 1.944088270E-02 5.21068642E-02 + 5.61934220E-01 1.60640965E-01 1.946779990E-02 5.21070949E-02 + 5.62037498E-01 1.60670644E-01 1.949474960E-02 5.21073259E-02 + 5.62140775E-01 1.60700323E-01 1.952173180E-02 5.21075573E-02 + 5.62244053E-01 1.60730002E-01 1.954874650E-02 5.21077891E-02 + 5.62347331E-01 1.60759681E-01 1.957579390E-02 5.21080212E-02 + 5.62450609E-01 1.60789361E-01 1.960287380E-02 5.21082537E-02 + 5.62553886E-01 1.60819041E-01 1.962998640E-02 5.21084865E-02 + 5.62657164E-01 1.60848722E-01 1.965713170E-02 5.21087197E-02 + 5.62760442E-01 1.60878402E-01 1.968430970E-02 5.21089533E-02 + 5.62863720E-01 1.60908083E-01 1.971152050E-02 5.21091872E-02 + 5.62966997E-01 1.60937764E-01 1.973876410E-02 5.21094215E-02 + 5.63070275E-01 1.60967446E-01 1.976604040E-02 5.21096562E-02 + 5.63173553E-01 1.60997128E-01 1.979334970E-02 5.21098913E-02 + 5.63276831E-01 1.61026810E-01 1.982069180E-02 5.21101267E-02 + 5.63380108E-01 1.61056492E-01 1.984806690E-02 5.21103625E-02 + 5.63483386E-01 1.61086175E-01 1.987547490E-02 5.21105986E-02 + 5.63586664E-01 1.61115858E-01 1.990291590E-02 5.21108351E-02 + 5.63689942E-01 1.61145542E-01 1.993038990E-02 5.21110720E-02 + 5.63793219E-01 1.61175225E-01 1.995789700E-02 5.21113093E-02 + 5.63896497E-01 1.61204909E-01 1.998543720E-02 5.21115469E-02 + 5.63999775E-01 1.61234594E-01 2.001301060E-02 5.21117849E-02 + 5.64103053E-01 1.61264278E-01 2.004061710E-02 5.21120233E-02 + 5.64206330E-01 1.61293963E-01 2.006825670E-02 5.21122620E-02 + 5.64309608E-01 1.61323648E-01 2.009592970E-02 5.21125012E-02 + 5.64412886E-01 1.61353334E-01 2.012363590E-02 5.21127407E-02 + 5.64516164E-01 1.61383020E-01 2.015137540E-02 5.21129805E-02 + 5.64619441E-01 1.61412706E-01 2.017914820E-02 5.21132208E-02 + 5.64722719E-01 1.61442392E-01 2.020695440E-02 5.21134614E-02 + 5.64825997E-01 1.61472079E-01 2.023479400E-02 5.21137024E-02 + 5.64929274E-01 1.61501766E-01 2.026266710E-02 5.21139438E-02 + 5.65032552E-01 1.61531454E-01 2.029057360E-02 5.21141855E-02 + 5.65135830E-01 1.61561141E-01 2.031851370E-02 5.21144277E-02 + 5.65239108E-01 1.61590829E-01 2.034648730E-02 5.21146702E-02 + 5.65342385E-01 1.61620518E-01 2.037449440E-02 5.21149131E-02 + 5.65445663E-01 1.61650206E-01 2.040253520E-02 5.21151563E-02 + 5.65548941E-01 1.61679895E-01 2.043060960E-02 5.21154000E-02 + 5.65652219E-01 1.61709584E-01 2.045871780E-02 5.21156440E-02 + 5.65755496E-01 1.61739274E-01 2.048685960E-02 5.21158884E-02 + 5.65858774E-01 1.61768964E-01 2.051503520E-02 5.21161332E-02 + 5.65962052E-01 1.61798654E-01 2.054324460E-02 5.21163784E-02 + 5.66065330E-01 1.61828345E-01 2.057148780E-02 5.21166239E-02 + 5.66168607E-01 1.61858036E-01 2.059976480E-02 5.21168699E-02 + 5.66271885E-01 1.61887727E-01 2.062807580E-02 5.21171162E-02 + 5.66375163E-01 1.61917418E-01 2.065642070E-02 5.21173629E-02 + 5.66478441E-01 1.61947110E-01 2.068479950E-02 5.21176100E-02 + 5.66581718E-01 1.61976802E-01 2.071321240E-02 5.21178575E-02 + 5.66684996E-01 1.62006495E-01 2.074165920E-02 5.21181053E-02 + 5.66788274E-01 1.62036187E-01 2.077014020E-02 5.21183536E-02 + 5.66891552E-01 1.62065880E-01 2.079865530E-02 5.21186022E-02 + 5.66994829E-01 1.62095574E-01 2.082720440E-02 5.21188512E-02 + 5.67098107E-01 1.62125268E-01 2.085578780E-02 5.21191006E-02 + 5.67201385E-01 1.62154962E-01 2.088440540E-02 5.21193504E-02 + 5.67304663E-01 1.62184656E-01 2.091305720E-02 5.21196006E-02 + 5.67407940E-01 1.62214351E-01 2.094174330E-02 5.21198512E-02 + 5.67511218E-01 1.62244046E-01 2.097046380E-02 5.21201021E-02 + 5.67614496E-01 1.62273741E-01 2.099921850E-02 5.21203535E-02 + 5.67717774E-01 1.62303437E-01 2.102800770E-02 5.21206052E-02 + 5.67821051E-01 1.62333133E-01 2.105683130E-02 5.21208574E-02 + 5.67924329E-01 1.62362829E-01 2.108568930E-02 5.21211099E-02 + 5.68027607E-01 1.62392526E-01 2.111458190E-02 5.21213628E-02 + 5.68130885E-01 1.62422223E-01 2.114350890E-02 5.21216161E-02 + 5.68234162E-01 1.62451920E-01 2.117247060E-02 5.21218699E-02 + 5.68337440E-01 1.62481617E-01 2.120146680E-02 5.21221240E-02 + 5.68440718E-01 1.62511315E-01 2.123049770E-02 5.21223785E-02 + 5.68543996E-01 1.62541014E-01 2.125956320E-02 5.21226333E-02 + 5.68647273E-01 1.62570712E-01 2.128866340E-02 5.21228886E-02 + 5.68750551E-01 1.62600411E-01 2.131779840E-02 5.21231443E-02 + 5.68853829E-01 1.62630110E-01 2.134696820E-02 5.21234004E-02 + 5.68957107E-01 1.62659810E-01 2.137617280E-02 5.21236569E-02 + 5.69060384E-01 1.62689510E-01 2.140541220E-02 5.21239138E-02 + 5.69163662E-01 1.62719210E-01 2.143468660E-02 5.21241710E-02 + 5.69266940E-01 1.62748911E-01 2.146399580E-02 5.21244287E-02 + 5.69370218E-01 1.62778612E-01 2.149334000E-02 5.21246868E-02 + 5.69473495E-01 1.62808313E-01 2.152271920E-02 5.21249453E-02 + 5.69576773E-01 1.62838015E-01 2.155213340E-02 5.21252041E-02 + 5.69680051E-01 1.62867716E-01 2.158158270E-02 5.21254634E-02 + 5.69783329E-01 1.62897419E-01 2.161106710E-02 5.21257231E-02 + 5.69886606E-01 1.62927121E-01 2.164058670E-02 5.21259832E-02 + 5.69989884E-01 1.62956824E-01 2.167014140E-02 5.21262437E-02 + 5.70093162E-01 1.62986527E-01 2.169973130E-02 5.21265045E-02 + 5.70196440E-01 1.63016231E-01 2.172935650E-02 5.21267658E-02 + 5.70299717E-01 1.63045935E-01 2.175901690E-02 5.21270275E-02 + 5.70402995E-01 1.63075639E-01 2.178871270E-02 5.21272896E-02 + 5.70506273E-01 1.63105344E-01 2.181844390E-02 5.21275521E-02 + 5.70609551E-01 1.63135049E-01 2.184821040E-02 5.21278151E-02 + 5.70712828E-01 1.63164754E-01 2.187801230E-02 5.21280784E-02 + 5.70816106E-01 1.63194460E-01 2.190784980E-02 5.21283421E-02 + 5.70919384E-01 1.63224166E-01 2.193772270E-02 5.21286062E-02 + 5.71022662E-01 1.63253872E-01 2.196763110E-02 5.21288708E-02 + 5.71125939E-01 1.63283579E-01 2.199757520E-02 5.21291357E-02 + 5.71229217E-01 1.63313286E-01 2.202755480E-02 5.21294011E-02 + 5.71332495E-01 1.63342993E-01 2.205757010E-02 5.21296669E-02 + 5.71435773E-01 1.63372701E-01 2.208762110E-02 5.21299331E-02 + 5.71539050E-01 1.63402409E-01 2.211770780E-02 5.21301997E-02 + 5.71642328E-01 1.63432117E-01 2.214783030E-02 5.21304667E-02 + 5.71745606E-01 1.63461826E-01 2.217798850E-02 5.21307341E-02 + 5.71848884E-01 1.63491535E-01 2.220818260E-02 5.21310019E-02 + 5.71952161E-01 1.63521244E-01 2.223841260E-02 5.21312702E-02 + 5.72055439E-01 1.63550954E-01 2.226867840E-02 5.21315388E-02 + 5.72158717E-01 1.63580664E-01 2.229898020E-02 5.21318079E-02 + 5.72261995E-01 1.63610374E-01 2.232931800E-02 5.21320774E-02 + 5.72365272E-01 1.63640085E-01 2.235969180E-02 5.21323473E-02 + 5.72468550E-01 1.63669796E-01 2.239010170E-02 5.21326176E-02 + 5.72571828E-01 1.63699508E-01 2.242054760E-02 5.21328884E-02 + 5.72675105E-01 1.63729220E-01 2.245102970E-02 5.21331596E-02 + 5.72778383E-01 1.63758932E-01 2.248154790E-02 5.21334311E-02 + 5.72881661E-01 1.63788644E-01 2.251210230E-02 5.21337031E-02 + 5.72984939E-01 1.63818357E-01 2.254269300E-02 5.21339755E-02 + 5.73088216E-01 1.63848070E-01 2.257331990E-02 5.21342484E-02 + 5.73191494E-01 1.63877784E-01 2.260398320E-02 5.21345216E-02 + 5.73294772E-01 1.63907498E-01 2.263468280E-02 5.21347953E-02 + 5.73398050E-01 1.63937212E-01 2.266541880E-02 5.21350694E-02 + 5.73501327E-01 1.63966927E-01 2.269619120E-02 5.21353439E-02 + 5.73604605E-01 1.63996642E-01 2.272700010E-02 5.21356189E-02 + 5.73707883E-01 1.64026357E-01 2.275784550E-02 5.21358943E-02 + 5.73811161E-01 1.64056073E-01 2.278872740E-02 5.21361700E-02 + 5.73914438E-01 1.64085789E-01 2.281964590E-02 5.21364463E-02 + 5.74017716E-01 1.64115505E-01 2.285060100E-02 5.21367229E-02 + 5.74120994E-01 1.64145222E-01 2.288159270E-02 5.21370000E-02 + 5.74224272E-01 1.64174939E-01 2.291262110E-02 5.21372775E-02 + 5.74327549E-01 1.64204657E-01 2.294368630E-02 5.21375554E-02 + 5.74430827E-01 1.64234375E-01 2.297478820E-02 5.21378337E-02 + 5.74534105E-01 1.64264093E-01 2.300592690E-02 5.21381125E-02 + 5.74637383E-01 1.64293811E-01 2.303710250E-02 5.21383917E-02 + 5.74740660E-01 1.64323530E-01 2.306831490E-02 5.21386714E-02 + 5.74843938E-01 1.64353250E-01 2.309956420E-02 5.21389514E-02 + 5.74947216E-01 1.64382969E-01 2.313085050E-02 5.21392319E-02 + 5.75050494E-01 1.64412689E-01 2.316217380E-02 5.21395128E-02 + 5.75153771E-01 1.64442410E-01 2.319353410E-02 5.21397942E-02 + 5.75257049E-01 1.64472130E-01 2.322493150E-02 5.21400760E-02 + 5.75360327E-01 1.64501851E-01 2.325636590E-02 5.21403582E-02 + 5.75463605E-01 1.64531573E-01 2.328783750E-02 5.21406409E-02 + 5.75566882E-01 1.64561295E-01 2.331934630E-02 5.21409240E-02 + 5.75670160E-01 1.64591017E-01 2.335089230E-02 5.21412075E-02 + 5.75773438E-01 1.64620739E-01 2.338247550E-02 5.21414914E-02 + 5.75876716E-01 1.64650462E-01 2.341409610E-02 5.21417758E-02 + 5.75979993E-01 1.64680186E-01 2.344575390E-02 5.21420607E-02 + 5.76083271E-01 1.64709909E-01 2.347744920E-02 5.21423459E-02 + 5.76186549E-01 1.64739633E-01 2.350918180E-02 5.21426316E-02 + 5.76289827E-01 1.64769358E-01 2.354095190E-02 5.21429178E-02 + 5.76393104E-01 1.64799083E-01 2.357275940E-02 5.21432044E-02 + 5.76496382E-01 1.64828808E-01 2.360460450E-02 5.21434914E-02 + 5.76599660E-01 1.64858533E-01 2.363648720E-02 5.21437789E-02 + 5.76702938E-01 1.64888259E-01 2.366840740E-02 5.21440668E-02 + 5.76806215E-01 1.64917985E-01 2.370036530E-02 5.21443551E-02 + 5.76909493E-01 1.64947712E-01 2.373236080E-02 5.21446439E-02 + 5.77012771E-01 1.64977439E-01 2.376439410E-02 5.21449331E-02 + 5.77116049E-01 1.65007166E-01 2.379646510E-02 5.21452228E-02 + 5.77219326E-01 1.65036894E-01 2.382857390E-02 5.21455129E-02 + 5.77322604E-01 1.65066622E-01 2.386072050E-02 5.21458035E-02 + 5.77425882E-01 1.65096351E-01 2.389290500E-02 5.21460945E-02 + 5.77529160E-01 1.65126079E-01 2.392512740E-02 5.21463859E-02 + 5.77632437E-01 1.65155809E-01 2.395738770E-02 5.21466778E-02 + 5.77735715E-01 1.65185538E-01 2.398968600E-02 5.21469701E-02 + 5.77838993E-01 1.65215268E-01 2.402202230E-02 5.21472629E-02 + 5.77942271E-01 1.65244999E-01 2.405439670E-02 5.21475562E-02 + 5.78045548E-01 1.65274729E-01 2.408680920E-02 5.21478499E-02 + 5.78148826E-01 1.65304460E-01 2.411925990E-02 5.21481440E-02 + 5.78252104E-01 1.65334192E-01 2.415174870E-02 5.21484386E-02 + 5.78355382E-01 1.65363924E-01 2.418427570E-02 5.21487336E-02 + 5.78458659E-01 1.65393656E-01 2.421684090E-02 5.21490291E-02 + 5.78561937E-01 1.65423389E-01 2.424944450E-02 5.21493250E-02 + 5.78665215E-01 1.65453122E-01 2.428208640E-02 5.21496214E-02 + 5.78768493E-01 1.65482855E-01 2.431476670E-02 5.21499183E-02 + 5.78871770E-01 1.65512589E-01 2.434748530E-02 5.21502156E-02 + 5.78975048E-01 1.65542323E-01 2.438024250E-02 5.21505133E-02 + 5.79078326E-01 1.65572058E-01 2.441303810E-02 5.21508115E-02 + 5.79181604E-01 1.65601793E-01 2.444587220E-02 5.21511102E-02 + 5.79284881E-01 1.65631528E-01 2.447874490E-02 5.21514093E-02 + 5.79388159E-01 1.65661264E-01 2.451165620E-02 5.21517088E-02 + 5.79491437E-01 1.65691000E-01 2.454460620E-02 5.21520089E-02 + 5.79594715E-01 1.65720736E-01 2.457759480E-02 5.21523094E-02 + 5.79697992E-01 1.65750473E-01 2.461062220E-02 5.21526103E-02 + 5.79801270E-01 1.65780210E-01 2.464368830E-02 5.21529117E-02 + 5.79904548E-01 1.65809948E-01 2.467679320E-02 5.21532136E-02 + 5.80007826E-01 1.65839686E-01 2.470993700E-02 5.21535159E-02 + 5.80111103E-01 1.65869424E-01 2.474311970E-02 5.21538187E-02 + 5.80214381E-01 1.65899163E-01 2.477634120E-02 5.21541219E-02 + 5.80317659E-01 1.65928902E-01 2.480960180E-02 5.21544256E-02 + 5.80420937E-01 1.65958642E-01 2.484290130E-02 5.21547298E-02 + 5.80524214E-01 1.65988382E-01 2.487623980E-02 5.21550344E-02 + 5.80627492E-01 1.66018122E-01 2.490961750E-02 5.21553395E-02 + 5.80730770E-01 1.66047863E-01 2.494303430E-02 5.21556451E-02 + 5.80834047E-01 1.66077604E-01 2.497649020E-02 5.21559511E-02 + 5.80937325E-01 1.66107346E-01 2.500998530E-02 5.21562576E-02 + 5.81040603E-01 1.66137088E-01 2.504351970E-02 5.21565645E-02 + 5.81143881E-01 1.66166830E-01 2.507709330E-02 5.21568720E-02 + 5.81247158E-01 1.66196573E-01 2.511070620E-02 5.21571798E-02 + 5.81350436E-01 1.66226316E-01 2.514435860E-02 5.21574882E-02 + 5.81453714E-01 1.66256060E-01 2.517805030E-02 5.21577970E-02 + 5.81556992E-01 1.66285804E-01 2.521178140E-02 5.21581063E-02 + 5.81660269E-01 1.66315548E-01 2.524555200E-02 5.21584161E-02 + 5.81763547E-01 1.66345293E-01 2.527936220E-02 5.21587263E-02 + 5.81866825E-01 1.66375038E-01 2.531321190E-02 5.21590371E-02 + 5.81970103E-01 1.66404783E-01 2.534710120E-02 5.21593482E-02 + 5.82073380E-01 1.66434529E-01 2.538103010E-02 5.21596599E-02 + 5.82176658E-01 1.66464276E-01 2.541499870E-02 5.21599720E-02 + 5.82279936E-01 1.66494022E-01 2.544900710E-02 5.21602846E-02 + 5.82383214E-01 1.66523769E-01 2.548305510E-02 5.21605977E-02 + 5.82486491E-01 1.66553517E-01 2.551714300E-02 5.21609113E-02 + 5.82589769E-01 1.66583265E-01 2.555127080E-02 5.21612253E-02 + 5.82693047E-01 1.66613013E-01 2.558543840E-02 5.21615398E-02 + 5.82796325E-01 1.66642762E-01 2.561964590E-02 5.21618548E-02 + 5.82899602E-01 1.66672511E-01 2.565389340E-02 5.21621702E-02 + 5.83002880E-01 1.66702261E-01 2.568818090E-02 5.21624862E-02 + 5.83106158E-01 1.66732011E-01 2.572250840E-02 5.21628026E-02 + 5.83209436E-01 1.66761761E-01 2.575687600E-02 5.21631195E-02 + 5.83312713E-01 1.66791512E-01 2.579128370E-02 5.21634369E-02 + 5.83415991E-01 1.66821263E-01 2.582573160E-02 5.21637547E-02 + 5.83519269E-01 1.66851015E-01 2.586021970E-02 5.21640731E-02 + 5.83622547E-01 1.66880767E-01 2.589474810E-02 5.21643919E-02 + 5.83725824E-01 1.66910519E-01 2.592931670E-02 5.21647112E-02 + 5.83829102E-01 1.66940272E-01 2.596392570E-02 5.21650310E-02 + 5.83932380E-01 1.66970025E-01 2.599857500E-02 5.21653513E-02 + 5.84035658E-01 1.66999779E-01 2.603326470E-02 5.21656720E-02 + 5.84138935E-01 1.67029533E-01 2.606799490E-02 5.21659933E-02 + 5.84242213E-01 1.67059288E-01 2.610276560E-02 5.21663150E-02 + 5.84345491E-01 1.67089043E-01 2.613757680E-02 5.21666372E-02 + 5.84448769E-01 1.67118798E-01 2.617242860E-02 5.21669599E-02 + 5.84552046E-01 1.67148554E-01 2.620732100E-02 5.21672831E-02 + 5.84655324E-01 1.67178310E-01 2.624225400E-02 5.21676068E-02 + 5.84758602E-01 1.67208066E-01 2.627722770E-02 5.21679310E-02 + 5.84861880E-01 1.67237823E-01 2.631224220E-02 5.21682556E-02 + 5.84965157E-01 1.67267581E-01 2.634729750E-02 5.21685808E-02 + 5.85068435E-01 1.67297339E-01 2.638239350E-02 5.21689064E-02 + 5.85171713E-01 1.67327097E-01 2.641753050E-02 5.21692326E-02 + 5.85274991E-01 1.67356856E-01 2.645270830E-02 5.21695592E-02 + 5.85378268E-01 1.67386615E-01 2.648792710E-02 5.21698863E-02 + 5.85481546E-01 1.67416374E-01 2.652318680E-02 5.21702139E-02 + 5.85584824E-01 1.67446134E-01 2.655848760E-02 5.21705420E-02 + 5.85688102E-01 1.67475894E-01 2.659382940E-02 5.21708707E-02 + 5.85791379E-01 1.67505655E-01 2.662921240E-02 5.21711998E-02 + 5.85894657E-01 1.67535416E-01 2.666463650E-02 5.21715294E-02 + 5.85997935E-01 1.67565178E-01 2.670010180E-02 5.21718595E-02 + 5.86101213E-01 1.67594940E-01 2.673560830E-02 5.21721901E-02 + 5.86204490E-01 1.67624703E-01 2.677115610E-02 5.21725212E-02 + 5.86307768E-01 1.67654465E-01 2.680674520E-02 5.21728528E-02 + 5.86411046E-01 1.67684229E-01 2.684237570E-02 5.21731848E-02 + 5.86514324E-01 1.67713993E-01 2.687804760E-02 5.21735174E-02 + 5.86617601E-01 1.67743757E-01 2.691376090E-02 5.21738505E-02 + 5.86720879E-01 1.67773521E-01 2.694951570E-02 5.21741841E-02 + 5.86824157E-01 1.67803286E-01 2.698531200E-02 5.21745183E-02 + 5.86927435E-01 1.67833052E-01 2.702114990E-02 5.21748529E-02 + 5.87030712E-01 1.67862818E-01 2.705702940E-02 5.21751880E-02 + 5.87133990E-01 1.67892584E-01 2.709295060E-02 5.21755236E-02 + 5.87237268E-01 1.67922351E-01 2.712891340E-02 5.21758597E-02 + 5.87340546E-01 1.67952118E-01 2.716491800E-02 5.21761963E-02 + 5.87443823E-01 1.67981886E-01 2.720096440E-02 5.21765335E-02 + 5.87547101E-01 1.68011654E-01 2.723705260E-02 5.21768711E-02 + 5.87650379E-01 1.68041422E-01 2.727318260E-02 5.21772093E-02 + 5.87753657E-01 1.68071191E-01 2.730935450E-02 5.21775479E-02 + 5.87856934E-01 1.68100961E-01 2.734556840E-02 5.21778871E-02 + 5.87960212E-01 1.68130731E-01 2.738182430E-02 5.21782268E-02 + 5.88063490E-01 1.68160501E-01 2.741812220E-02 5.21785670E-02 + 5.88166768E-01 1.68190272E-01 2.745446220E-02 5.21789077E-02 + 5.88270045E-01 1.68220043E-01 2.749084430E-02 5.21792489E-02 + 5.88373323E-01 1.68249814E-01 2.752726850E-02 5.21795906E-02 + 5.88476601E-01 1.68279586E-01 2.756373500E-02 5.21799329E-02 + 5.88579878E-01 1.68309359E-01 2.760024370E-02 5.21802756E-02 + 5.88683156E-01 1.68339132E-01 2.763679460E-02 5.21806189E-02 + 5.88786434E-01 1.68368905E-01 2.767338790E-02 5.21809627E-02 + 5.88889712E-01 1.68398679E-01 2.771002360E-02 5.21813070E-02 + 5.88992989E-01 1.68428453E-01 2.774670170E-02 5.21816518E-02 + 5.89096267E-01 1.68458228E-01 2.778342230E-02 5.21819972E-02 + 5.89199545E-01 1.68488003E-01 2.782018530E-02 5.21823430E-02 + 5.89302823E-01 1.68517778E-01 2.785699090E-02 5.21826894E-02 + 5.89406100E-01 1.68547554E-01 2.789383910E-02 5.21830363E-02 + 5.89509378E-01 1.68577331E-01 2.793072980E-02 5.21833837E-02 + 5.89612656E-01 1.68607108E-01 2.796766330E-02 5.21837317E-02 + 5.89715934E-01 1.68636885E-01 2.800463950E-02 5.21840801E-02 + 5.89819211E-01 1.68666663E-01 2.804165840E-02 5.21844291E-02 + 5.89922489E-01 1.68696441E-01 2.807872020E-02 5.21847786E-02 + 5.90025767E-01 1.68726220E-01 2.811582470E-02 5.21851287E-02 + 5.90129045E-01 1.68755999E-01 2.815297220E-02 5.21854792E-02 + 5.90232322E-01 1.68785779E-01 2.819016260E-02 5.21858303E-02 + 5.90335600E-01 1.68815559E-01 2.822739590E-02 5.21861819E-02 + 5.90438878E-01 1.68845339E-01 2.826467230E-02 5.21865340E-02 + 5.90542156E-01 1.68875120E-01 2.830199170E-02 5.21868867E-02 + 5.90645433E-01 1.68904901E-01 2.833935420E-02 5.21872399E-02 + 5.90748711E-01 1.68934683E-01 2.837675990E-02 5.21875936E-02 + 5.90851989E-01 1.68964466E-01 2.841420880E-02 5.21879479E-02 + 5.90955267E-01 1.68994248E-01 2.845170090E-02 5.21883027E-02 + 5.91058544E-01 1.69024032E-01 2.848923620E-02 5.21886580E-02 + 5.91161822E-01 1.69053815E-01 2.852681490E-02 5.21890138E-02 + 5.91265100E-01 1.69083599E-01 2.856443700E-02 5.21893702E-02 + 5.91368378E-01 1.69113384E-01 2.860210240E-02 5.21897271E-02 + 5.91471655E-01 1.69143169E-01 2.863981130E-02 5.21900846E-02 + 5.91574933E-01 1.69172955E-01 2.867756370E-02 5.21904425E-02 + 5.91678211E-01 1.69202741E-01 2.871535960E-02 5.21908011E-02 + 5.91781489E-01 1.69232527E-01 2.875319910E-02 5.21911601E-02 + 5.91884766E-01 1.69262314E-01 2.879108220E-02 5.21915197E-02 + 5.91988044E-01 1.69292101E-01 2.882900900E-02 5.21918798E-02 + 5.92091322E-01 1.69321889E-01 2.886697950E-02 5.21922405E-02 + 5.92194600E-01 1.69351678E-01 2.890499380E-02 5.21926017E-02 + 5.92297877E-01 1.69381466E-01 2.894305180E-02 5.21929635E-02 + 5.92401155E-01 1.69411256E-01 2.898115370E-02 5.21933257E-02 + 5.92504433E-01 1.69441045E-01 2.901929950E-02 5.21936886E-02 + 5.92607711E-01 1.69470835E-01 2.905748920E-02 5.21940519E-02 + 5.92710988E-01 1.69500626E-01 2.909572290E-02 5.21944159E-02 + 5.92814266E-01 1.69530417E-01 2.913400060E-02 5.21947803E-02 + 5.92917544E-01 1.69560209E-01 2.917232240E-02 5.21951453E-02 + 5.93020822E-01 1.69590001E-01 2.921068830E-02 5.21955109E-02 + 5.93124099E-01 1.69619793E-01 2.924909830E-02 5.21958769E-02 + 5.93227377E-01 1.69649586E-01 2.928755250E-02 5.21962436E-02 + 5.93330655E-01 1.69679380E-01 2.932605100E-02 5.21966108E-02 + 5.93433933E-01 1.69709174E-01 2.936459370E-02 5.21969785E-02 + 5.93537210E-01 1.69738968E-01 2.940318080E-02 5.21973468E-02 + 5.93640488E-01 1.69768763E-01 2.944181230E-02 5.21977156E-02 + 5.93743766E-01 1.69798558E-01 2.948048810E-02 5.21980850E-02 + 5.93847044E-01 1.69828354E-01 2.951920850E-02 5.21984549E-02 + 5.93950321E-01 1.69858150E-01 2.955797330E-02 5.21988254E-02 + 5.94053599E-01 1.69887947E-01 2.959678270E-02 5.21991964E-02 + 5.94156877E-01 1.69917745E-01 2.963563670E-02 5.21995680E-02 + 5.94260155E-01 1.69947542E-01 2.967453530E-02 5.21999402E-02 + 5.94363432E-01 1.69977340E-01 2.971347860E-02 5.22003129E-02 + 5.94466710E-01 1.70007139E-01 2.975246660E-02 5.22006861E-02 + 5.94569988E-01 1.70036938E-01 2.979149940E-02 5.22010599E-02 + 5.94673266E-01 1.70066738E-01 2.983057710E-02 5.22014343E-02 + 5.94776543E-01 1.70096538E-01 2.986969950E-02 5.22018092E-02 + 5.94879821E-01 1.70126339E-01 2.990886690E-02 5.22021847E-02 + 5.94983099E-01 1.70156140E-01 2.994807930E-02 5.22025607E-02 + 5.95086377E-01 1.70185941E-01 2.998733670E-02 5.22029373E-02 + 5.95189654E-01 1.70215744E-01 3.002663910E-02 5.22033145E-02 + 5.95292932E-01 1.70245546E-01 3.006598650E-02 5.22036922E-02 + 5.95396210E-01 1.70275349E-01 3.010537920E-02 5.22040705E-02 + 5.95499488E-01 1.70305153E-01 3.014481700E-02 5.22044493E-02 + 5.95602765E-01 1.70334957E-01 3.018430000E-02 5.22048287E-02 + 5.95706043E-01 1.70364761E-01 3.022382830E-02 5.22052087E-02 + 5.95809321E-01 1.70394566E-01 3.026340190E-02 5.22055892E-02 + 5.95912599E-01 1.70424372E-01 3.030302090E-02 5.22059703E-02 + 5.96015876E-01 1.70454178E-01 3.034268520E-02 5.22063520E-02 + 5.96119154E-01 1.70483984E-01 3.038239510E-02 5.22067342E-02 + 5.96222432E-01 1.70513791E-01 3.042215040E-02 5.22071170E-02 + 5.96325709E-01 1.70543599E-01 3.046195120E-02 5.22075004E-02 + 5.96428987E-01 1.70573406E-01 3.050179770E-02 5.22078843E-02 + 5.96532265E-01 1.70603215E-01 3.054168980E-02 5.22082688E-02 + 5.96635543E-01 1.70633024E-01 3.058162750E-02 5.22086539E-02 + 5.96738820E-01 1.70662833E-01 3.062161100E-02 5.22090396E-02 + 5.96842098E-01 1.70692643E-01 3.066164030E-02 5.22094258E-02 + 5.96945376E-01 1.70722454E-01 3.070171530E-02 5.22098126E-02 + 5.97048654E-01 1.70752265E-01 3.074183630E-02 5.22102000E-02 + 5.97151931E-01 1.70782076E-01 3.078200310E-02 5.22105879E-02 + 5.97255209E-01 1.70811888E-01 3.082221590E-02 5.22109764E-02 + 5.97358487E-01 1.70841700E-01 3.086247470E-02 5.22113655E-02 + 5.97461765E-01 1.70871513E-01 3.090277950E-02 5.22117552E-02 + 5.97565042E-01 1.70901327E-01 3.094313050E-02 5.22121455E-02 + 5.97668320E-01 1.70931141E-01 3.098352750E-02 5.22125363E-02 + 5.97771598E-01 1.70960955E-01 3.102397080E-02 5.22129277E-02 + 5.97874876E-01 1.70990770E-01 3.106446030E-02 5.22133197E-02 + 5.97978153E-01 1.71020585E-01 3.110499600E-02 5.22137123E-02 + 5.98081431E-01 1.71050401E-01 3.114557810E-02 5.22141054E-02 + 5.98184709E-01 1.71080218E-01 3.118620650E-02 5.22144991E-02 + 5.98287987E-01 1.71110035E-01 3.122688140E-02 5.22148935E-02 + 5.98391264E-01 1.71139852E-01 3.126760270E-02 5.22152884E-02 + 5.98494542E-01 1.71169670E-01 3.130837050E-02 5.22156838E-02 + 5.98597820E-01 1.71199489E-01 3.134918490E-02 5.22160799E-02 + 5.98701098E-01 1.71229308E-01 3.139004590E-02 5.22164766E-02 + 5.98804375E-01 1.71259127E-01 3.143095350E-02 5.22168738E-02 + 5.98907653E-01 1.71288947E-01 3.147190780E-02 5.22172716E-02 + 5.99010931E-01 1.71318768E-01 3.151290880E-02 5.22176701E-02 + 5.99114209E-01 1.71348589E-01 3.155395670E-02 5.22180691E-02 + 5.99217486E-01 1.71378410E-01 3.159505130E-02 5.22184687E-02 + 5.99320764E-01 1.71408232E-01 3.163619290E-02 5.22188688E-02 + 5.99424042E-01 1.71438055E-01 3.167738130E-02 5.22192696E-02 + 5.99527320E-01 1.71467878E-01 3.171861680E-02 5.22196710E-02 + 5.99630597E-01 1.71497702E-01 3.175989930E-02 5.22200730E-02 + 5.99733875E-01 1.71527526E-01 3.180122880E-02 5.22204755E-02 + 5.99837153E-01 1.71557350E-01 3.184260540E-02 5.22208787E-02 + 5.99940431E-01 1.71587175E-01 3.188402920E-02 5.22212824E-02 + 6.00043708E-01 1.71617001E-01 3.192550020E-02 5.22216868E-02 + 6.00146986E-01 1.71646827E-01 3.196701850E-02 5.22220917E-02 + 6.00250264E-01 1.71676654E-01 3.200858400E-02 5.22224973E-02 + 6.00353542E-01 1.71706481E-01 3.205019690E-02 5.22229034E-02 + 6.00456819E-01 1.71736309E-01 3.209185720E-02 5.22233101E-02 + 6.00560097E-01 1.71766137E-01 3.213356500E-02 5.22237175E-02 + 6.00663375E-01 1.71795966E-01 3.217532020E-02 5.22241254E-02 + 6.00766653E-01 1.71825796E-01 3.221712300E-02 5.22245340E-02 + 6.00869930E-01 1.71855625E-01 3.225897330E-02 5.22249431E-02 + 6.00973208E-01 1.71885456E-01 3.230087130E-02 5.22253528E-02 + 6.01076486E-01 1.71915287E-01 3.234281700E-02 5.22257632E-02 + 6.01179764E-01 1.71945118E-01 3.238481040E-02 5.22261742E-02 + 6.01283041E-01 1.71974950E-01 3.242685150E-02 5.22265857E-02 + 6.01386319E-01 1.72004783E-01 3.246894050E-02 5.22269979E-02 + 6.01489597E-01 1.72034616E-01 3.251107740E-02 5.22274107E-02 + 6.01592875E-01 1.72064449E-01 3.255326220E-02 5.22278240E-02 + 6.01696152E-01 1.72094283E-01 3.259549490E-02 5.22282380E-02 + 6.01799430E-01 1.72124118E-01 3.263777560E-02 5.22286526E-02 + 6.01902708E-01 1.72153953E-01 3.268010440E-02 5.22290679E-02 + 6.02005986E-01 1.72183789E-01 3.272248130E-02 5.22294837E-02 + 6.02109263E-01 1.72213625E-01 3.276490640E-02 5.22299001E-02 + 6.02212541E-01 1.72243462E-01 3.280737970E-02 5.22303172E-02 + 6.02315819E-01 1.72273299E-01 3.284990120E-02 5.22307348E-02 + 6.02419097E-01 1.72303137E-01 3.289247100E-02 5.22311531E-02 + 6.02522374E-01 1.72332975E-01 3.293508920E-02 5.22315720E-02 + 6.02625652E-01 1.72362814E-01 3.297775570E-02 5.22319915E-02 + 6.02728930E-01 1.72392654E-01 3.302047070E-02 5.22324116E-02 + 6.02832208E-01 1.72422494E-01 3.306323420E-02 5.22328324E-02 + 6.02935485E-01 1.72452334E-01 3.310604630E-02 5.22332537E-02 + 6.03038763E-01 1.72482175E-01 3.314890690E-02 5.22336757E-02 + 6.03142041E-01 1.72512017E-01 3.319181610E-02 5.22340983E-02 + 6.03245319E-01 1.72541859E-01 3.323477410E-02 5.22345215E-02 + 6.03348596E-01 1.72571702E-01 3.327778080E-02 5.22349454E-02 + 6.03451874E-01 1.72601545E-01 3.332083620E-02 5.22353699E-02 + 6.03555152E-01 1.72631389E-01 3.336394050E-02 5.22357949E-02 + 6.03658430E-01 1.72661233E-01 3.340709370E-02 5.22362207E-02 + 6.03761707E-01 1.72691078E-01 3.345029570E-02 5.22366470E-02 + 6.03864985E-01 1.72720923E-01 3.349354680E-02 5.22370740E-02 + 6.03968263E-01 1.72750769E-01 3.353684690E-02 5.22375016E-02 + 6.04071540E-01 1.72780616E-01 3.358019600E-02 5.22379298E-02 + 6.04174818E-01 1.72810463E-01 3.362359430E-02 5.22383586E-02 + 6.04278096E-01 1.72840311E-01 3.366704180E-02 5.22387881E-02 + 6.04381374E-01 1.72870159E-01 3.371053840E-02 5.22392182E-02 + 6.04484651E-01 1.72900008E-01 3.375408440E-02 5.22396490E-02 + 6.04587929E-01 1.72929857E-01 3.379767960E-02 5.22400803E-02 + 6.04691207E-01 1.72959707E-01 3.384132420E-02 5.22405123E-02 + 6.04794485E-01 1.72989557E-01 3.388501830E-02 5.22409450E-02 + 6.04897762E-01 1.73019408E-01 3.392876170E-02 5.22413782E-02 + 6.05001040E-01 1.73049260E-01 3.397255470E-02 5.22418121E-02 + 6.05104318E-01 1.73079112E-01 3.401639730E-02 5.22422467E-02 + 6.05207596E-01 1.73108964E-01 3.406028950E-02 5.22426819E-02 + 6.05310873E-01 1.73138818E-01 3.410423130E-02 5.22431177E-02 + 6.05414151E-01 1.73168671E-01 3.414822280E-02 5.22435541E-02 + 6.05517429E-01 1.73198526E-01 3.419226410E-02 5.22439912E-02 + 6.05620707E-01 1.73228381E-01 3.423635530E-02 5.22444290E-02 + 6.05723984E-01 1.73258236E-01 3.428049620E-02 5.22448673E-02 + 6.05827262E-01 1.73288092E-01 3.432468710E-02 5.22453064E-02 + 6.05930540E-01 1.73317949E-01 3.436892790E-02 5.22457460E-02 + 6.06033818E-01 1.73347806E-01 3.441321870E-02 5.22461863E-02 + 6.06137095E-01 1.73377663E-01 3.445755960E-02 5.22466273E-02 + 6.06240373E-01 1.73407522E-01 3.450195060E-02 5.22470689E-02 + 6.06343651E-01 1.73437381E-01 3.454639170E-02 5.22475111E-02 + 6.06446929E-01 1.73467240E-01 3.459088310E-02 5.22479540E-02 + 6.06550206E-01 1.73497100E-01 3.463542470E-02 5.22483975E-02 + 6.06653484E-01 1.73526960E-01 3.468001660E-02 5.22488417E-02 + 6.06756762E-01 1.73556822E-01 3.472465880E-02 5.22492865E-02 + 6.06860040E-01 1.73586683E-01 3.476935150E-02 5.22497320E-02 + 6.06963317E-01 1.73616546E-01 3.481409460E-02 5.22501781E-02 + 6.07066595E-01 1.73646408E-01 3.485888820E-02 5.22506249E-02 + 6.07169873E-01 1.73676272E-01 3.490373240E-02 5.22510723E-02 + 6.07273151E-01 1.73706136E-01 3.494862720E-02 5.22515204E-02 + 6.07376428E-01 1.73736000E-01 3.499357260E-02 5.22519692E-02 + 6.07479706E-01 1.73765865E-01 3.503856870E-02 5.22524186E-02 + 6.07582984E-01 1.73795731E-01 3.508361560E-02 5.22528686E-02 + 6.07686262E-01 1.73825597E-01 3.512871320E-02 5.22533193E-02 + 6.07789539E-01 1.73855464E-01 3.517386180E-02 5.22537707E-02 + 6.07892817E-01 1.73885332E-01 3.521906120E-02 5.22542227E-02 + 6.07996095E-01 1.73915200E-01 3.526431160E-02 5.22546754E-02 + 6.08099373E-01 1.73945068E-01 3.530961300E-02 5.22551288E-02 + 6.08202650E-01 1.73974938E-01 3.535496540E-02 5.22555828E-02 + 6.08305928E-01 1.74004807E-01 3.540036900E-02 5.22560374E-02 + 6.08409206E-01 1.74034678E-01 3.544582370E-02 5.22564928E-02 + 6.08512484E-01 1.74064549E-01 3.549132960E-02 5.22569488E-02 + 6.08615761E-01 1.74094420E-01 3.553688680E-02 5.22574054E-02 + 6.08719039E-01 1.74124292E-01 3.558249530E-02 5.22578628E-02 + 6.08822317E-01 1.74154165E-01 3.562815510E-02 5.22583207E-02 + 6.08925595E-01 1.74184038E-01 3.567386640E-02 5.22587794E-02 + 6.09028872E-01 1.74213912E-01 3.571962910E-02 5.22592387E-02 + 6.09132150E-01 1.74243787E-01 3.576544330E-02 5.22596987E-02 + 6.09235428E-01 1.74273662E-01 3.581130910E-02 5.22601594E-02 + 6.09338706E-01 1.74303537E-01 3.585722650E-02 5.22606207E-02 + 6.09441983E-01 1.74333414E-01 3.590319550E-02 5.22610828E-02 + 6.09545261E-01 1.74363291E-01 3.594921630E-02 5.22615454E-02 + 6.09648539E-01 1.74393168E-01 3.599528880E-02 5.22620088E-02 + 6.09751817E-01 1.74423046E-01 3.604141320E-02 5.22624728E-02 + 6.09855094E-01 1.74452925E-01 3.608758940E-02 5.22629375E-02 + 6.09958372E-01 1.74482804E-01 3.613381760E-02 5.22634029E-02 + 6.10061650E-01 1.74512684E-01 3.618009770E-02 5.22638690E-02 + 6.10164928E-01 1.74542564E-01 3.622642980E-02 5.22643357E-02 + 6.10268205E-01 1.74572445E-01 3.627281410E-02 5.22648031E-02 + 6.10371483E-01 1.74602327E-01 3.631925040E-02 5.22652712E-02 + 6.10474761E-01 1.74632209E-01 3.636573890E-02 5.22657400E-02 + 6.10578039E-01 1.74662092E-01 3.641227970E-02 5.22662094E-02 + 6.10681316E-01 1.74691975E-01 3.645887270E-02 5.22666796E-02 + 6.10784594E-01 1.74721859E-01 3.650551800E-02 5.22671504E-02 + 6.10887872E-01 1.74751744E-01 3.655221580E-02 5.22676219E-02 + 6.10991150E-01 1.74781629E-01 3.659896590E-02 5.22680941E-02 + 6.11094427E-01 1.74811515E-01 3.664576860E-02 5.22685670E-02 + 6.11197705E-01 1.74841402E-01 3.669262380E-02 5.22690405E-02 + 6.11300983E-01 1.74871289E-01 3.673953160E-02 5.22695148E-02 + 6.11404261E-01 1.74901176E-01 3.678649200E-02 5.22699897E-02 + 6.11507538E-01 1.74931065E-01 3.683350510E-02 5.22704654E-02 + 6.11610816E-01 1.74960953E-01 3.688057100E-02 5.22709417E-02 + 6.11714094E-01 1.74990843E-01 3.692768970E-02 5.22714187E-02 + 6.11817372E-01 1.75020733E-01 3.697486120E-02 5.22718964E-02 + 6.11920649E-01 1.75050624E-01 3.702208560E-02 5.22723748E-02 + 6.12023927E-01 1.75080515E-01 3.706936300E-02 5.22728539E-02 + 6.12127205E-01 1.75110407E-01 3.711669340E-02 5.22733337E-02 + 6.12230482E-01 1.75140300E-01 3.716407680E-02 5.22738141E-02 + 6.12333760E-01 1.75170193E-01 3.721151340E-02 5.22742953E-02 + 6.12437038E-01 1.75200087E-01 3.725900310E-02 5.22747772E-02 + 6.12540316E-01 1.75229981E-01 3.730654600E-02 5.22752597E-02 + 6.12643593E-01 1.75259876E-01 3.735414220E-02 5.22757430E-02 + 6.12746871E-01 1.75289772E-01 3.740179170E-02 5.22762270E-02 + 6.12850149E-01 1.75319668E-01 3.744949460E-02 5.22767117E-02 + 6.12953427E-01 1.75349565E-01 3.749725090E-02 5.22771970E-02 + 6.13056704E-01 1.75379463E-01 3.754506070E-02 5.22776831E-02 + 6.13159982E-01 1.75409361E-01 3.759292410E-02 5.22781699E-02 + 6.13263260E-01 1.75439260E-01 3.764084100E-02 5.22786574E-02 + 6.13366538E-01 1.75469159E-01 3.768881150E-02 5.22791456E-02 + 6.13469815E-01 1.75499059E-01 3.773683580E-02 5.22796345E-02 + 6.13573093E-01 1.75528960E-01 3.778491370E-02 5.22801241E-02 + 6.13676371E-01 1.75558861E-01 3.783304550E-02 5.22806144E-02 + 6.13779649E-01 1.75588763E-01 3.788123110E-02 5.22811054E-02 + 6.13882926E-01 1.75618666E-01 3.792947070E-02 5.22815971E-02 + 6.13986204E-01 1.75648569E-01 3.797776420E-02 5.22820896E-02 + 6.14089482E-01 1.75678473E-01 3.802611160E-02 5.22825827E-02 + 6.14192760E-01 1.75708377E-01 3.807451320E-02 5.22830766E-02 + 6.14296037E-01 1.75738282E-01 3.812296890E-02 5.22835712E-02 + 6.14399315E-01 1.75768188E-01 3.817147870E-02 5.22840665E-02 + 6.14502593E-01 1.75798094E-01 3.822004280E-02 5.22845625E-02 + 6.14605871E-01 1.75828001E-01 3.826866110E-02 5.22850592E-02 + 6.14709148E-01 1.75857909E-01 3.831733370E-02 5.22855567E-02 + 6.14812426E-01 1.75887817E-01 3.836606080E-02 5.22860548E-02 + 6.14915704E-01 1.75917726E-01 3.841484230E-02 5.22865537E-02 + 6.15018982E-01 1.75947636E-01 3.846367820E-02 5.22870533E-02 + 6.15122259E-01 1.75977546E-01 3.851256870E-02 5.22875536E-02 + 6.15225537E-01 1.76007457E-01 3.856151380E-02 5.22880547E-02 + 6.15328815E-01 1.76037368E-01 3.861051360E-02 5.22885565E-02 + 6.15432093E-01 1.76067280E-01 3.865956800E-02 5.22890590E-02 + 6.15535370E-01 1.76097193E-01 3.870867720E-02 5.22895622E-02 + 6.15638648E-01 1.76127107E-01 3.875784130E-02 5.22900661E-02 + 6.15741926E-01 1.76157021E-01 3.880706010E-02 5.22905708E-02 + 6.15845204E-01 1.76186935E-01 3.885633390E-02 5.22910762E-02 + 6.15948481E-01 1.76216851E-01 3.890566270E-02 5.22915823E-02 + 6.16051759E-01 1.76246767E-01 3.895504650E-02 5.22920892E-02 + 6.16155037E-01 1.76276684E-01 3.900448540E-02 5.22925968E-02 + 6.16258315E-01 1.76306601E-01 3.905397940E-02 5.22931051E-02 + 6.16361592E-01 1.76336519E-01 3.910352860E-02 5.22936142E-02 + 6.16464870E-01 1.76366437E-01 3.915313310E-02 5.22941239E-02 + 6.16568148E-01 1.76396357E-01 3.920279280E-02 5.22946345E-02 + 6.16671426E-01 1.76426277E-01 3.925250790E-02 5.22951457E-02 + 6.16774703E-01 1.76456197E-01 3.930227850E-02 5.22956577E-02 + 6.16877981E-01 1.76486119E-01 3.935210440E-02 5.22961704E-02 + 6.16981259E-01 1.76516040E-01 3.940198590E-02 5.22966839E-02 + 6.17084537E-01 1.76545963E-01 3.945192300E-02 5.22971981E-02 + 6.17187814E-01 1.76575886E-01 3.950191570E-02 5.22977131E-02 + 6.17291092E-01 1.76605810E-01 3.955196400E-02 5.22982288E-02 + 6.17394370E-01 1.76635735E-01 3.960206810E-02 5.22987452E-02 + 6.17497648E-01 1.76665660E-01 3.965222800E-02 5.22992624E-02 + 6.17600925E-01 1.76695586E-01 3.970244370E-02 5.22997803E-02 + 6.17704203E-01 1.76725512E-01 3.975271530E-02 5.23002990E-02 + 6.17807481E-01 1.76755440E-01 3.980304290E-02 5.23008184E-02 + 6.17910759E-01 1.76785367E-01 3.985342650E-02 5.23013385E-02 + 6.18014036E-01 1.76815296E-01 3.990386620E-02 5.23018594E-02 + 6.18117314E-01 1.76845225E-01 3.995436190E-02 5.23023811E-02 + 6.18220592E-01 1.76875155E-01 4.000491390E-02 5.23029035E-02 + 6.18323870E-01 1.76905086E-01 4.005552210E-02 5.23034266E-02 + 6.18427147E-01 1.76935017E-01 4.010618650E-02 5.23039505E-02 + 6.18530425E-01 1.76964949E-01 4.015690730E-02 5.23044752E-02 + 6.18633703E-01 1.76994881E-01 4.020768450E-02 5.23050006E-02 + 6.18736981E-01 1.77024815E-01 4.025851810E-02 5.23055268E-02 + 6.18840258E-01 1.77054748E-01 4.030940830E-02 5.23060537E-02 + 6.18943536E-01 1.77084683E-01 4.036035500E-02 5.23065814E-02 + 6.19046814E-01 1.77114618E-01 4.041135830E-02 5.23071098E-02 + 6.19150092E-01 1.77144554E-01 4.046241830E-02 5.23076390E-02 + 6.19253369E-01 1.77174491E-01 4.051353500E-02 5.23081690E-02 + 6.19356647E-01 1.77204428E-01 4.056470850E-02 5.23086997E-02 + 6.19459925E-01 1.77234366E-01 4.061593890E-02 5.23092311E-02 + 6.19563203E-01 1.77264305E-01 4.066722610E-02 5.23097634E-02 + 6.19666480E-01 1.77294244E-01 4.071857030E-02 5.23102964E-02 + 6.19769758E-01 1.77324184E-01 4.076997150E-02 5.23108301E-02 + 6.19873036E-01 1.77354125E-01 4.082142980E-02 5.23113647E-02 + 6.19976313E-01 1.77384066E-01 4.087294510E-02 5.23119000E-02 + 6.20079591E-01 1.77414008E-01 4.092451770E-02 5.23124360E-02 + 6.20182869E-01 1.77443951E-01 4.097614750E-02 5.23129729E-02 + 6.20286147E-01 1.77473895E-01 4.102783460E-02 5.23135105E-02 + 6.20389424E-01 1.77503839E-01 4.107957900E-02 5.23140488E-02 + 6.20492702E-01 1.77533784E-01 4.113138080E-02 5.23145880E-02 + 6.20595980E-01 1.77563729E-01 4.118324000E-02 5.23151279E-02 + 6.20699258E-01 1.77593676E-01 4.123515680E-02 5.23156686E-02 + 6.20802535E-01 1.77623622E-01 4.128713120E-02 5.23162100E-02 + 6.20905813E-01 1.77653570E-01 4.133916310E-02 5.23167523E-02 + 6.21009091E-01 1.77683518E-01 4.139125280E-02 5.23172953E-02 + 6.21112369E-01 1.77713467E-01 4.144340020E-02 5.23178391E-02 + 6.21215646E-01 1.77743417E-01 4.149560540E-02 5.23183837E-02 + 6.21318924E-01 1.77773368E-01 4.154786840E-02 5.23189290E-02 + 6.21422202E-01 1.77803319E-01 4.160018930E-02 5.23194751E-02 + 6.21525480E-01 1.77833270E-01 4.165256820E-02 5.23200220E-02 + 6.21628757E-01 1.77863223E-01 4.170500520E-02 5.23205697E-02 + 6.21732035E-01 1.77893176E-01 4.175750020E-02 5.23211182E-02 + 6.21835313E-01 1.77923130E-01 4.181005330E-02 5.23216675E-02 + 6.21938591E-01 1.77953085E-01 4.186266460E-02 5.23222175E-02 + 6.22041868E-01 1.77983040E-01 4.191533420E-02 5.23227683E-02 + 6.22145146E-01 1.78012996E-01 4.196806210E-02 5.23233200E-02 + 6.22248424E-01 1.78042953E-01 4.202084840E-02 5.23238724E-02 + 6.22351702E-01 1.78072910E-01 4.207369300E-02 5.23244256E-02 + 6.22454979E-01 1.78102868E-01 4.212659620E-02 5.23249795E-02 + 6.22558257E-01 1.78132827E-01 4.217955790E-02 5.23255343E-02 + 6.22661535E-01 1.78162787E-01 4.223257810E-02 5.23260899E-02 + 6.22764813E-01 1.78192747E-01 4.228565710E-02 5.23266462E-02 + 6.22868090E-01 1.78222708E-01 4.233879470E-02 5.23272034E-02 + 6.22971368E-01 1.78252670E-01 4.239199110E-02 5.23277614E-02 + 6.23074646E-01 1.78282632E-01 4.244524630E-02 5.23283201E-02 + 6.23177924E-01 1.78312596E-01 4.249856040E-02 5.23288797E-02 + 6.23281201E-01 1.78342559E-01 4.255193340E-02 5.23294400E-02 + 6.23384479E-01 1.78372524E-01 4.260536540E-02 5.23300011E-02 + 6.23487757E-01 1.78402489E-01 4.265885650E-02 5.23305631E-02 + 6.23591035E-01 1.78432455E-01 4.271240670E-02 5.23311258E-02 + 6.23694312E-01 1.78462422E-01 4.276601610E-02 5.23316894E-02 + 6.23797590E-01 1.78492390E-01 4.281968460E-02 5.23322537E-02 + 6.23900868E-01 1.78522358E-01 4.287341250E-02 5.23328189E-02 + 6.24004146E-01 1.78552327E-01 4.292719970E-02 5.23333848E-02 + 6.24107423E-01 1.78582296E-01 4.298104630E-02 5.23339516E-02 + 6.24210701E-01 1.78612267E-01 4.303495240E-02 5.23345192E-02 + 6.24313979E-01 1.78642238E-01 4.308891800E-02 5.23350876E-02 + 6.24417257E-01 1.78672210E-01 4.314294310E-02 5.23356568E-02 + 6.24520534E-01 1.78702182E-01 4.319702790E-02 5.23362268E-02 + 6.24623812E-01 1.78732156E-01 4.325117240E-02 5.23367976E-02 + 6.24727090E-01 1.78762130E-01 4.330537660E-02 5.23373692E-02 + 6.24830368E-01 1.78792104E-01 4.335964070E-02 5.23379416E-02 + 6.24933645E-01 1.78822080E-01 4.341396460E-02 5.23385149E-02 + 6.25036923E-01 1.78852056E-01 4.346834840E-02 5.23390890E-02 + 6.25140201E-01 1.78882033E-01 4.352279220E-02 5.23396639E-02 + 6.25243479E-01 1.78912011E-01 4.357729610E-02 5.23402396E-02 + 6.25346756E-01 1.78941989E-01 4.363186010E-02 5.23408161E-02 + 6.25450034E-01 1.78971968E-01 4.368648420E-02 5.23413934E-02 + 6.25553312E-01 1.79001948E-01 4.374116850E-02 5.23419716E-02 + 6.25656590E-01 1.79031929E-01 4.379591310E-02 5.23425506E-02 + 6.25759867E-01 1.79061910E-01 4.385071810E-02 5.23431304E-02 + 6.25863145E-01 1.79091893E-01 4.390558340E-02 5.23437111E-02 + 6.25966423E-01 1.79121875E-01 4.396050920E-02 5.23442925E-02 + 6.26069701E-01 1.79151859E-01 4.401549550E-02 5.23448748E-02 + 6.26172978E-01 1.79181843E-01 4.407054240E-02 5.23454579E-02 + 6.26276256E-01 1.79211829E-01 4.412565000E-02 5.23460419E-02 + 6.26379534E-01 1.79241814E-01 4.418081820E-02 5.23466266E-02 + 6.26482812E-01 1.79271801E-01 4.423604710E-02 5.23472122E-02 + 6.26586089E-01 1.79301788E-01 4.429133690E-02 5.23477987E-02 + 6.26689367E-01 1.79331777E-01 4.434668750E-02 5.23483860E-02 + 6.26792645E-01 1.79361765E-01 4.440209910E-02 5.23489741E-02 + 6.26895923E-01 1.79391755E-01 4.445757170E-02 5.23495630E-02 + 6.26999200E-01 1.79421745E-01 4.451310530E-02 5.23501528E-02 + 6.27102478E-01 1.79451737E-01 4.456870000E-02 5.23507434E-02 + 6.27205756E-01 1.79481729E-01 4.462435590E-02 5.23513348E-02 + 6.27309034E-01 1.79511721E-01 4.468007300E-02 5.23519271E-02 + 6.27412311E-01 1.79541715E-01 4.473585140E-02 5.23525202E-02 + 6.27515589E-01 1.79571709E-01 4.479169110E-02 5.23531142E-02 + 6.27618867E-01 1.79601704E-01 4.484759230E-02 5.23537090E-02 + 6.27722144E-01 1.79631699E-01 4.490355490E-02 5.23543047E-02 + 6.27825422E-01 1.79661696E-01 4.495957900E-02 5.23549012E-02 + 6.27928700E-01 1.79691693E-01 4.501566480E-02 5.23554985E-02 + 6.28031978E-01 1.79721691E-01 4.507181210E-02 5.23560967E-02 + 6.28135255E-01 1.79751690E-01 4.512802120E-02 5.23566958E-02 + 6.28238533E-01 1.79781689E-01 4.518429210E-02 5.23572956E-02 + 6.28341811E-01 1.79811690E-01 4.524062470E-02 5.23578964E-02 + 6.28445089E-01 1.79841691E-01 4.529701930E-02 5.23584980E-02 + 6.28548366E-01 1.79871693E-01 4.535347580E-02 5.23591004E-02 + 6.28651644E-01 1.79901695E-01 4.540999430E-02 5.23597037E-02 + 6.28754922E-01 1.79931699E-01 4.546657490E-02 5.23603079E-02 + 6.28858200E-01 1.79961703E-01 4.552321770E-02 5.23609129E-02 + 6.28961477E-01 1.79991708E-01 4.557992260E-02 5.23615187E-02 + 6.29064755E-01 1.80021713E-01 4.563668970E-02 5.23621254E-02 + 6.29168033E-01 1.80051720E-01 4.569351920E-02 5.23627330E-02 + 6.29271311E-01 1.80081727E-01 4.575041110E-02 5.23633414E-02 + 6.29374588E-01 1.80111735E-01 4.580736530E-02 5.23639507E-02 + 6.29477866E-01 1.80141744E-01 4.586438210E-02 5.23645609E-02 + 6.29581144E-01 1.80171754E-01 4.592146150E-02 5.23651719E-02 + 6.29684422E-01 1.80201764E-01 4.597860340E-02 5.23657838E-02 + 6.29787699E-01 1.80231775E-01 4.603580800E-02 5.23663966E-02 + 6.29890977E-01 1.80261787E-01 4.609307540E-02 5.23670102E-02 + 6.29994255E-01 1.80291800E-01 4.615040560E-02 5.23676247E-02 + 6.30097533E-01 1.80321814E-01 4.620779860E-02 5.23682400E-02 + 6.30200810E-01 1.80351828E-01 4.626525460E-02 5.23688562E-02 + 6.30304088E-01 1.80381843E-01 4.632277350E-02 5.23694733E-02 + 6.30407366E-01 1.80411859E-01 4.638035550E-02 5.23700913E-02 + 6.30510644E-01 1.80441876E-01 4.643800060E-02 5.23707101E-02 + 6.30613921E-01 1.80471893E-01 4.649570880E-02 5.23713298E-02 + 6.30717199E-01 1.80501911E-01 4.655348030E-02 5.23719504E-02 + 6.30820477E-01 1.80531930E-01 4.661131510E-02 5.23725719E-02 + 6.30923755E-01 1.80561950E-01 4.666921320E-02 5.23731942E-02 + 6.31027032E-01 1.80591971E-01 4.672717480E-02 5.23738174E-02 + 6.31130310E-01 1.80621992E-01 4.678519980E-02 5.23744415E-02 + 6.31233588E-01 1.80652015E-01 4.684328840E-02 5.23750665E-02 + 6.31336866E-01 1.80682038E-01 4.690144050E-02 5.23756924E-02 + 6.31440143E-01 1.80712062E-01 4.695965640E-02 5.23763191E-02 + 6.31543421E-01 1.80742086E-01 4.701793590E-02 5.23769467E-02 + 6.31646699E-01 1.80772112E-01 4.707627930E-02 5.23775752E-02 + 6.31749977E-01 1.80802138E-01 4.713468640E-02 5.23782046E-02 + 6.31853254E-01 1.80832165E-01 4.719315750E-02 5.23788349E-02 + 6.31956532E-01 1.80862193E-01 4.725169260E-02 5.23794661E-02 + 6.32059810E-01 1.80892222E-01 4.731029170E-02 5.23800982E-02 + 6.32163088E-01 1.80922251E-01 4.736895500E-02 5.23807311E-02 + 6.32266365E-01 1.80952282E-01 4.742768230E-02 5.23813649E-02 + 6.32369643E-01 1.80982313E-01 4.748647390E-02 5.23819997E-02 + 6.32472921E-01 1.81012345E-01 4.754532980E-02 5.23826353E-02 + 6.32576199E-01 1.81042377E-01 4.760425000E-02 5.23832718E-02 + 6.32679476E-01 1.81072411E-01 4.766323470E-02 5.23839093E-02 + 6.32782754E-01 1.81102445E-01 4.772228380E-02 5.23845476E-02 + 6.32886032E-01 1.81132481E-01 4.778139750E-02 5.23851868E-02 + 6.32989310E-01 1.81162517E-01 4.784057570E-02 5.23858269E-02 + 6.33092587E-01 1.81192553E-01 4.789981860E-02 5.23864679E-02 + 6.33195865E-01 1.81222591E-01 4.795912630E-02 5.23871099E-02 + 6.33299143E-01 1.81252630E-01 4.801849870E-02 5.23877527E-02 + 6.33402421E-01 1.81282669E-01 4.807793600E-02 5.23883964E-02 + 6.33505698E-01 1.81312709E-01 4.813743820E-02 5.23890411E-02 + 6.33608976E-01 1.81342750E-01 4.819700540E-02 5.23896866E-02 + 6.33712254E-01 1.81372792E-01 4.825663760E-02 5.23903330E-02 + 6.33815532E-01 1.81402834E-01 4.831633490E-02 5.23909804E-02 + 6.33918809E-01 1.81432878E-01 4.837609740E-02 5.23916287E-02 + 6.34022087E-01 1.81462922E-01 4.843592520E-02 5.23922778E-02 + 6.34125365E-01 1.81492967E-01 4.849581820E-02 5.23929279E-02 + 6.34228643E-01 1.81523013E-01 4.855577660E-02 5.23935789E-02 + 6.34331920E-01 1.81553060E-01 4.861580040E-02 5.23942309E-02 + 6.34435198E-01 1.81583108E-01 4.867588970E-02 5.23948837E-02 + 6.34538476E-01 1.81613156E-01 4.873604450E-02 5.23955374E-02 + 6.34641754E-01 1.81643205E-01 4.879626500E-02 5.23961921E-02 + 6.34745031E-01 1.81673255E-01 4.885655110E-02 5.23968477E-02 + 6.34848309E-01 1.81703306E-01 4.891690300E-02 5.23975042E-02 + 6.34951587E-01 1.81733358E-01 4.897732070E-02 5.23981616E-02 + 6.35054865E-01 1.81763411E-01 4.903780420E-02 5.23988200E-02 + 6.35158142E-01 1.81793464E-01 4.909835370E-02 5.23994793E-02 + 6.35261420E-01 1.81823519E-01 4.915896920E-02 5.24001395E-02 + 6.35364698E-01 1.81853574E-01 4.921965080E-02 5.24008006E-02 + 6.35467975E-01 1.81883630E-01 4.928039840E-02 5.24014627E-02 + 6.35571253E-01 1.81913687E-01 4.934121230E-02 5.24021257E-02 + 6.35674531E-01 1.81943744E-01 4.940209240E-02 5.24027896E-02 + 6.35777809E-01 1.81973803E-01 4.946303890E-02 5.24034544E-02 + 6.35881086E-01 1.82003862E-01 4.952405170E-02 5.24041202E-02 + 6.35984364E-01 1.82033923E-01 4.958513100E-02 5.24047869E-02 + 6.36087642E-01 1.82063984E-01 4.964627680E-02 5.24054546E-02 + 6.36190920E-01 1.82094046E-01 4.970748920E-02 5.24061231E-02 + 6.36294197E-01 1.82124108E-01 4.976876820E-02 5.24067927E-02 + 6.36397475E-01 1.82154172E-01 4.983011390E-02 5.24074631E-02 + 6.36500753E-01 1.82184237E-01 4.989152640E-02 5.24081345E-02 + 6.36604031E-01 1.82214302E-01 4.995300570E-02 5.24088068E-02 + 6.36707308E-01 1.82244368E-01 5.001455200E-02 5.24094801E-02 + 6.36810586E-01 1.82274435E-01 5.007616520E-02 5.24101543E-02 + 6.36913864E-01 1.82304503E-01 5.013784540E-02 5.24108295E-02 + 6.37017142E-01 1.82334572E-01 5.019959270E-02 5.24115056E-02 + 6.37120419E-01 1.82364642E-01 5.026140720E-02 5.24121827E-02 + 6.37223697E-01 1.82394713E-01 5.032328900E-02 5.24128607E-02 + 6.37326975E-01 1.82424784E-01 5.038523800E-02 5.24135396E-02 + 6.37430253E-01 1.82454856E-01 5.044725440E-02 5.24142195E-02 + 6.37533530E-01 1.82484929E-01 5.050933820E-02 5.24149004E-02 + 6.37636808E-01 1.82515004E-01 5.057148950E-02 5.24155822E-02 + 6.37740086E-01 1.82545078E-01 5.063370840E-02 5.24162649E-02 + 6.37843364E-01 1.82575154E-01 5.069599490E-02 5.24169487E-02 + 6.37946641E-01 1.82605231E-01 5.075834900E-02 5.24176333E-02 + 6.38049919E-01 1.82635308E-01 5.082077090E-02 5.24183190E-02 + 6.38153197E-01 1.82665387E-01 5.088326070E-02 5.24190055E-02 + 6.38256475E-01 1.82695466E-01 5.094581830E-02 5.24196931E-02 + 6.38359752E-01 1.82725546E-01 5.100844390E-02 5.24203816E-02 + 6.38463030E-01 1.82755627E-01 5.107113750E-02 5.24210711E-02 + 6.38566308E-01 1.82785709E-01 5.113389920E-02 5.24217615E-02 + 6.38669586E-01 1.82815792E-01 5.119672900E-02 5.24224529E-02 + 6.38772863E-01 1.82845876E-01 5.125962710E-02 5.24231452E-02 + 6.38876141E-01 1.82875961E-01 5.132259340E-02 5.24238386E-02 + 6.38979419E-01 1.82906046E-01 5.138562810E-02 5.24245329E-02 + 6.39082697E-01 1.82936132E-01 5.144873120E-02 5.24252281E-02 + 6.39185974E-01 1.82966220E-01 5.151190280E-02 5.24259244E-02 + 6.39289252E-01 1.82996308E-01 5.157514290E-02 5.24266216E-02 + 6.39392530E-01 1.83026397E-01 5.163845170E-02 5.24273198E-02 + 6.39495808E-01 1.83056487E-01 5.170182910E-02 5.24280189E-02 + 6.39599085E-01 1.83086578E-01 5.176527530E-02 5.24287190E-02 + 6.39702363E-01 1.83116669E-01 5.182879030E-02 5.24294201E-02 + 6.39805641E-01 1.83146762E-01 5.189237410E-02 5.24301222E-02 + 6.39908919E-01 1.83176856E-01 5.195602700E-02 5.24308253E-02 + 6.40012196E-01 1.83206950E-01 5.201974880E-02 5.24315293E-02 + 6.40115474E-01 1.83237045E-01 5.208353970E-02 5.24322344E-02 + 6.40218752E-01 1.83267141E-01 5.214739980E-02 5.24329404E-02 + 6.40322030E-01 1.83297239E-01 5.221132910E-02 5.24336473E-02 + 6.40425307E-01 1.83327337E-01 5.227532770E-02 5.24343553E-02 + 6.40528585E-01 1.83357436E-01 5.233939560E-02 5.24350643E-02 + 6.40631863E-01 1.83387535E-01 5.240353300E-02 5.24357742E-02 + 6.40735141E-01 1.83417636E-01 5.246773980E-02 5.24364852E-02 + 6.40838418E-01 1.83447738E-01 5.253201620E-02 5.24371971E-02 + 6.40941696E-01 1.83477840E-01 5.259636220E-02 5.24379100E-02 + 6.41044974E-01 1.83507944E-01 5.266077790E-02 5.24386239E-02 + 6.41148252E-01 1.83538048E-01 5.272526340E-02 5.24393388E-02 + 6.41251529E-01 1.83568154E-01 5.278981870E-02 5.24400547E-02 + 6.41354807E-01 1.83598260E-01 5.285444390E-02 5.24407716E-02 + 6.41458085E-01 1.83628367E-01 5.291913900E-02 5.24414895E-02 + 6.41561363E-01 1.83658475E-01 5.298390420E-02 5.24422084E-02 + 6.41664640E-01 1.83688584E-01 5.304873950E-02 5.24429283E-02 + 6.41767918E-01 1.83718694E-01 5.311364490E-02 5.24436492E-02 + 6.41871196E-01 1.83748805E-01 5.317862060E-02 5.24443711E-02 + 6.41974474E-01 1.83778916E-01 5.324366650E-02 5.24450940E-02 + 6.42077751E-01 1.83809029E-01 5.330878290E-02 5.24458179E-02 + 6.42181029E-01 1.83839143E-01 5.337396970E-02 5.24465428E-02 + 6.42284307E-01 1.83869257E-01 5.343922690E-02 5.24472688E-02 + 6.42387585E-01 1.83899373E-01 5.350455480E-02 5.24479957E-02 + 6.42490862E-01 1.83929489E-01 5.356995330E-02 5.24487236E-02 + 6.42594140E-01 1.83959606E-01 5.363542250E-02 5.24494526E-02 + 6.42697418E-01 1.83989725E-01 5.370096250E-02 5.24501826E-02 + 6.42800696E-01 1.84019844E-01 5.376657340E-02 5.24509135E-02 + 6.42903973E-01 1.84049964E-01 5.383225510E-02 5.24516455E-02 + 6.43007251E-01 1.84080085E-01 5.389800790E-02 5.24523785E-02 + 6.43110529E-01 1.84110207E-01 5.396383170E-02 5.24531126E-02 + 6.43213807E-01 1.84140330E-01 5.402972660E-02 5.24538476E-02 + 6.43317084E-01 1.84170454E-01 5.409569280E-02 5.24545837E-02 + 6.43420362E-01 1.84200578E-01 5.416173020E-02 5.24553208E-02 + 6.43523640E-01 1.84230704E-01 5.422783890E-02 5.24560589E-02 + 6.43626917E-01 1.84260831E-01 5.429401900E-02 5.24567980E-02 + 6.43730195E-01 1.84290958E-01 5.436027060E-02 5.24575382E-02 + 6.43833473E-01 1.84321087E-01 5.442659380E-02 5.24582794E-02 + 6.43936751E-01 1.84351216E-01 5.449298850E-02 5.24590216E-02 + 6.44040028E-01 1.84381347E-01 5.455945490E-02 5.24597648E-02 + 6.44143306E-01 1.84411478E-01 5.462599310E-02 5.24605091E-02 + 6.44246584E-01 1.84441611E-01 5.469260310E-02 5.24612544E-02 + 6.44349862E-01 1.84471744E-01 5.475928500E-02 5.24620008E-02 + 6.44453139E-01 1.84501878E-01 5.482603890E-02 5.24627481E-02 + 6.44556417E-01 1.84532013E-01 5.489286470E-02 5.24634965E-02 + 6.44659695E-01 1.84562150E-01 5.495976270E-02 5.24642460E-02 + 6.44762973E-01 1.84592287E-01 5.502673280E-02 5.24649965E-02 + 6.44866250E-01 1.84622425E-01 5.509377520E-02 5.24657480E-02 + 6.44969528E-01 1.84652564E-01 5.516088990E-02 5.24665006E-02 + 6.45072806E-01 1.84682704E-01 5.522807700E-02 5.24672542E-02 + 6.45176084E-01 1.84712845E-01 5.529533650E-02 5.24680088E-02 + 6.45279361E-01 1.84742987E-01 5.536266850E-02 5.24687645E-02 + 6.45382639E-01 1.84773130E-01 5.543007310E-02 5.24695213E-02 + 6.45485917E-01 1.84803274E-01 5.549755040E-02 5.24702791E-02 + 6.45589195E-01 1.84833418E-01 5.556510040E-02 5.24710379E-02 + 6.45692472E-01 1.84863564E-01 5.563272320E-02 5.24717978E-02 + 6.45795750E-01 1.84893711E-01 5.570041890E-02 5.24725588E-02 + 6.45899028E-01 1.84923859E-01 5.576818750E-02 5.24733208E-02 + 6.46002306E-01 1.84954008E-01 5.583602920E-02 5.24740838E-02 + 6.46105583E-01 1.84984157E-01 5.590394390E-02 5.24748479E-02 + 6.46208861E-01 1.85014308E-01 5.597193170E-02 5.24756131E-02 + 6.46312139E-01 1.85044460E-01 5.603999280E-02 5.24763793E-02 + 6.46415417E-01 1.85074612E-01 5.610812720E-02 5.24771466E-02 + 6.46518694E-01 1.85104766E-01 5.617633500E-02 5.24779149E-02 + 6.46621972E-01 1.85134920E-01 5.624461620E-02 5.24786843E-02 + 6.46725250E-01 1.85165076E-01 5.631297090E-02 5.24794548E-02 + 6.46828528E-01 1.85195233E-01 5.638139920E-02 5.24802263E-02 + 6.46931805E-01 1.85225390E-01 5.644990120E-02 5.24809989E-02 + 6.47035083E-01 1.85255549E-01 5.651847680E-02 5.24817726E-02 + 6.47138361E-01 1.85285708E-01 5.658712630E-02 5.24825473E-02 + 6.47241639E-01 1.85315869E-01 5.665584960E-02 5.24833231E-02 + 6.47344916E-01 1.85346030E-01 5.672464690E-02 5.24841000E-02 + 6.47448194E-01 1.85376193E-01 5.679351820E-02 5.24848779E-02 + 6.47551472E-01 1.85406356E-01 5.686246360E-02 5.24856569E-02 + 6.47654750E-01 1.85436521E-01 5.693148310E-02 5.24864370E-02 + 6.47758027E-01 1.85466686E-01 5.700057680E-02 5.24872182E-02 + 6.47861305E-01 1.85496853E-01 5.706974490E-02 5.24880004E-02 + 6.47964583E-01 1.85527020E-01 5.713898730E-02 5.24887838E-02 + 6.48067861E-01 1.85557189E-01 5.720830420E-02 5.24895682E-02 + 6.48171138E-01 1.85587358E-01 5.727769550E-02 5.24903537E-02 + 6.48274416E-01 1.85617528E-01 5.734716150E-02 5.24911402E-02 + 6.48377694E-01 1.85647700E-01 5.741670210E-02 5.24919279E-02 + 6.48480972E-01 1.85677872E-01 5.748631750E-02 5.24927167E-02 + 6.48584249E-01 1.85708046E-01 5.755600760E-02 5.24935065E-02 + 6.48687527E-01 1.85738220E-01 5.762577270E-02 5.24942974E-02 + 6.48790805E-01 1.85768396E-01 5.769561270E-02 5.24950894E-02 + 6.48894083E-01 1.85798572E-01 5.776552770E-02 5.24958825E-02 + 6.48997360E-01 1.85828750E-01 5.783551780E-02 5.24966767E-02 + 6.49100638E-01 1.85858929E-01 5.790558300E-02 5.24974720E-02 + 6.49203916E-01 1.85889108E-01 5.797572350E-02 5.24982684E-02 + 6.49307194E-01 1.85919289E-01 5.804593940E-02 5.24990659E-02 + 6.49410471E-01 1.85949470E-01 5.811623060E-02 5.24998645E-02 + 6.49513749E-01 1.85979653E-01 5.818659730E-02 5.25006641E-02 + 6.49617027E-01 1.86009836E-01 5.825703950E-02 5.25014649E-02 + 6.49720305E-01 1.86040021E-01 5.832755730E-02 5.25022668E-02 + 6.49823582E-01 1.86070207E-01 5.839815080E-02 5.25030698E-02 + 6.49926860E-01 1.86100394E-01 5.846882000E-02 5.25038739E-02 + 6.50030138E-01 1.86130581E-01 5.853956510E-02 5.25046791E-02 + 6.50133416E-01 1.86160770E-01 5.861038600E-02 5.25054854E-02 + 6.50236693E-01 1.86190960E-01 5.868128300E-02 5.25062928E-02 + 6.50339971E-01 1.86221151E-01 5.875225600E-02 5.25071013E-02 + 6.50443249E-01 1.86251342E-01 5.882330510E-02 5.25079110E-02 + 6.50546527E-01 1.86281535E-01 5.889443040E-02 5.25087217E-02 + 6.50649804E-01 1.86311729E-01 5.896563190E-02 5.25095336E-02 + 6.50753082E-01 1.86341924E-01 5.903690990E-02 5.25103466E-02 + 6.50856360E-01 1.86372120E-01 5.910826420E-02 5.25111607E-02 + 6.50959638E-01 1.86402317E-01 5.917969500E-02 5.25119759E-02 + 6.51062915E-01 1.86432515E-01 5.925120240E-02 5.25127922E-02 + 6.51166193E-01 1.86462714E-01 5.932278640E-02 5.25136097E-02 + 6.51269471E-01 1.86492915E-01 5.939444720E-02 5.25144283E-02 + 6.51372748E-01 1.86523116E-01 5.946618470E-02 5.25152480E-02 + 6.51476026E-01 1.86553318E-01 5.953799910E-02 5.25160688E-02 + 6.51579304E-01 1.86583521E-01 5.960989040E-02 5.25168908E-02 + 6.51682582E-01 1.86613726E-01 5.968185870E-02 5.25177139E-02 + 6.51785859E-01 1.86643931E-01 5.975390410E-02 5.25185381E-02 + 6.51889137E-01 1.86674137E-01 5.982602670E-02 5.25193634E-02 + 6.51992415E-01 1.86704345E-01 5.989822650E-02 5.25201899E-02 + 6.52095693E-01 1.86734553E-01 5.997050370E-02 5.25210175E-02 + 6.52198970E-01 1.86764763E-01 6.004285820E-02 5.25218463E-02 + 6.52302248E-01 1.86794974E-01 6.011529020E-02 5.25226762E-02 + 6.52405526E-01 1.86825185E-01 6.018779970E-02 5.25235072E-02 + 6.52508804E-01 1.86855398E-01 6.026038680E-02 5.25243394E-02 + 6.52612081E-01 1.86885612E-01 6.033305160E-02 5.25251727E-02 + 6.52715359E-01 1.86915827E-01 6.040579420E-02 5.25260072E-02 + 6.52818637E-01 1.86946043E-01 6.047861460E-02 5.25268428E-02 + 6.52921915E-01 1.86976260E-01 6.055151290E-02 5.25276795E-02 + 6.53025192E-01 1.87006478E-01 6.062448920E-02 5.25285174E-02 + 6.53128470E-01 1.87036697E-01 6.069754350E-02 5.25293565E-02 + 6.53231748E-01 1.87066917E-01 6.077067600E-02 5.25301966E-02 + 6.53335026E-01 1.87097139E-01 6.084388680E-02 5.25310380E-02 + 6.53438303E-01 1.87127361E-01 6.091717580E-02 5.25318805E-02 + 6.53541581E-01 1.87157585E-01 6.099054310E-02 5.25327241E-02 + 6.53644859E-01 1.87187809E-01 6.106398890E-02 5.25335689E-02 + 6.53748137E-01 1.87218035E-01 6.113751330E-02 5.25344149E-02 + 6.53851414E-01 1.87248261E-01 6.121111620E-02 5.25352620E-02 + 6.53954692E-01 1.87278489E-01 6.128479780E-02 5.25361103E-02 + 6.54057970E-01 1.87308718E-01 6.135855810E-02 5.25369597E-02 + 6.54161248E-01 1.87338948E-01 6.143239730E-02 5.25378103E-02 + 6.54264525E-01 1.87369179E-01 6.150631540E-02 5.25386621E-02 + 6.54367803E-01 1.87399411E-01 6.158031240E-02 5.25395150E-02 + 6.54471081E-01 1.87429644E-01 6.165438850E-02 5.25403691E-02 + 6.54574359E-01 1.87459878E-01 6.172854370E-02 5.25412244E-02 + 6.54677636E-01 1.87490114E-01 6.180277820E-02 5.25420809E-02 + 6.54780914E-01 1.87520350E-01 6.187709190E-02 5.25429385E-02 + 6.54884192E-01 1.87550588E-01 6.195148490E-02 5.25437973E-02 + 6.54987470E-01 1.87580826E-01 6.202595750E-02 5.25446572E-02 + 6.55090747E-01 1.87611066E-01 6.210050950E-02 5.25455184E-02 + 6.55194025E-01 1.87641307E-01 6.217514110E-02 5.25463807E-02 + 6.55297303E-01 1.87671549E-01 6.224985240E-02 5.25472442E-02 + 6.55400581E-01 1.87701792E-01 6.232464340E-02 5.25481088E-02 + 6.55503858E-01 1.87732036E-01 6.239951420E-02 5.25489747E-02 + 6.55607136E-01 1.87762281E-01 6.247446500E-02 5.25498417E-02 + 6.55710414E-01 1.87792528E-01 6.254949570E-02 5.25507099E-02 + 6.55813692E-01 1.87822775E-01 6.262460650E-02 5.25515793E-02 + 6.55916969E-01 1.87853024E-01 6.269979740E-02 5.25524499E-02 + 6.56020247E-01 1.87883273E-01 6.277506850E-02 5.25533217E-02 + 6.56123525E-01 1.87913524E-01 6.285041990E-02 5.25541947E-02 + 6.56226803E-01 1.87943776E-01 6.292585160E-02 5.25550689E-02 + 6.56330080E-01 1.87974029E-01 6.300136390E-02 5.25559442E-02 + 6.56433358E-01 1.88004283E-01 6.307695660E-02 5.25568208E-02 + 6.56536636E-01 1.88034538E-01 6.315262990E-02 5.25576985E-02 + 6.56639914E-01 1.88064795E-01 6.322838390E-02 5.25585775E-02 + 6.56743191E-01 1.88095052E-01 6.330421870E-02 5.25594576E-02 + 6.56846469E-01 1.88125311E-01 6.338013430E-02 5.25603390E-02 + 6.56949747E-01 1.88155571E-01 6.345613080E-02 5.25612215E-02 + 6.57053025E-01 1.88185831E-01 6.353220830E-02 5.25621053E-02 + 6.57156302E-01 1.88216093E-01 6.360836680E-02 5.25629902E-02 + 6.57259580E-01 1.88246357E-01 6.368460660E-02 5.25638764E-02 + 6.57362858E-01 1.88276621E-01 6.376092750E-02 5.25647638E-02 + 6.57466136E-01 1.88306886E-01 6.383732970E-02 5.25656524E-02 + 6.57569413E-01 1.88337153E-01 6.391381340E-02 5.25665422E-02 + 6.57672691E-01 1.88367420E-01 6.399037840E-02 5.25674332E-02 + 6.57775969E-01 1.88397689E-01 6.406702510E-02 5.25683254E-02 + 6.57879247E-01 1.88427959E-01 6.414375330E-02 5.25692188E-02 + 6.57982524E-01 1.88458230E-01 6.422056330E-02 5.25701135E-02 + 6.58085802E-01 1.88488502E-01 6.429745500E-02 5.25710093E-02 + 6.58189080E-01 1.88518775E-01 6.437442860E-02 5.25719064E-02 + 6.58292358E-01 1.88549050E-01 6.445148410E-02 5.25728048E-02 + 6.58395635E-01 1.88579325E-01 6.452862170E-02 5.25737043E-02 + 6.58498913E-01 1.88609602E-01 6.460584130E-02 5.25746051E-02 + 6.58602191E-01 1.88639880E-01 6.468314310E-02 5.25755071E-02 + 6.58705469E-01 1.88670159E-01 6.476052720E-02 5.25764103E-02 + 6.58808746E-01 1.88700439E-01 6.483799360E-02 5.25773147E-02 + 6.58912024E-01 1.88730721E-01 6.491554240E-02 5.25782204E-02 + 6.59015302E-01 1.88761003E-01 6.499317370E-02 5.25791273E-02 + 6.59118579E-01 1.88791287E-01 6.507088760E-02 5.25800355E-02 + 6.59221857E-01 1.88821572E-01 6.514868410E-02 5.25809448E-02 + 6.59325135E-01 1.88851858E-01 6.522656340E-02 5.25818555E-02 + 6.59428413E-01 1.88882145E-01 6.530452550E-02 5.25827673E-02 + 6.59531690E-01 1.88912433E-01 6.538257050E-02 5.25836804E-02 + 6.59634968E-01 1.88942722E-01 6.546069840E-02 5.25845947E-02 + 6.59738246E-01 1.88973013E-01 6.553890940E-02 5.25855103E-02 + 6.59841524E-01 1.89003305E-01 6.561720360E-02 5.25864271E-02 + 6.59944801E-01 1.89033598E-01 6.569558100E-02 5.25873452E-02 + 6.60048079E-01 1.89063892E-01 6.577404160E-02 5.25882645E-02 + 6.60151357E-01 1.89094187E-01 6.585258570E-02 5.25891851E-02 + 6.60254635E-01 1.89124484E-01 6.593121320E-02 5.25901069E-02 + 6.60357912E-01 1.89154781E-01 6.600992420E-02 5.25910300E-02 + 6.60461190E-01 1.89185080E-01 6.608871890E-02 5.25919543E-02 + 6.60564468E-01 1.89215380E-01 6.616759730E-02 5.25928799E-02 + 6.60667746E-01 1.89245681E-01 6.624655940E-02 5.25938067E-02 + 6.60771023E-01 1.89275984E-01 6.632560540E-02 5.25947348E-02 + 6.60874301E-01 1.89306287E-01 6.640473540E-02 5.25956642E-02 + 6.60977579E-01 1.89336592E-01 6.648394940E-02 5.25965948E-02 + 6.61080857E-01 1.89366898E-01 6.656324750E-02 5.25975267E-02 + 6.61184134E-01 1.89397205E-01 6.664262980E-02 5.25984598E-02 + 6.61287412E-01 1.89427513E-01 6.672209630E-02 5.25993942E-02 + 6.61390690E-01 1.89457822E-01 6.680164730E-02 5.26003299E-02 + 6.61493968E-01 1.89488133E-01 6.688128260E-02 5.26012668E-02 + 6.61597245E-01 1.89518445E-01 6.696100250E-02 5.26022051E-02 + 6.61700523E-01 1.89548758E-01 6.704080690E-02 5.26031446E-02 + 6.61803801E-01 1.89579072E-01 6.712069610E-02 5.26040853E-02 + 6.61907079E-01 1.89609388E-01 6.720067000E-02 5.26050274E-02 + 6.62010356E-01 1.89639704E-01 6.728072870E-02 5.26059707E-02 + 6.62113634E-01 1.89670022E-01 6.736087240E-02 5.26069153E-02 + 6.62216912E-01 1.89700341E-01 6.744110110E-02 5.26078612E-02 + 6.62320190E-01 1.89730661E-01 6.752141490E-02 5.26088083E-02 + 6.62423467E-01 1.89760983E-01 6.760181390E-02 5.26097567E-02 + 6.62526745E-01 1.89791305E-01 6.768229810E-02 5.26107065E-02 + 6.62630023E-01 1.89821629E-01 6.776286760E-02 5.26116575E-02 + 6.62733301E-01 1.89851954E-01 6.784352260E-02 5.26126098E-02 + 6.62836578E-01 1.89882280E-01 6.792426310E-02 5.26135634E-02 + 6.62939856E-01 1.89912608E-01 6.800508920E-02 5.26145183E-02 + 6.63043134E-01 1.89942937E-01 6.808600090E-02 5.26154744E-02 + 6.63146412E-01 1.89973267E-01 6.816699840E-02 5.26164319E-02 + 6.63249689E-01 1.90003598E-01 6.824808180E-02 5.26173907E-02 + 6.63352967E-01 1.90033930E-01 6.832925100E-02 5.26183507E-02 + 6.63456245E-01 1.90064264E-01 6.841050630E-02 5.26193121E-02 + 6.63559523E-01 1.90094598E-01 6.849184760E-02 5.26202748E-02 + 6.63662800E-01 1.90124934E-01 6.857327510E-02 5.26212387E-02 + 6.63766078E-01 1.90155272E-01 6.865478890E-02 5.26222040E-02 + 6.63869356E-01 1.90185610E-01 6.873638900E-02 5.26231706E-02 + 6.63972634E-01 1.90215950E-01 6.881807560E-02 5.26241385E-02 + 6.64075911E-01 1.90246291E-01 6.889984860E-02 5.26251077E-02 + 6.64179189E-01 1.90276633E-01 6.898170820E-02 5.26260782E-02 + 6.64282467E-01 1.90306976E-01 6.906365450E-02 5.26270500E-02 + 6.64385745E-01 1.90337321E-01 6.914568760E-02 5.26280231E-02 + 6.64489022E-01 1.90367667E-01 6.922780750E-02 5.26289975E-02 + 6.64592300E-01 1.90398014E-01 6.931001430E-02 5.26299733E-02 + 6.64695578E-01 1.90428362E-01 6.939230820E-02 5.26309504E-02 + 6.64798856E-01 1.90458712E-01 6.947468910E-02 5.26319288E-02 + 6.64902133E-01 1.90489063E-01 6.955715720E-02 5.26329085E-02 + 6.65005411E-01 1.90519415E-01 6.963971260E-02 5.26338896E-02 + 6.65108689E-01 1.90549768E-01 6.972235530E-02 5.26348719E-02 + 6.65211967E-01 1.90580123E-01 6.980508550E-02 5.26358556E-02 + 6.65315244E-01 1.90610478E-01 6.988790310E-02 5.26368407E-02 + 6.65418522E-01 1.90640836E-01 6.997080840E-02 5.26378270E-02 + 6.65521800E-01 1.90671194E-01 7.005380140E-02 5.26388147E-02 + 6.65625078E-01 1.90701553E-01 7.013688210E-02 5.26398037E-02 + 6.65728355E-01 1.90731914E-01 7.022005070E-02 5.26407941E-02 + 6.65831633E-01 1.90762276E-01 7.030330720E-02 5.26417858E-02 + 6.65934911E-01 1.90792640E-01 7.038665180E-02 5.26427788E-02 + 6.66038189E-01 1.90823004E-01 7.047008450E-02 5.26437732E-02 + 6.66141466E-01 1.90853370E-01 7.055360540E-02 5.26447689E-02 + 6.66244744E-01 1.90883737E-01 7.063721450E-02 5.26457659E-02 + 6.66348022E-01 1.90914106E-01 7.072091210E-02 5.26467643E-02 + 6.66451300E-01 1.90944475E-01 7.080469800E-02 5.26477641E-02 + 6.66554577E-01 1.90974846E-01 7.088857260E-02 5.26487652E-02 + 6.66657855E-01 1.91005219E-01 7.097253570E-02 5.26497676E-02 + 6.66761133E-01 1.91035592E-01 7.105658760E-02 5.26507714E-02 + 6.66864410E-01 1.91065967E-01 7.114072830E-02 5.26517766E-02 + 6.66967688E-01 1.91096343E-01 7.122495780E-02 5.26527831E-02 + 6.67070966E-01 1.91126720E-01 7.130927640E-02 5.26537909E-02 + 6.67174244E-01 1.91157099E-01 7.139368390E-02 5.26548001E-02 + 6.67277521E-01 1.91187479E-01 7.147818070E-02 5.26558107E-02 + 6.67380799E-01 1.91217860E-01 7.156276660E-02 5.26568226E-02 + 6.67484077E-01 1.91248243E-01 7.164744190E-02 5.26578359E-02 + 6.67587355E-01 1.91278626E-01 7.173220660E-02 5.26588506E-02 + 6.67690632E-01 1.91309011E-01 7.181706080E-02 5.26598666E-02 + 6.67793910E-01 1.91339398E-01 7.190200450E-02 5.26608840E-02 + 6.67897188E-01 1.91369785E-01 7.198703800E-02 5.26619028E-02 + 6.68000466E-01 1.91400174E-01 7.207216110E-02 5.26629230E-02 + 6.68103743E-01 1.91430564E-01 7.215737410E-02 5.26639445E-02 + 6.68207021E-01 1.91460956E-01 7.224267710E-02 5.26649674E-02 + 6.68310299E-01 1.91491349E-01 7.232807000E-02 5.26659916E-02 + 6.68413577E-01 1.91521743E-01 7.241355310E-02 5.26670173E-02 + 6.68516854E-01 1.91552138E-01 7.249912630E-02 5.26680443E-02 + 6.68620132E-01 1.91582535E-01 7.258478980E-02 5.26690727E-02 + 6.68723410E-01 1.91612933E-01 7.267054370E-02 5.26701025E-02 + 6.68826688E-01 1.91643332E-01 7.275638800E-02 5.26711337E-02 + 6.68929965E-01 1.91673733E-01 7.284232290E-02 5.26721662E-02 + 6.69033243E-01 1.91704135E-01 7.292834840E-02 5.26732002E-02 + 6.69136521E-01 1.91734538E-01 7.301446460E-02 5.26742355E-02 + 6.69239799E-01 1.91764943E-01 7.310067160E-02 5.26752722E-02 + 6.69343076E-01 1.91795349E-01 7.318696950E-02 5.26763103E-02 + 6.69446354E-01 1.91825756E-01 7.327335840E-02 5.26773499E-02 + 6.69549632E-01 1.91856165E-01 7.335983830E-02 5.26783908E-02 + 6.69652910E-01 1.91886574E-01 7.344640940E-02 5.26794331E-02 + 6.69756187E-01 1.91916986E-01 7.353307180E-02 5.26804768E-02 + 6.69859465E-01 1.91947398E-01 7.361982540E-02 5.26815219E-02 + 6.69962743E-01 1.91977812E-01 7.370667050E-02 5.26825684E-02 + 6.70066021E-01 1.92008227E-01 7.379360720E-02 5.26836164E-02 + 6.70169298E-01 1.92038644E-01 7.388063540E-02 5.26846657E-02 + 6.70272576E-01 1.92069061E-01 7.396775530E-02 5.26857164E-02 + 6.70375854E-01 1.92099481E-01 7.405496690E-02 5.26867686E-02 + 6.70479132E-01 1.92129901E-01 7.414227050E-02 5.26878221E-02 + 6.70582409E-01 1.92160323E-01 7.422966600E-02 5.26888771E-02 + 6.70685687E-01 1.92190746E-01 7.431715350E-02 5.26899335E-02 + 6.70788965E-01 1.92221171E-01 7.440473320E-02 5.26909913E-02 + 6.70892243E-01 1.92251596E-01 7.449240510E-02 5.26920505E-02 + 6.70995520E-01 1.92282024E-01 7.458016930E-02 5.26931112E-02 + 6.71098798E-01 1.92312452E-01 7.466802590E-02 5.26941733E-02 + 6.71202076E-01 1.92342882E-01 7.475597500E-02 5.26952368E-02 + 6.71305354E-01 1.92373313E-01 7.484401670E-02 5.26963017E-02 + 6.71408631E-01 1.92403746E-01 7.493215100E-02 5.26973680E-02 + 6.71511909E-01 1.92434180E-01 7.502037820E-02 5.26984358E-02 + 6.71615187E-01 1.92464615E-01 7.510869810E-02 5.26995050E-02 + 6.71718465E-01 1.92495052E-01 7.519711100E-02 5.27005757E-02 + 6.71821742E-01 1.92525490E-01 7.528561700E-02 5.27016477E-02 + 6.71925020E-01 1.92555929E-01 7.537421610E-02 5.27027213E-02 + 6.72028298E-01 1.92586370E-01 7.546290830E-02 5.27037962E-02 + 6.72131576E-01 1.92616812E-01 7.555169390E-02 5.27048726E-02 + 6.72234853E-01 1.92647256E-01 7.564057290E-02 5.27059504E-02 + 6.72338131E-01 1.92677700E-01 7.572954540E-02 5.27070297E-02 + 6.72441409E-01 1.92708147E-01 7.581861140E-02 5.27081104E-02 + 6.72544687E-01 1.92738594E-01 7.590777110E-02 5.27091926E-02 + 6.72647964E-01 1.92769043E-01 7.599702460E-02 5.27102762E-02 + 6.72751242E-01 1.92799493E-01 7.608637190E-02 5.27113613E-02 + 6.72854520E-01 1.92829945E-01 7.617581310E-02 5.27124478E-02 + 6.72957798E-01 1.92860398E-01 7.626534840E-02 5.27135358E-02 + 6.73061075E-01 1.92890853E-01 7.635497780E-02 5.27146252E-02 + 6.73164353E-01 1.92921309E-01 7.644470140E-02 5.27157161E-02 + 6.73267631E-01 1.92951766E-01 7.653451940E-02 5.27168085E-02 + 6.73370909E-01 1.92982224E-01 7.662443170E-02 5.27179023E-02 + 6.73474186E-01 1.93012684E-01 7.671443850E-02 5.27189976E-02 + 6.73577464E-01 1.93043146E-01 7.680453990E-02 5.27200943E-02 + 6.73680742E-01 1.93073609E-01 7.689473600E-02 5.27211925E-02 + 6.73784020E-01 1.93104073E-01 7.698502680E-02 5.27222922E-02 + 6.73887297E-01 1.93134538E-01 7.707541250E-02 5.27233933E-02 + 6.73990575E-01 1.93165005E-01 7.716589310E-02 5.27244959E-02 + 6.74093853E-01 1.93195474E-01 7.725646880E-02 5.27256000E-02 + 6.74197131E-01 1.93225943E-01 7.734713960E-02 5.27267056E-02 + 6.74300408E-01 1.93256415E-01 7.743790560E-02 5.27278127E-02 + 6.74403686E-01 1.93286887E-01 7.752876700E-02 5.27289212E-02 + 6.74506964E-01 1.93317361E-01 7.761972370E-02 5.27300312E-02 + 6.74610242E-01 1.93347836E-01 7.771077600E-02 5.27311427E-02 + 6.74713519E-01 1.93378313E-01 7.780192390E-02 5.27322556E-02 + 6.74816797E-01 1.93408791E-01 7.789316740E-02 5.27333701E-02 + 6.74920075E-01 1.93439271E-01 7.798450680E-02 5.27344860E-02 + 6.75023352E-01 1.93469752E-01 7.807594200E-02 5.27356035E-02 + 6.75126630E-01 1.93500235E-01 7.816747320E-02 5.27367224E-02 + 6.75229908E-01 1.93530718E-01 7.825910040E-02 5.27378428E-02 + 6.75333186E-01 1.93561204E-01 7.835082380E-02 5.27389648E-02 + 6.75436463E-01 1.93591690E-01 7.844264350E-02 5.27400882E-02 + 6.75539741E-01 1.93622179E-01 7.853455940E-02 5.27412131E-02 + 6.75643019E-01 1.93652668E-01 7.862657190E-02 5.27423395E-02 + 6.75746297E-01 1.93683159E-01 7.871868080E-02 5.27434674E-02 + 6.75849574E-01 1.93713651E-01 7.881088640E-02 5.27445968E-02 + 6.75952852E-01 1.93744145E-01 7.890318870E-02 5.27457278E-02 + 6.76056130E-01 1.93774641E-01 7.899558780E-02 5.27468602E-02 + 6.76159408E-01 1.93805137E-01 7.908808390E-02 5.27479942E-02 + 6.76262685E-01 1.93835635E-01 7.918067690E-02 5.27491296E-02 + 6.76365963E-01 1.93866135E-01 7.927336700E-02 5.27502666E-02 + 6.76469241E-01 1.93896636E-01 7.936615430E-02 5.27514051E-02 + 6.76572519E-01 1.93927139E-01 7.945903890E-02 5.27525451E-02 + 6.76675796E-01 1.93957642E-01 7.955202080E-02 5.27536866E-02 + 6.76779074E-01 1.93988148E-01 7.964510030E-02 5.27548297E-02 + 6.76882352E-01 1.94018655E-01 7.973827730E-02 5.27559742E-02 + 6.76985630E-01 1.94049163E-01 7.983155200E-02 5.27571203E-02 + 6.77088907E-01 1.94079673E-01 7.992492440E-02 5.27582680E-02 + 6.77192185E-01 1.94110184E-01 8.001839470E-02 5.27594171E-02 + 6.77295463E-01 1.94140696E-01 8.011196290E-02 5.27605678E-02 + 6.77398741E-01 1.94171210E-01 8.020562920E-02 5.27617200E-02 + 6.77502018E-01 1.94201726E-01 8.029939360E-02 5.27628738E-02 + 6.77605296E-01 1.94232243E-01 8.039325620E-02 5.27640290E-02 + 6.77708574E-01 1.94262761E-01 8.048721720E-02 5.27651859E-02 + 6.77811852E-01 1.94293281E-01 8.058127660E-02 5.27663442E-02 + 6.77915129E-01 1.94323803E-01 8.067543450E-02 5.27675041E-02 + 6.78018407E-01 1.94354326E-01 8.076969110E-02 5.27686656E-02 + 6.78121685E-01 1.94384850E-01 8.086404630E-02 5.27698286E-02 + 6.78224963E-01 1.94415376E-01 8.095850040E-02 5.27709931E-02 + 6.78328240E-01 1.94445903E-01 8.105305340E-02 5.27721592E-02 + 6.78431518E-01 1.94476432E-01 8.114770530E-02 5.27733268E-02 + 6.78534796E-01 1.94506962E-01 8.124245640E-02 5.27744960E-02 + 6.78638074E-01 1.94537494E-01 8.133730670E-02 5.27756668E-02 + 6.78741351E-01 1.94568027E-01 8.143225620E-02 5.27768391E-02 + 6.78844629E-01 1.94598562E-01 8.152730520E-02 5.27780130E-02 + 6.78947907E-01 1.94629098E-01 8.162245360E-02 5.27791884E-02 + 6.79051185E-01 1.94659635E-01 8.171770160E-02 5.27803654E-02 + 6.79154462E-01 1.94690175E-01 8.181304930E-02 5.27815439E-02 + 6.79257740E-01 1.94720715E-01 8.190849680E-02 5.27827240E-02 + 6.79361018E-01 1.94751257E-01 8.200404410E-02 5.27839057E-02 + 6.79464296E-01 1.94781801E-01 8.209969140E-02 5.27850890E-02 + 6.79567573E-01 1.94812346E-01 8.219543880E-02 5.27862738E-02 + 6.79670851E-01 1.94842893E-01 8.229128630E-02 5.27874602E-02 + 6.79774129E-01 1.94873441E-01 8.238723410E-02 5.27886482E-02 + 6.79877407E-01 1.94903991E-01 8.248328230E-02 5.27898378E-02 + 6.79980684E-01 1.94934542E-01 8.257943090E-02 5.27910289E-02 + 6.80083962E-01 1.94965094E-01 8.267568010E-02 5.27922216E-02 + 6.80187240E-01 1.94995648E-01 8.277202990E-02 5.27934159E-02 + 6.80290518E-01 1.95026204E-01 8.286848050E-02 5.27946118E-02 + 6.80393795E-01 1.95056761E-01 8.296503190E-02 5.27958093E-02 + 6.80497073E-01 1.95087320E-01 8.306168430E-02 5.27970083E-02 + 6.80600351E-01 1.95117880E-01 8.315843780E-02 5.27982090E-02 + 6.80703629E-01 1.95148442E-01 8.325529230E-02 5.27994112E-02 + 6.80806906E-01 1.95179005E-01 8.335224810E-02 5.28006151E-02 + 6.80910184E-01 1.95209570E-01 8.344930530E-02 5.28018205E-02 + 6.81013462E-01 1.95240136E-01 8.354646390E-02 5.28030276E-02 + 6.81116740E-01 1.95270704E-01 8.364372400E-02 5.28042362E-02 + 6.81220017E-01 1.95301273E-01 8.374108580E-02 5.28054464E-02 + 6.81323295E-01 1.95331844E-01 8.383854930E-02 5.28066583E-02 + 6.81426573E-01 1.95362417E-01 8.393611470E-02 5.28078717E-02 + 6.81529851E-01 1.95392991E-01 8.403378200E-02 5.28090868E-02 + 6.81633128E-01 1.95423566E-01 8.413155130E-02 5.28103035E-02 + 6.81736406E-01 1.95454143E-01 8.422942280E-02 5.28115218E-02 + 6.81839684E-01 1.95484722E-01 8.432739650E-02 5.28127417E-02 + 6.81942962E-01 1.95515302E-01 8.442547250E-02 5.28139632E-02 + 6.82046239E-01 1.95545884E-01 8.452365090E-02 5.28151863E-02 + 6.82149517E-01 1.95576467E-01 8.462193190E-02 5.28164111E-02 + 6.82252795E-01 1.95607052E-01 8.472031560E-02 5.28176375E-02 + 6.82356073E-01 1.95637638E-01 8.481880190E-02 5.28188655E-02 + 6.82459350E-01 1.95668226E-01 8.491739110E-02 5.28200951E-02 + 6.82562628E-01 1.95698815E-01 8.501608330E-02 5.28213263E-02 + 6.82665906E-01 1.95729406E-01 8.511487840E-02 5.28225592E-02 + 6.82769183E-01 1.95759999E-01 8.521377680E-02 5.28237937E-02 + 6.82872461E-01 1.95790593E-01 8.531277830E-02 5.28250299E-02 + 6.82975739E-01 1.95821188E-01 8.541188320E-02 5.28262677E-02 + 6.83079017E-01 1.95851786E-01 8.551109150E-02 5.28275071E-02 + 6.83182294E-01 1.95882384E-01 8.561040330E-02 5.28287482E-02 + 6.83285572E-01 1.95912985E-01 8.570981880E-02 5.28299909E-02 + 6.83388850E-01 1.95943587E-01 8.580933810E-02 5.28312353E-02 + 6.83492128E-01 1.95974190E-01 8.590896120E-02 5.28324813E-02 + 6.83595405E-01 1.96004795E-01 8.600868820E-02 5.28337289E-02 + 6.83698683E-01 1.96035402E-01 8.610851920E-02 5.28349782E-02 + 6.83801961E-01 1.96066010E-01 8.620845450E-02 5.28362292E-02 + 6.83905239E-01 1.96096620E-01 8.630849390E-02 5.28374818E-02 + 6.84008516E-01 1.96127231E-01 8.640863770E-02 5.28387360E-02 + 6.84111794E-01 1.96157844E-01 8.650888600E-02 5.28399919E-02 + 6.84215072E-01 1.96188459E-01 8.660923880E-02 5.28412495E-02 + 6.84318350E-01 1.96219075E-01 8.670969630E-02 5.28425088E-02 + 6.84421627E-01 1.96249693E-01 8.681025850E-02 5.28437697E-02 + 6.84524905E-01 1.96280312E-01 8.691092560E-02 5.28450322E-02 + 6.84628183E-01 1.96310933E-01 8.701169760E-02 5.28462965E-02 + 6.84731461E-01 1.96341556E-01 8.711257470E-02 5.28475624E-02 + 6.84834738E-01 1.96372180E-01 8.721355700E-02 5.28488300E-02 + 6.84938016E-01 1.96402806E-01 8.731464460E-02 5.28500992E-02 + 6.85041294E-01 1.96433433E-01 8.741583750E-02 5.28513702E-02 + 6.85144572E-01 1.96464062E-01 8.751713590E-02 5.28526428E-02 + 6.85247849E-01 1.96494692E-01 8.761853990E-02 5.28539171E-02 + 6.85351127E-01 1.96525325E-01 8.772004950E-02 5.28551931E-02 + 6.85454405E-01 1.96555958E-01 8.782166500E-02 5.28564707E-02 + 6.85557683E-01 1.96586594E-01 8.792338630E-02 5.28577501E-02 + 6.85660960E-01 1.96617231E-01 8.802521370E-02 5.28590311E-02 + 6.85764238E-01 1.96647869E-01 8.812714710E-02 5.28603138E-02 + 6.85867516E-01 1.96678510E-01 8.822918670E-02 5.28615982E-02 + 6.85970794E-01 1.96709151E-01 8.833133260E-02 5.28628844E-02 + 6.86074071E-01 1.96739795E-01 8.843358500E-02 5.28641722E-02 + 6.86177349E-01 1.96770440E-01 8.853594380E-02 5.28654617E-02 + 6.86280627E-01 1.96801087E-01 8.863840930E-02 5.28667529E-02 + 6.86383905E-01 1.96831735E-01 8.874098140E-02 5.28680458E-02 + 6.86487182E-01 1.96862385E-01 8.884366040E-02 5.28693404E-02 + 6.86590460E-01 1.96893037E-01 8.894644640E-02 5.28706367E-02 + 6.86693738E-01 1.96923690E-01 8.904933930E-02 5.28719348E-02 + 6.86797016E-01 1.96954345E-01 8.915233940E-02 5.28732345E-02 + 6.86900293E-01 1.96985002E-01 8.925544680E-02 5.28745360E-02 + 6.87003571E-01 1.97015660E-01 8.935866140E-02 5.28758392E-02 + 6.87106849E-01 1.97046320E-01 8.946198360E-02 5.28771440E-02 + 6.87210127E-01 1.97076981E-01 8.956541330E-02 5.28784507E-02 + 6.87313404E-01 1.97107644E-01 8.966895060E-02 5.28797590E-02 + 6.87416682E-01 1.97138309E-01 8.977259580E-02 5.28810690E-02 + 6.87519960E-01 1.97168976E-01 8.987634870E-02 5.28823808E-02 + 6.87623238E-01 1.97199644E-01 8.998020970E-02 5.28836943E-02 + 6.87726515E-01 1.97230313E-01 9.008417880E-02 5.28850096E-02 + 6.87829793E-01 1.97260985E-01 9.018825600E-02 5.28863265E-02 + 6.87933071E-01 1.97291658E-01 9.029244160E-02 5.28876453E-02 + 6.88036349E-01 1.97322333E-01 9.039673550E-02 5.28889657E-02 + 6.88139626E-01 1.97353009E-01 9.050113800E-02 5.28902879E-02 + 6.88242904E-01 1.97383687E-01 9.060564900E-02 5.28916118E-02 + 6.88346182E-01 1.97414367E-01 9.071026880E-02 5.28929375E-02 + 6.88449460E-01 1.97445048E-01 9.081499740E-02 5.28942649E-02 + 6.88552737E-01 1.97475732E-01 9.091983490E-02 5.28955940E-02 + 6.88656015E-01 1.97506416E-01 9.102478150E-02 5.28969249E-02 + 6.88759293E-01 1.97537103E-01 9.112983720E-02 5.28982576E-02 + 6.88862571E-01 1.97567791E-01 9.123500220E-02 5.28995920E-02 + 6.88965848E-01 1.97598481E-01 9.134027660E-02 5.29009281E-02 + 6.89069126E-01 1.97629172E-01 9.144566040E-02 5.29022661E-02 + 6.89172404E-01 1.97659865E-01 9.155115370E-02 5.29036057E-02 + 6.89275682E-01 1.97690560E-01 9.165675680E-02 5.29049472E-02 + 6.89378959E-01 1.97721257E-01 9.176246970E-02 5.29062904E-02 + 6.89482237E-01 1.97751955E-01 9.186829240E-02 5.29076354E-02 + 6.89585515E-01 1.97782655E-01 9.197422510E-02 5.29089821E-02 + 6.89688793E-01 1.97813357E-01 9.208026800E-02 5.29103306E-02 + 6.89792070E-01 1.97844060E-01 9.218642110E-02 5.29116809E-02 + 6.89895348E-01 1.97874765E-01 9.229268450E-02 5.29130329E-02 + 6.89998626E-01 1.97905472E-01 9.239905830E-02 5.29143868E-02 + 6.90101904E-01 1.97936181E-01 9.250554270E-02 5.29157424E-02 + 6.90205181E-01 1.97966891E-01 9.261213770E-02 5.29170998E-02 + 6.90308459E-01 1.97997603E-01 9.271884350E-02 5.29184589E-02 + 6.90411737E-01 1.98028316E-01 9.282566020E-02 5.29198199E-02 + 6.90515014E-01 1.98059032E-01 9.293258780E-02 5.29211826E-02 + 6.90618292E-01 1.98089749E-01 9.303962660E-02 5.29225472E-02 + 6.90721570E-01 1.98120468E-01 9.314677650E-02 5.29239135E-02 + 6.90824848E-01 1.98151188E-01 9.325403770E-02 5.29252816E-02 + 6.90928125E-01 1.98181910E-01 9.336141040E-02 5.29266515E-02 + 6.91031403E-01 1.98212634E-01 9.346889450E-02 5.29280233E-02 + 6.91134681E-01 1.98243360E-01 9.357649030E-02 5.29293968E-02 + 6.91237959E-01 1.98274087E-01 9.368419780E-02 5.29307721E-02 + 6.91341236E-01 1.98304817E-01 9.379201720E-02 5.29321492E-02 + 6.91444514E-01 1.98335547E-01 9.389994860E-02 5.29335281E-02 + 6.91547792E-01 1.98366280E-01 9.400799200E-02 5.29349089E-02 + 6.91651070E-01 1.98397014E-01 9.411614760E-02 5.29362914E-02 + 6.91754347E-01 1.98427751E-01 9.422441550E-02 5.29376758E-02 + 6.91857625E-01 1.98458488E-01 9.433279570E-02 5.29390620E-02 + 6.91960903E-01 1.98489228E-01 9.444128850E-02 5.29404500E-02 + 6.92064181E-01 1.98519969E-01 9.454989390E-02 5.29418398E-02 + 6.92167458E-01 1.98550712E-01 9.465861210E-02 5.29432314E-02 + 6.92270736E-01 1.98581457E-01 9.476744310E-02 5.29446249E-02 + 6.92374014E-01 1.98612204E-01 9.487638700E-02 5.29460202E-02 + 6.92477292E-01 1.98642952E-01 9.498544400E-02 5.29474173E-02 + 6.92580569E-01 1.98673702E-01 9.509461420E-02 5.29488162E-02 + 6.92683847E-01 1.98704454E-01 9.520389770E-02 5.29502170E-02 + 6.92787125E-01 1.98735208E-01 9.531329450E-02 5.29516196E-02 + 6.92890403E-01 1.98765963E-01 9.542280490E-02 5.29530241E-02 + 6.92993680E-01 1.98796721E-01 9.553242890E-02 5.29544304E-02 + 6.93096958E-01 1.98827480E-01 9.564216660E-02 5.29558385E-02 + 6.93200236E-01 1.98858240E-01 9.575201810E-02 5.29572485E-02 + 6.93303514E-01 1.98889003E-01 9.586198370E-02 5.29586603E-02 + 6.93406791E-01 1.98919767E-01 9.597206320E-02 5.29600740E-02 + 6.93510069E-01 1.98950533E-01 9.608225700E-02 5.29614895E-02 + 6.93613347E-01 1.98981301E-01 9.619256500E-02 5.29629069E-02 + 6.93716625E-01 1.99012071E-01 9.630298750E-02 5.29643261E-02 + 6.93819902E-01 1.99042842E-01 9.641352440E-02 5.29657472E-02 + 6.93923180E-01 1.99073615E-01 9.652417600E-02 5.29671702E-02 + 6.94026458E-01 1.99104390E-01 9.663494240E-02 5.29685950E-02 + 6.94129736E-01 1.99135167E-01 9.674582360E-02 5.29700217E-02 + 6.94233013E-01 1.99165946E-01 9.685681970E-02 5.29714502E-02 + 6.94336291E-01 1.99196726E-01 9.696793090E-02 5.29728806E-02 + 6.94439569E-01 1.99227508E-01 9.707915730E-02 5.29743129E-02 + 6.94542847E-01 1.99258292E-01 9.719049910E-02 5.29757471E-02 + 6.94646124E-01 1.99289078E-01 9.730195620E-02 5.29771831E-02 + 6.94749402E-01 1.99319866E-01 9.741352890E-02 5.29786210E-02 + 6.94852680E-01 1.99350655E-01 9.752521720E-02 5.29800608E-02 + 6.94955958E-01 1.99381446E-01 9.763702130E-02 5.29815025E-02 + 6.95059235E-01 1.99412239E-01 9.774894120E-02 5.29829460E-02 + 6.95162513E-01 1.99443034E-01 9.786097720E-02 5.29843915E-02 + 6.95265791E-01 1.99473831E-01 9.797312920E-02 5.29858388E-02 + 6.95369069E-01 1.99504630E-01 9.808539740E-02 5.29872880E-02 + 6.95472346E-01 1.99535430E-01 9.819778200E-02 5.29887391E-02 + 6.95575624E-01 1.99566232E-01 9.831028300E-02 5.29901922E-02 + 6.95678902E-01 1.99597036E-01 9.842290060E-02 5.29916471E-02 + 6.95782180E-01 1.99627842E-01 9.853563490E-02 5.29931039E-02 + 6.95885457E-01 1.99658649E-01 9.864848590E-02 5.29945626E-02 + 6.95988735E-01 1.99689459E-01 9.876145390E-02 5.29960232E-02 + 6.96092013E-01 1.99720270E-01 9.887453880E-02 5.29974858E-02 + 6.96195291E-01 1.99751083E-01 9.898774090E-02 5.29989502E-02 + 6.96298568E-01 1.99781898E-01 9.910106030E-02 5.30004166E-02 + 6.96401846E-01 1.99812715E-01 9.921449700E-02 5.30018848E-02 + 6.96505124E-01 1.99843534E-01 9.932805110E-02 5.30033550E-02 + 6.96608402E-01 1.99874355E-01 9.944172290E-02 5.30048271E-02 + 6.96711679E-01 1.99905177E-01 9.955551240E-02 5.30063011E-02 + 6.96814957E-01 1.99936001E-01 9.966941970E-02 5.30077771E-02 + 6.96918235E-01 1.99966827E-01 9.978344500E-02 5.30092549E-02 + 6.97021513E-01 1.99997655E-01 9.989758830E-02 5.30107347E-02 + 6.97124790E-01 2.00028485E-01 1.000118500E-01 5.30122165E-02 + 6.97228068E-01 2.00059317E-01 1.001262300E-01 5.30137001E-02 + 6.97331346E-01 2.00090150E-01 1.002407280E-01 5.30151857E-02 + 6.97434624E-01 2.00120986E-01 1.003553440E-01 5.30166733E-02 + 6.97537901E-01 2.00151823E-01 1.004700800E-01 5.30181628E-02 + 6.97641179E-01 2.00182662E-01 1.005849340E-01 5.30196542E-02 + 6.97744457E-01 2.00213503E-01 1.006999070E-01 5.30211475E-02 + 6.97847735E-01 2.00244346E-01 1.008149990E-01 5.30226429E-02 + 6.97951012E-01 2.00275191E-01 1.009302100E-01 5.30241401E-02 + 6.98054290E-01 2.00306038E-01 1.010455400E-01 5.30256393E-02 + 6.98157568E-01 2.00336886E-01 1.011609900E-01 5.30271405E-02 + 6.98260845E-01 2.00367737E-01 1.012765590E-01 5.30286436E-02 + 6.98364123E-01 2.00398589E-01 1.013922480E-01 5.30301487E-02 + 6.98467401E-01 2.00429443E-01 1.015080560E-01 5.30316557E-02 + 6.98570679E-01 2.00460300E-01 1.016239840E-01 5.30331647E-02 + 6.98673956E-01 2.00491158E-01 1.017400320E-01 5.30346757E-02 + 6.98777234E-01 2.00522018E-01 1.018562010E-01 5.30361887E-02 + 6.98880512E-01 2.00552879E-01 1.019724890E-01 5.30377036E-02 + 6.98983790E-01 2.00583743E-01 1.020888980E-01 5.30392204E-02 + 6.99087067E-01 2.00614609E-01 1.022054270E-01 5.30407393E-02 + 6.99190345E-01 2.00645476E-01 1.023220760E-01 5.30422601E-02 + 6.99293623E-01 2.00676346E-01 1.024388460E-01 5.30437829E-02 + 6.99396901E-01 2.00707217E-01 1.025557370E-01 5.30453077E-02 + 6.99500178E-01 2.00738090E-01 1.026727490E-01 5.30468345E-02 + 6.99603456E-01 2.00768966E-01 1.027898820E-01 5.30483633E-02 + 6.99706734E-01 2.00799843E-01 1.029071360E-01 5.30498941E-02 + 6.99810012E-01 2.00830722E-01 1.030245110E-01 5.30514268E-02 + 6.99913289E-01 2.00861603E-01 1.031420080E-01 5.30529616E-02 + 7.00016567E-01 2.00892486E-01 1.032596260E-01 5.30544983E-02 + 7.00119845E-01 2.00923371E-01 1.033773660E-01 5.30560370E-02 + 7.00223123E-01 2.00954257E-01 1.034952270E-01 5.30575778E-02 + 7.00326400E-01 2.00985146E-01 1.036132100E-01 5.30591205E-02 + 7.00429678E-01 2.01016037E-01 1.037313160E-01 5.30606653E-02 + 7.00532956E-01 2.01046929E-01 1.038495430E-01 5.30622120E-02 + 7.00636234E-01 2.01077824E-01 1.039678920E-01 5.30637608E-02 + 7.00739511E-01 2.01108720E-01 1.040863640E-01 5.30653116E-02 + 7.00842789E-01 2.01139619E-01 1.042049580E-01 5.30668644E-02 + 7.00946067E-01 2.01170519E-01 1.043236750E-01 5.30684192E-02 + 7.01049345E-01 2.01201421E-01 1.044425150E-01 5.30699761E-02 + 7.01152622E-01 2.01232326E-01 1.045614770E-01 5.30715349E-02 + 7.01255900E-01 2.01263232E-01 1.046805620E-01 5.30730958E-02 + 7.01359178E-01 2.01294140E-01 1.047997700E-01 5.30746587E-02 + 7.01462456E-01 2.01325050E-01 1.049191020E-01 5.30762237E-02 + 7.01565733E-01 2.01355962E-01 1.050385570E-01 5.30777907E-02 + 7.01669011E-01 2.01386877E-01 1.051581350E-01 5.30793597E-02 + 7.01772289E-01 2.01417793E-01 1.052778370E-01 5.30809307E-02 + 7.01875567E-01 2.01448711E-01 1.053976620E-01 5.30825038E-02 + 7.01978844E-01 2.01479631E-01 1.055176110E-01 5.30840790E-02 + 7.02082122E-01 2.01510553E-01 1.056376840E-01 5.30856562E-02 + 7.02185400E-01 2.01541477E-01 1.057578810E-01 5.30872354E-02 + 7.02288678E-01 2.01572402E-01 1.058782020E-01 5.30888167E-02 + 7.02391955E-01 2.01603330E-01 1.059986480E-01 5.30904000E-02 + 7.02495233E-01 2.01634260E-01 1.061192180E-01 5.30919854E-02 + 7.02598511E-01 2.01665192E-01 1.062399120E-01 5.30935728E-02 + 7.02701789E-01 2.01696126E-01 1.063607310E-01 5.30951623E-02 + 7.02805066E-01 2.01727062E-01 1.064816750E-01 5.30967539E-02 + 7.02908344E-01 2.01758000E-01 1.066027440E-01 5.30983476E-02 + 7.03011622E-01 2.01788940E-01 1.067239370E-01 5.30999433E-02 + 7.03114900E-01 2.01819882E-01 1.068452560E-01 5.31015410E-02 + 7.03218177E-01 2.01850826E-01 1.069667000E-01 5.31031409E-02 + 7.03321455E-01 2.01881771E-01 1.070882700E-01 5.31047428E-02 + 7.03424733E-01 2.01912719E-01 1.072099650E-01 5.31063468E-02 + 7.03528011E-01 2.01943669E-01 1.073317860E-01 5.31079529E-02 + 7.03631288E-01 2.01974621E-01 1.074537320E-01 5.31095610E-02 + 7.03734566E-01 2.02005575E-01 1.075758040E-01 5.31111713E-02 + 7.03837844E-01 2.02036531E-01 1.076980030E-01 5.31127836E-02 + 7.03941122E-01 2.02067489E-01 1.078203270E-01 5.31143980E-02 + 7.04044399E-01 2.02098449E-01 1.079427780E-01 5.31160145E-02 + 7.04147677E-01 2.02129411E-01 1.080653550E-01 5.31176332E-02 + 7.04250955E-01 2.02160375E-01 1.081880580E-01 5.31192539E-02 + 7.04354233E-01 2.02191341E-01 1.083108880E-01 5.31208767E-02 + 7.04457510E-01 2.02222310E-01 1.084338450E-01 5.31225016E-02 + 7.04560788E-01 2.02253280E-01 1.085569290E-01 5.31241286E-02 + 7.04664066E-01 2.02284252E-01 1.086801400E-01 5.31257577E-02 + 7.04767344E-01 2.02315226E-01 1.088034780E-01 5.31273889E-02 + 7.04870621E-01 2.02346202E-01 1.089269430E-01 5.31290223E-02 + 7.04973899E-01 2.02377181E-01 1.090505360E-01 5.31306578E-02 + 7.05077177E-01 2.02408161E-01 1.091742560E-01 5.31322953E-02 + 7.05180455E-01 2.02439144E-01 1.092981040E-01 5.31339350E-02 + 7.05283732E-01 2.02470128E-01 1.094220790E-01 5.31355768E-02 + 7.05387010E-01 2.02501115E-01 1.095461830E-01 5.31372208E-02 + 7.05490288E-01 2.02532103E-01 1.096704140E-01 5.31388669E-02 + 7.05593566E-01 2.02563094E-01 1.097947740E-01 5.31405151E-02 + 7.05696843E-01 2.02594087E-01 1.099192610E-01 5.31421654E-02 + 7.05800121E-01 2.02625082E-01 1.100438780E-01 5.31438179E-02 + 7.05903399E-01 2.02656079E-01 1.101686230E-01 5.31454725E-02 + 7.06006677E-01 2.02687078E-01 1.102934960E-01 5.31471293E-02 + 7.06109954E-01 2.02718079E-01 1.104184980E-01 5.31487881E-02 + 7.06213232E-01 2.02749082E-01 1.105436290E-01 5.31504492E-02 + 7.06316510E-01 2.02780087E-01 1.106688900E-01 5.31521124E-02 + 7.06419787E-01 2.02811094E-01 1.107942790E-01 5.31537777E-02 + 7.06523065E-01 2.02842104E-01 1.109197980E-01 5.31554452E-02 + 7.06626343E-01 2.02873115E-01 1.110454460E-01 5.31571149E-02 + 7.06729621E-01 2.02904129E-01 1.111712230E-01 5.31587867E-02 + 7.06832898E-01 2.02935144E-01 1.112971310E-01 5.31604607E-02 + 7.06936176E-01 2.02966162E-01 1.114231680E-01 5.31621368E-02 + 7.07039454E-01 2.02997182E-01 1.115493350E-01 5.31638151E-02 + 7.07142732E-01 2.03028204E-01 1.116756320E-01 5.31654956E-02 + 7.07246009E-01 2.03059228E-01 1.118020590E-01 5.31671782E-02 + 7.07349287E-01 2.03090254E-01 1.119286170E-01 5.31688630E-02 + 7.07452565E-01 2.03121282E-01 1.120553050E-01 5.31705500E-02 + 7.07555843E-01 2.03152313E-01 1.121821240E-01 5.31722392E-02 + 7.07659120E-01 2.03183345E-01 1.123090730E-01 5.31739305E-02 + 7.07762398E-01 2.03214380E-01 1.124361530E-01 5.31756241E-02 + 7.07865676E-01 2.03245416E-01 1.125633650E-01 5.31773198E-02 + 7.07968954E-01 2.03276455E-01 1.126907070E-01 5.31790177E-02 + 7.08072231E-01 2.03307496E-01 1.128181810E-01 5.31807178E-02 + 7.08175509E-01 2.03338539E-01 1.129457860E-01 5.31824202E-02 + 7.08278787E-01 2.03369585E-01 1.130735220E-01 5.31841247E-02 + 7.08382065E-01 2.03400632E-01 1.132013900E-01 5.31858314E-02 + 7.08485342E-01 2.03431681E-01 1.133293900E-01 5.31875403E-02 + 7.08588620E-01 2.03462733E-01 1.134575220E-01 5.31892514E-02 + 7.08691898E-01 2.03493787E-01 1.135857860E-01 5.31909647E-02 + 7.08795176E-01 2.03524843E-01 1.137141820E-01 5.31926802E-02 + 7.08898453E-01 2.03555901E-01 1.138427100E-01 5.31943980E-02 + 7.09001731E-01 2.03586961E-01 1.139713700E-01 5.31961180E-02 + 7.09105009E-01 2.03618023E-01 1.141001640E-01 5.31978401E-02 + 7.09208287E-01 2.03649088E-01 1.142290900E-01 5.31995645E-02 + 7.09311564E-01 2.03680155E-01 1.143581480E-01 5.32012912E-02 + 7.09414842E-01 2.03711223E-01 1.144873400E-01 5.32030200E-02 + 7.09518120E-01 2.03742294E-01 1.146166650E-01 5.32047511E-02 + 7.09621398E-01 2.03773368E-01 1.147461220E-01 5.32064844E-02 + 7.09724675E-01 2.03804443E-01 1.148757140E-01 5.32082200E-02 + 7.09827953E-01 2.03835520E-01 1.150054390E-01 5.32099578E-02 + 7.09931231E-01 2.03866600E-01 1.151352970E-01 5.32116978E-02 + 7.10034509E-01 2.03897682E-01 1.152652890E-01 5.32134401E-02 + 7.10137786E-01 2.03928766E-01 1.153954150E-01 5.32151846E-02 + 7.10241064E-01 2.03959852E-01 1.155256750E-01 5.32169314E-02 + 7.10344342E-01 2.03990941E-01 1.156560690E-01 5.32186804E-02 + 7.10447620E-01 2.04022031E-01 1.157865980E-01 5.32204317E-02 + 7.10550897E-01 2.04053124E-01 1.159172600E-01 5.32221852E-02 + 7.10654175E-01 2.04084219E-01 1.160480580E-01 5.32239410E-02 + 7.10757453E-01 2.04115316E-01 1.161789900E-01 5.32256991E-02 + 7.10860731E-01 2.04146416E-01 1.163100570E-01 5.32274594E-02 + 7.10964008E-01 2.04177517E-01 1.164412590E-01 5.32292220E-02 + 7.11067286E-01 2.04208621E-01 1.165725960E-01 5.32309868E-02 + 7.11170564E-01 2.04239727E-01 1.167040680E-01 5.32327540E-02 + 7.11273842E-01 2.04270835E-01 1.168356750E-01 5.32345234E-02 + 7.11377119E-01 2.04301945E-01 1.169674180E-01 5.32362951E-02 + 7.11480397E-01 2.04333058E-01 1.170992970E-01 5.32380690E-02 + 7.11583675E-01 2.04364173E-01 1.172313110E-01 5.32398453E-02 + 7.11686953E-01 2.04395290E-01 1.173634610E-01 5.32416238E-02 + 7.11790230E-01 2.04426409E-01 1.174957480E-01 5.32434046E-02 + 7.11893508E-01 2.04457531E-01 1.176281700E-01 5.32451878E-02 + 7.11996786E-01 2.04488654E-01 1.177607290E-01 5.32469732E-02 + 7.12100064E-01 2.04519780E-01 1.178934240E-01 5.32487609E-02 + 7.12203341E-01 2.04550908E-01 1.180262560E-01 5.32505509E-02 + 7.12306619E-01 2.04582039E-01 1.181592240E-01 5.32523432E-02 + 7.12409897E-01 2.04613172E-01 1.182923300E-01 5.32541378E-02 + 7.12513175E-01 2.04644306E-01 1.184255720E-01 5.32559348E-02 + 7.12616452E-01 2.04675444E-01 1.185589520E-01 5.32577340E-02 + 7.12719730E-01 2.04706583E-01 1.186924680E-01 5.32595355E-02 + 7.12823008E-01 2.04737725E-01 1.188261230E-01 5.32613394E-02 + 7.12926286E-01 2.04768869E-01 1.189599140E-01 5.32631456E-02 + 7.13029563E-01 2.04800015E-01 1.190938440E-01 5.32649541E-02 + 7.13132841E-01 2.04831163E-01 1.192279110E-01 5.32667650E-02 + 7.13236119E-01 2.04862314E-01 1.193621160E-01 5.32685781E-02 + 7.13339397E-01 2.04893467E-01 1.194964590E-01 5.32703936E-02 + 7.13442674E-01 2.04924622E-01 1.196309400E-01 5.32722115E-02 + 7.13545952E-01 2.04955779E-01 1.197655600E-01 5.32740316E-02 + 7.13649230E-01 2.04986939E-01 1.199003180E-01 5.32758541E-02 + 7.13752508E-01 2.05018101E-01 1.200352150E-01 5.32776790E-02 + 7.13855785E-01 2.05049265E-01 1.201702510E-01 5.32795062E-02 + 7.13959063E-01 2.05080432E-01 1.203054260E-01 5.32813357E-02 + 7.14062341E-01 2.05111601E-01 1.204407390E-01 5.32831676E-02 + 7.14165618E-01 2.05142772E-01 1.205761920E-01 5.32850019E-02 + 7.14268896E-01 2.05173945E-01 1.207117840E-01 5.32868385E-02 + 7.14372174E-01 2.05205121E-01 1.208475160E-01 5.32886774E-02 + 7.14475452E-01 2.05236299E-01 1.209833870E-01 5.32905188E-02 + 7.14578729E-01 2.05267479E-01 1.211193990E-01 5.32923624E-02 + 7.14682007E-01 2.05298662E-01 1.212555500E-01 5.32942085E-02 + 7.14785285E-01 2.05329847E-01 1.213918410E-01 5.32960569E-02 + 7.14888563E-01 2.05361034E-01 1.215282720E-01 5.32979077E-02 + 7.14991840E-01 2.05392224E-01 1.216648430E-01 5.32997609E-02 + 7.15095118E-01 2.05423416E-01 1.218015550E-01 5.33016164E-02 + 7.15198396E-01 2.05454610E-01 1.219384080E-01 5.33034744E-02 + 7.15301674E-01 2.05485806E-01 1.220754010E-01 5.33053347E-02 + 7.15404951E-01 2.05517005E-01 1.222125350E-01 5.33071974E-02 + 7.15508229E-01 2.05548206E-01 1.223498100E-01 5.33090625E-02 + 7.15611507E-01 2.05579409E-01 1.224872270E-01 5.33109300E-02 + 7.15714785E-01 2.05610615E-01 1.226247840E-01 5.33127999E-02 + 7.15818062E-01 2.05641823E-01 1.227624840E-01 5.33146722E-02 + 7.15921340E-01 2.05673034E-01 1.229003240E-01 5.33165469E-02 + 7.16024618E-01 2.05704247E-01 1.230383070E-01 5.33184240E-02 + 7.16127896E-01 2.05735462E-01 1.231764310E-01 5.33203035E-02 + 7.16231173E-01 2.05766679E-01 1.233146970E-01 5.33221854E-02 + 7.16334451E-01 2.05797899E-01 1.234531060E-01 5.33240697E-02 + 7.16437729E-01 2.05829121E-01 1.235916570E-01 5.33259564E-02 + 7.16541007E-01 2.05860346E-01 1.237303500E-01 5.33278456E-02 + 7.16644284E-01 2.05891572E-01 1.238691860E-01 5.33297372E-02 + 7.16747562E-01 2.05922802E-01 1.240081640E-01 5.33316312E-02 + 7.16850840E-01 2.05954033E-01 1.241472860E-01 5.33335276E-02 + 7.16954118E-01 2.05985267E-01 1.242865500E-01 5.33354265E-02 + 7.17057395E-01 2.06016504E-01 1.244259580E-01 5.33373278E-02 + 7.17160673E-01 2.06047742E-01 1.245655090E-01 5.33392315E-02 + 7.17263951E-01 2.06078983E-01 1.247052030E-01 5.33411377E-02 + 7.17367229E-01 2.06110227E-01 1.248450410E-01 5.33430463E-02 + 7.17470506E-01 2.06141472E-01 1.249850230E-01 5.33449574E-02 + 7.17573784E-01 2.06172721E-01 1.251251490E-01 5.33468709E-02 + 7.17677062E-01 2.06203971E-01 1.252654180E-01 5.33487868E-02 + 7.17780340E-01 2.06235224E-01 1.254058320E-01 5.33507052E-02 + 7.17883617E-01 2.06266479E-01 1.255463900E-01 5.33526261E-02 + 7.17986895E-01 2.06297737E-01 1.256870930E-01 5.33545494E-02 + 7.18090173E-01 2.06328997E-01 1.258279400E-01 5.33564752E-02 + 7.18193451E-01 2.06360260E-01 1.259689320E-01 5.33584035E-02 + 7.18296728E-01 2.06391525E-01 1.261100690E-01 5.33603342E-02 + 7.18400006E-01 2.06422792E-01 1.262513510E-01 5.33622674E-02 + 7.18503284E-01 2.06454062E-01 1.263927780E-01 5.33642031E-02 + 7.18606562E-01 2.06485334E-01 1.265343510E-01 5.33661413E-02 + 7.18709839E-01 2.06516609E-01 1.266760680E-01 5.33680819E-02 + 7.18813117E-01 2.06547886E-01 1.268179320E-01 5.33700250E-02 + 7.18916395E-01 2.06579165E-01 1.269599410E-01 5.33719706E-02 + 7.19019673E-01 2.06610447E-01 1.271020970E-01 5.33739187E-02 + 7.19122950E-01 2.06641731E-01 1.272443980E-01 5.33758693E-02 + 7.19226228E-01 2.06673018E-01 1.273868460E-01 5.33778224E-02 + 7.19329506E-01 2.06704307E-01 1.275294400E-01 5.33797780E-02 + 7.19432784E-01 2.06735598E-01 1.276721800E-01 5.33817360E-02 + 7.19536061E-01 2.06766892E-01 1.278150670E-01 5.33836966E-02 + 7.19639339E-01 2.06798189E-01 1.279581010E-01 5.33856597E-02 + 7.19742617E-01 2.06829488E-01 1.281012820E-01 5.33876253E-02 + 7.19845895E-01 2.06860789E-01 1.282446100E-01 5.33895934E-02 + 7.19949172E-01 2.06892093E-01 1.283880860E-01 5.33915641E-02 + 7.20052450E-01 2.06923399E-01 1.285317080E-01 5.33935372E-02 + 7.20155728E-01 2.06954707E-01 1.286754780E-01 5.33955129E-02 + 7.20259006E-01 2.06986019E-01 1.288193960E-01 5.33974911E-02 + 7.20362283E-01 2.07017332E-01 1.289634620E-01 5.33994718E-02 + 7.20465561E-01 2.07048648E-01 1.291076760E-01 5.34014551E-02 + 7.20568839E-01 2.07079967E-01 1.292520380E-01 5.34034409E-02 + 7.20672117E-01 2.07111288E-01 1.293965480E-01 5.34054292E-02 + 7.20775394E-01 2.07142611E-01 1.295412070E-01 5.34074201E-02 + 7.20878672E-01 2.07173937E-01 1.296860140E-01 5.34094135E-02 + 7.20981950E-01 2.07205265E-01 1.298309700E-01 5.34114095E-02 + 7.21085228E-01 2.07236596E-01 1.299760750E-01 5.34134080E-02 + 7.21188505E-01 2.07267930E-01 1.301213290E-01 5.34154091E-02 + 7.21291783E-01 2.07299266E-01 1.302667330E-01 5.34174127E-02 + 7.21395061E-01 2.07330604E-01 1.304122850E-01 5.34194189E-02 + 7.21498339E-01 2.07361945E-01 1.305579870E-01 5.34214276E-02 + 7.21601616E-01 2.07393288E-01 1.307038390E-01 5.34234390E-02 + 7.21704894E-01 2.07424634E-01 1.308498410E-01 5.34254528E-02 + 7.21808172E-01 2.07455982E-01 1.309959920E-01 5.34274693E-02 + 7.21911449E-01 2.07487333E-01 1.311422940E-01 5.34294883E-02 + 7.22014727E-01 2.07518686E-01 1.312887460E-01 5.34315099E-02 + 7.22118005E-01 2.07550042E-01 1.314353480E-01 5.34335341E-02 + 7.22221283E-01 2.07581401E-01 1.315821010E-01 5.34355609E-02 + 7.22324560E-01 2.07612762E-01 1.317290040E-01 5.34375902E-02 + 7.22427838E-01 2.07644125E-01 1.318760590E-01 5.34396222E-02 + 7.22531116E-01 2.07675491E-01 1.320232640E-01 5.34416567E-02 + 7.22634394E-01 2.07706859E-01 1.321706210E-01 5.34436938E-02 + 7.22737671E-01 2.07738230E-01 1.323181290E-01 5.34457336E-02 + 7.22840949E-01 2.07769604E-01 1.324657890E-01 5.34477759E-02 + 7.22944227E-01 2.07800980E-01 1.326136000E-01 5.34498208E-02 + 7.23047505E-01 2.07832359E-01 1.327615630E-01 5.34518684E-02 + 7.23150782E-01 2.07863740E-01 1.329096780E-01 5.34539185E-02 + 7.23254060E-01 2.07895124E-01 1.330579450E-01 5.34559713E-02 + 7.23357338E-01 2.07926510E-01 1.332063640E-01 5.34580267E-02 + 7.23460616E-01 2.07957899E-01 1.333549360E-01 5.34600847E-02 + 7.23563893E-01 2.07989290E-01 1.335036600E-01 5.34621454E-02 + 7.23667171E-01 2.08020684E-01 1.336525370E-01 5.34642086E-02 + 7.23770449E-01 2.08052080E-01 1.338015660E-01 5.34662745E-02 + 7.23873727E-01 2.08083479E-01 1.339507490E-01 5.34683430E-02 + 7.23977004E-01 2.08114881E-01 1.341000850E-01 5.34704142E-02 + 7.24080282E-01 2.08146285E-01 1.342495750E-01 5.34724880E-02 + 7.24183560E-01 2.08177692E-01 1.343992180E-01 5.34745645E-02 + 7.24286838E-01 2.08209101E-01 1.345490140E-01 5.34766436E-02 + 7.24390115E-01 2.08240513E-01 1.346989640E-01 5.34787253E-02 + 7.24493393E-01 2.08271928E-01 1.348490690E-01 5.34808097E-02 + 7.24596671E-01 2.08303345E-01 1.349993270E-01 5.34828968E-02 + 7.24699949E-01 2.08334765E-01 1.351497400E-01 5.34849865E-02 + 7.24803226E-01 2.08366187E-01 1.353003070E-01 5.34870788E-02 + 7.24906504E-01 2.08397612E-01 1.354510290E-01 5.34891739E-02 + 7.25009782E-01 2.08429039E-01 1.356019050E-01 5.34912716E-02 + 7.25113060E-01 2.08460469E-01 1.357529360E-01 5.34933720E-02 + 7.25216337E-01 2.08491902E-01 1.359041230E-01 5.34954750E-02 + 7.25319615E-01 2.08523337E-01 1.360554650E-01 5.34975807E-02 + 7.25422893E-01 2.08554775E-01 1.362069620E-01 5.34996892E-02 + 7.25526171E-01 2.08586216E-01 1.363586140E-01 5.35018003E-02 + 7.25629448E-01 2.08617659E-01 1.365104220E-01 5.35039140E-02 + 7.25732726E-01 2.08649104E-01 1.366623860E-01 5.35060305E-02 + 7.25836004E-01 2.08680553E-01 1.368145070E-01 5.35081497E-02 + 7.25939282E-01 2.08712004E-01 1.369667830E-01 5.35102716E-02 + 7.26042559E-01 2.08743457E-01 1.371192160E-01 5.35123961E-02 + 7.26145837E-01 2.08774914E-01 1.372718050E-01 5.35145234E-02 + 7.26249115E-01 2.08806373E-01 1.374245500E-01 5.35166534E-02 + 7.26352393E-01 2.08837834E-01 1.375774530E-01 5.35187861E-02 + 7.26455670E-01 2.08869298E-01 1.377305130E-01 5.35209215E-02 + 7.26558948E-01 2.08900765E-01 1.378837290E-01 5.35230596E-02 + 7.26662226E-01 2.08932235E-01 1.380371030E-01 5.35252004E-02 + 7.26765504E-01 2.08963707E-01 1.381906350E-01 5.35273440E-02 + 7.26868781E-01 2.08995182E-01 1.383443240E-01 5.35294903E-02 + 7.26972059E-01 2.09026659E-01 1.384981700E-01 5.35316393E-02 + 7.27075337E-01 2.09058139E-01 1.386521750E-01 5.35337911E-02 + 7.27178615E-01 2.09089622E-01 1.388063380E-01 5.35359455E-02 + 7.27281892E-01 2.09121107E-01 1.389606590E-01 5.35381028E-02 + 7.27385170E-01 2.09152596E-01 1.391151380E-01 5.35402627E-02 + 7.27488448E-01 2.09184086E-01 1.392697760E-01 5.35424255E-02 + 7.27591726E-01 2.09215580E-01 1.394245730E-01 5.35445909E-02 + 7.27695003E-01 2.09247076E-01 1.395795290E-01 5.35467591E-02 + 7.27798281E-01 2.09278575E-01 1.397346440E-01 5.35489301E-02 + 7.27901559E-01 2.09310076E-01 1.398899180E-01 5.35511039E-02 + 7.28004837E-01 2.09341581E-01 1.400453510E-01 5.35532804E-02 + 7.28108114E-01 2.09373088E-01 1.402009440E-01 5.35554596E-02 + 7.28211392E-01 2.09404597E-01 1.403566970E-01 5.35576417E-02 + 7.28314670E-01 2.09436109E-01 1.405126090E-01 5.35598265E-02 + 7.28417948E-01 2.09467624E-01 1.406686820E-01 5.35620140E-02 + 7.28521225E-01 2.09499142E-01 1.408249140E-01 5.35642044E-02 + 7.28624503E-01 2.09530663E-01 1.409813070E-01 5.35663975E-02 + 7.28727781E-01 2.09562186E-01 1.411378610E-01 5.35685935E-02 + 7.28831059E-01 2.09593712E-01 1.412945750E-01 5.35707922E-02 + 7.28934336E-01 2.09625240E-01 1.414514510E-01 5.35729937E-02 + 7.29037614E-01 2.09656772E-01 1.416084870E-01 5.35751980E-02 + 7.29140892E-01 2.09688306E-01 1.417656840E-01 5.35774051E-02 + 7.29244170E-01 2.09719842E-01 1.419230430E-01 5.35796150E-02 + 7.29347447E-01 2.09751382E-01 1.420805630E-01 5.35818278E-02 + 7.29450725E-01 2.09782924E-01 1.422382450E-01 5.35840433E-02 + 7.29554003E-01 2.09814469E-01 1.423960890E-01 5.35862616E-02 + 7.29657280E-01 2.09846017E-01 1.425540950E-01 5.35884828E-02 + 7.29760558E-01 2.09877568E-01 1.427122630E-01 5.35907067E-02 + 7.29863836E-01 2.09909121E-01 1.428705930E-01 5.35929335E-02 + 7.29967114E-01 2.09940677E-01 1.430290860E-01 5.35951632E-02 + 7.30070391E-01 2.09972236E-01 1.431877420E-01 5.35973956E-02 + 7.30173669E-01 2.10003797E-01 1.433465600E-01 5.35996309E-02 + 7.30276947E-01 2.10035361E-01 1.435055410E-01 5.36018690E-02 + 7.30380225E-01 2.10066928E-01 1.436646860E-01 5.36041100E-02 + 7.30483502E-01 2.10098498E-01 1.438239940E-01 5.36063538E-02 + 7.30586780E-01 2.10130071E-01 1.439834650E-01 5.36086004E-02 + 7.30690058E-01 2.10161646E-01 1.441431010E-01 5.36108499E-02 + 7.30793336E-01 2.10193224E-01 1.443028990E-01 5.36131023E-02 + 7.30896613E-01 2.10224805E-01 1.444628620E-01 5.36153575E-02 + 7.30999891E-01 2.10256389E-01 1.446229900E-01 5.36176156E-02 + 7.31103169E-01 2.10287976E-01 1.447832810E-01 5.36198765E-02 + 7.31206447E-01 2.10319565E-01 1.449437370E-01 5.36221403E-02 + 7.31309724E-01 2.10351157E-01 1.451043580E-01 5.36244070E-02 + 7.31413002E-01 2.10382752E-01 1.452651440E-01 5.36266765E-02 + 7.31516280E-01 2.10414350E-01 1.454260940E-01 5.36289490E-02 + 7.31619558E-01 2.10445950E-01 1.455872100E-01 5.36312243E-02 + 7.31722835E-01 2.10477553E-01 1.457484910E-01 5.36335024E-02 + 7.31826113E-01 2.10509160E-01 1.459099380E-01 5.36357835E-02 + 7.31929391E-01 2.10540769E-01 1.460715510E-01 5.36380675E-02 + 7.32032669E-01 2.10572380E-01 1.462333290E-01 5.36403544E-02 + 7.32135946E-01 2.10603995E-01 1.463952730E-01 5.36426441E-02 + 7.32239224E-01 2.10635612E-01 1.465573840E-01 5.36449368E-02 + 7.32342502E-01 2.10667233E-01 1.467196610E-01 5.36472323E-02 + 7.32445780E-01 2.10698856E-01 1.468821050E-01 5.36495308E-02 + 7.32549057E-01 2.10730482E-01 1.470447150E-01 5.36518322E-02 + 7.32652335E-01 2.10762111E-01 1.472074920E-01 5.36541365E-02 + 7.32755613E-01 2.10793742E-01 1.473704370E-01 5.36564437E-02 + 7.32858891E-01 2.10825377E-01 1.475335480E-01 5.36587539E-02 + 7.32962168E-01 2.10857014E-01 1.476968270E-01 5.36610670E-02 + 7.33065446E-01 2.10888654E-01 1.478602740E-01 5.36633830E-02 + 7.33168724E-01 2.10920297E-01 1.480238880E-01 5.36657019E-02 + 7.33272002E-01 2.10951943E-01 1.481876700E-01 5.36680238E-02 + 7.33375279E-01 2.10983592E-01 1.483516210E-01 5.36703486E-02 + 7.33478557E-01 2.11015244E-01 1.485157390E-01 5.36726763E-02 + 7.33581835E-01 2.11046898E-01 1.486800270E-01 5.36750070E-02 + 7.33685113E-01 2.11078556E-01 1.488444820E-01 5.36773407E-02 + 7.33788390E-01 2.11110216E-01 1.490091070E-01 5.36796773E-02 + 7.33891668E-01 2.11141879E-01 1.491739000E-01 5.36820168E-02 + 7.33994946E-01 2.11173545E-01 1.493388630E-01 5.36843594E-02 + 7.34098224E-01 2.11205214E-01 1.495039950E-01 5.36867049E-02 + 7.34201501E-01 2.11236886E-01 1.496692970E-01 5.36890533E-02 + 7.34304779E-01 2.11268560E-01 1.498347680E-01 5.36914047E-02 + 7.34408057E-01 2.11300238E-01 1.500004090E-01 5.36937592E-02 + 7.34511335E-01 2.11331919E-01 1.501662200E-01 5.36961165E-02 + 7.34614612E-01 2.11363602E-01 1.503322020E-01 5.36984769E-02 + 7.34717890E-01 2.11395288E-01 1.504983530E-01 5.37008403E-02 + 7.34821168E-01 2.11426978E-01 1.506646760E-01 5.37032066E-02 + 7.34924446E-01 2.11458670E-01 1.508311690E-01 5.37055759E-02 + 7.35027723E-01 2.11490365E-01 1.509978330E-01 5.37079483E-02 + 7.35131001E-01 2.11522063E-01 1.511646680E-01 5.37103236E-02 + 7.35234279E-01 2.11553764E-01 1.513316740E-01 5.37127019E-02 + 7.35337557E-01 2.11585468E-01 1.514988520E-01 5.37150833E-02 + 7.35440834E-01 2.11617175E-01 1.516662010E-01 5.37174676E-02 + 7.35544112E-01 2.11648884E-01 1.518337220E-01 5.37198550E-02 + 7.35647390E-01 2.11680597E-01 1.520014150E-01 5.37222454E-02 + 7.35750668E-01 2.11712313E-01 1.521692800E-01 5.37246388E-02 + 7.35853945E-01 2.11744031E-01 1.523373180E-01 5.37270353E-02 + 7.35957223E-01 2.11775753E-01 1.525055280E-01 5.37294347E-02 + 7.36060501E-01 2.11807478E-01 1.526739110E-01 5.37318372E-02 + 7.36163779E-01 2.11839205E-01 1.528424660E-01 5.37342428E-02 + 7.36267056E-01 2.11870935E-01 1.530111950E-01 5.37366513E-02 + 7.36370334E-01 2.11902669E-01 1.531800970E-01 5.37390630E-02 + 7.36473612E-01 2.11934405E-01 1.533491720E-01 5.37414776E-02 + 7.36576890E-01 2.11966145E-01 1.535184210E-01 5.37438953E-02 + 7.36680167E-01 2.11997887E-01 1.536878440E-01 5.37463161E-02 + 7.36783445E-01 2.12029632E-01 1.538574400E-01 5.37487400E-02 + 7.36886723E-01 2.12061380E-01 1.540272110E-01 5.37511669E-02 + 7.36990001E-01 2.12093132E-01 1.541971560E-01 5.37535968E-02 + 7.37093278E-01 2.12124886E-01 1.543672750E-01 5.37560298E-02 + 7.37196556E-01 2.12156643E-01 1.545375700E-01 5.37584659E-02 + 7.37299834E-01 2.12188404E-01 1.547080390E-01 5.37609051E-02 + 7.37403111E-01 2.12220167E-01 1.548786830E-01 5.37633474E-02 + 7.37506389E-01 2.12251933E-01 1.550495020E-01 5.37657927E-02 + 7.37609667E-01 2.12283702E-01 1.552204960E-01 5.37682412E-02 + 7.37712945E-01 2.12315475E-01 1.553916670E-01 5.37706927E-02 + 7.37816222E-01 2.12347250E-01 1.555630130E-01 5.37731473E-02 + 7.37919500E-01 2.12379028E-01 1.557345340E-01 5.37756050E-02 + 7.38022778E-01 2.12410810E-01 1.559062320E-01 5.37780659E-02 + 7.38126056E-01 2.12442594E-01 1.560781070E-01 5.37805298E-02 + 7.38229333E-01 2.12474382E-01 1.562501570E-01 5.37829968E-02 + 7.38332611E-01 2.12506172E-01 1.564223850E-01 5.37854670E-02 + 7.38435889E-01 2.12537965E-01 1.565947890E-01 5.37879403E-02 + 7.38539167E-01 2.12569762E-01 1.567673710E-01 5.37904167E-02 + 7.38642444E-01 2.12601562E-01 1.569401290E-01 5.37928962E-02 + 7.38745722E-01 2.12633364E-01 1.571130650E-01 5.37953788E-02 + 7.38849000E-01 2.12665170E-01 1.572861790E-01 5.37978646E-02 + 7.38952278E-01 2.12696979E-01 1.574594700E-01 5.38003535E-02 + 7.39055555E-01 2.12728790E-01 1.576329390E-01 5.38028456E-02 + 7.39158833E-01 2.12760605E-01 1.578065860E-01 5.38053408E-02 + 7.39262111E-01 2.12792423E-01 1.579804120E-01 5.38078391E-02 + 7.39365389E-01 2.12824244E-01 1.581544160E-01 5.38103406E-02 + 7.39468666E-01 2.12856068E-01 1.583285990E-01 5.38128453E-02 + 7.39571944E-01 2.12887896E-01 1.585029610E-01 5.38153531E-02 + 7.39675222E-01 2.12919726E-01 1.586775020E-01 5.38178641E-02 + 7.39778500E-01 2.12951559E-01 1.588522220E-01 5.38203782E-02 + 7.39881777E-01 2.12983396E-01 1.590271220E-01 5.38228955E-02 + 7.39985055E-01 2.13015235E-01 1.592022010E-01 5.38254160E-02 + 7.40088333E-01 2.13047078E-01 1.593774600E-01 5.38279397E-02 + 7.40191611E-01 2.13078923E-01 1.595528990E-01 5.38304665E-02 + 7.40294888E-01 2.13110772E-01 1.597285180E-01 5.38329966E-02 + 7.40398166E-01 2.13142624E-01 1.599043180E-01 5.38355298E-02 + 7.40501444E-01 2.13174479E-01 1.600802980E-01 5.38380662E-02 + 7.40604722E-01 2.13206337E-01 1.602564590E-01 5.38406058E-02 + 7.40707999E-01 2.13238199E-01 1.604328010E-01 5.38431486E-02 + 7.40811277E-01 2.13270063E-01 1.606093240E-01 5.38456947E-02 + 7.40914555E-01 2.13301930E-01 1.607860290E-01 5.38482439E-02 + 7.41017833E-01 2.13333801E-01 1.609629140E-01 5.38507963E-02 + 7.41121110E-01 2.13365675E-01 1.611399820E-01 5.38533520E-02 + 7.41224388E-01 2.13397552E-01 1.613172320E-01 5.38559109E-02 + 7.41327666E-01 2.13429432E-01 1.614946630E-01 5.38584730E-02 + 7.41430944E-01 2.13461315E-01 1.616722770E-01 5.38610383E-02 + 7.41534221E-01 2.13493201E-01 1.618500730E-01 5.38636069E-02 + 7.41637499E-01 2.13525091E-01 1.620280520E-01 5.38661786E-02 + 7.41740777E-01 2.13556984E-01 1.622062140E-01 5.38687537E-02 + 7.41844055E-01 2.13588879E-01 1.623845590E-01 5.38713320E-02 + 7.41947332E-01 2.13620778E-01 1.625630870E-01 5.38739135E-02 + 7.42050610E-01 2.13652681E-01 1.627417980E-01 5.38764983E-02 + 7.42153888E-01 2.13684586E-01 1.629206930E-01 5.38790863E-02 + 7.42257166E-01 2.13716494E-01 1.630997720E-01 5.38816776E-02 + 7.42360443E-01 2.13748406E-01 1.632790350E-01 5.38842722E-02 + 7.42463721E-01 2.13780321E-01 1.634584820E-01 5.38868700E-02 + 7.42566999E-01 2.13812239E-01 1.636381140E-01 5.38894711E-02 + 7.42670277E-01 2.13844160E-01 1.638179300E-01 5.38920754E-02 + 7.42773554E-01 2.13876085E-01 1.639979310E-01 5.38946831E-02 + 7.42876832E-01 2.13908012E-01 1.641781160E-01 5.38972940E-02 + 7.42980110E-01 2.13939943E-01 1.643584870E-01 5.38999082E-02 + 7.43083388E-01 2.13971877E-01 1.645390440E-01 5.39025257E-02 + 7.43186665E-01 2.14003815E-01 1.647197850E-01 5.39051465E-02 + 7.43289943E-01 2.14035755E-01 1.649007130E-01 5.39077706E-02 + 7.43393221E-01 2.14067699E-01 1.650818260E-01 5.39103980E-02 + 7.43496499E-01 2.14099646E-01 1.652631260E-01 5.39130288E-02 + 7.43599776E-01 2.14131596E-01 1.654446120E-01 5.39156628E-02 + 7.43703054E-01 2.14163549E-01 1.656262840E-01 5.39183001E-02 + 7.43806332E-01 2.14195506E-01 1.658081440E-01 5.39209408E-02 + 7.43909610E-01 2.14227465E-01 1.659901900E-01 5.39235847E-02 + 7.44012887E-01 2.14259429E-01 1.661724230E-01 5.39262320E-02 + 7.44116165E-01 2.14291395E-01 1.663548430E-01 5.39288827E-02 + 7.44219443E-01 2.14323364E-01 1.665374510E-01 5.39315366E-02 + 7.44322721E-01 2.14355337E-01 1.667202470E-01 5.39341939E-02 + 7.44425998E-01 2.14387313E-01 1.669032310E-01 5.39368546E-02 + 7.44529276E-01 2.14419293E-01 1.670864020E-01 5.39395186E-02 + 7.44632554E-01 2.14451275E-01 1.672697620E-01 5.39421859E-02 + 7.44735832E-01 2.14483261E-01 1.674533110E-01 5.39448566E-02 + 7.44839109E-01 2.14515250E-01 1.676370480E-01 5.39475307E-02 + 7.44942387E-01 2.14547243E-01 1.678209740E-01 5.39502081E-02 + 7.45045665E-01 2.14579238E-01 1.680050890E-01 5.39528889E-02 + 7.45148943E-01 2.14611237E-01 1.681893930E-01 5.39555730E-02 + 7.45252220E-01 2.14643239E-01 1.683738870E-01 5.39582605E-02 + 7.45355498E-01 2.14675245E-01 1.685585710E-01 5.39609514E-02 + 7.45458776E-01 2.14707254E-01 1.687434440E-01 5.39636457E-02 + 7.45562053E-01 2.14739266E-01 1.689285080E-01 5.39663434E-02 + 7.45665331E-01 2.14771281E-01 1.691137610E-01 5.39690445E-02 + 7.45768609E-01 2.14803300E-01 1.692992060E-01 5.39717489E-02 + 7.45871887E-01 2.14835322E-01 1.694848410E-01 5.39744568E-02 + 7.45975164E-01 2.14867347E-01 1.696706660E-01 5.39771681E-02 + 7.46078442E-01 2.14899376E-01 1.698566830E-01 5.39798827E-02 + 7.46181720E-01 2.14931408E-01 1.700428920E-01 5.39826008E-02 + 7.46284998E-01 2.14963443E-01 1.702292910E-01 5.39853223E-02 + 7.46388275E-01 2.14995482E-01 1.704158830E-01 5.39880472E-02 + 7.46491553E-01 2.15027524E-01 1.706026660E-01 5.39907755E-02 + 7.46594831E-01 2.15059569E-01 1.707896410E-01 5.39935073E-02 + 7.46698109E-01 2.15091618E-01 1.709768090E-01 5.39962425E-02 + 7.46801386E-01 2.15123670E-01 1.711641690E-01 5.39989811E-02 + 7.46904664E-01 2.15155725E-01 1.713517220E-01 5.40017232E-02 + 7.47007942E-01 2.15187784E-01 1.715394670E-01 5.40044687E-02 + 7.47111220E-01 2.15219846E-01 1.717274060E-01 5.40072177E-02 + 7.47214497E-01 2.15251911E-01 1.719155380E-01 5.40099701E-02 + 7.47317775E-01 2.15283980E-01 1.721038640E-01 5.40127260E-02 + 7.47421053E-01 2.15316052E-01 1.722923840E-01 5.40154853E-02 + 7.47524331E-01 2.15348128E-01 1.724810970E-01 5.40182481E-02 + 7.47627608E-01 2.15380207E-01 1.726700040E-01 5.40210144E-02 + 7.47730886E-01 2.15412289E-01 1.728591060E-01 5.40237841E-02 + 7.47834164E-01 2.15444375E-01 1.730484020E-01 5.40265573E-02 + 7.47937442E-01 2.15476464E-01 1.732378940E-01 5.40293340E-02 + 7.48040719E-01 2.15508556E-01 1.734275800E-01 5.40321142E-02 + 7.48143997E-01 2.15540652E-01 1.736174610E-01 5.40348979E-02 + 7.48247275E-01 2.15572751E-01 1.738075370E-01 5.40376851E-02 + 7.48350553E-01 2.15604854E-01 1.739978090E-01 5.40404757E-02 + 7.48453830E-01 2.15636960E-01 1.741882770E-01 5.40432699E-02 + 7.48557108E-01 2.15669069E-01 1.743789410E-01 5.40460676E-02 + 7.48660386E-01 2.15701182E-01 1.745698010E-01 5.40488688E-02 + 7.48763664E-01 2.15733299E-01 1.747608580E-01 5.40516735E-02 + 7.48866941E-01 2.15765418E-01 1.749521110E-01 5.40544817E-02 + 7.48970219E-01 2.15797541E-01 1.751435610E-01 5.40572934E-02 + 7.49073497E-01 2.15829668E-01 1.753352080E-01 5.40601087E-02 + 7.49176775E-01 2.15861798E-01 1.755270520E-01 5.40629275E-02 + 7.49280052E-01 2.15893932E-01 1.757190940E-01 5.40657499E-02 + 7.49383330E-01 2.15926068E-01 1.759113330E-01 5.40685757E-02 + 7.49486608E-01 2.15958209E-01 1.761037700E-01 5.40714052E-02 + 7.49589886E-01 2.15990353E-01 1.762964050E-01 5.40742381E-02 + 7.49693163E-01 2.16022500E-01 1.764892390E-01 5.40770747E-02 + 7.49796441E-01 2.16054651E-01 1.766822710E-01 5.40799148E-02 + 7.49899719E-01 2.16086805E-01 1.768755020E-01 5.40827584E-02 + 7.50002997E-01 2.16118962E-01 1.770689310E-01 5.40856056E-02 + 7.50106274E-01 2.16151124E-01 1.772625600E-01 5.40884564E-02 + 7.50209552E-01 2.16183288E-01 1.774563880E-01 5.40913108E-02 + 7.50312830E-01 2.16215456E-01 1.776504160E-01 5.40941687E-02 + 7.50416108E-01 2.16247628E-01 1.778446430E-01 5.40970302E-02 + 7.50519385E-01 2.16279803E-01 1.780390710E-01 5.40998953E-02 + 7.50622663E-01 2.16311981E-01 1.782336990E-01 5.41027640E-02 + 7.50725941E-01 2.16344163E-01 1.784285270E-01 5.41056363E-02 + 7.50829219E-01 2.16376349E-01 1.786235550E-01 5.41085122E-02 + 7.50932496E-01 2.16408538E-01 1.788187850E-01 5.41113917E-02 + 7.51035774E-01 2.16440731E-01 1.790142150E-01 5.41142748E-02 + 7.51139052E-01 2.16472927E-01 1.792098470E-01 5.41171616E-02 + 7.51242330E-01 2.16505126E-01 1.794056800E-01 5.41200519E-02 + 7.51345607E-01 2.16537329E-01 1.796017150E-01 5.41229459E-02 + 7.51448885E-01 2.16569536E-01 1.797979520E-01 5.41258435E-02 + 7.51552163E-01 2.16601746E-01 1.799943910E-01 5.41287447E-02 + 7.51655441E-01 2.16633960E-01 1.801910320E-01 5.41316495E-02 + 7.51758718E-01 2.16666177E-01 1.803878760E-01 5.41345580E-02 + 7.51861996E-01 2.16698398E-01 1.805849230E-01 5.41374702E-02 + 7.51965274E-01 2.16730622E-01 1.807821720E-01 5.41403860E-02 + 7.52068552E-01 2.16762850E-01 1.809796250E-01 5.41433054E-02 + 7.52171829E-01 2.16795082E-01 1.811772810E-01 5.41462285E-02 + 7.52275107E-01 2.16827317E-01 1.813751410E-01 5.41491553E-02 + 7.52378385E-01 2.16859555E-01 1.815732050E-01 5.41520857E-02 + 7.52481663E-01 2.16891797E-01 1.817714730E-01 5.41550198E-02 + 7.52584940E-01 2.16924043E-01 1.819699450E-01 5.41579576E-02 + 7.52688218E-01 2.16956292E-01 1.821686210E-01 5.41608990E-02 + 7.52791496E-01 2.16988545E-01 1.823675020E-01 5.41638442E-02 + 7.52894774E-01 2.17020802E-01 1.825665890E-01 5.41667930E-02 + 7.52998051E-01 2.17053062E-01 1.827658800E-01 5.41697455E-02 + 7.53101329E-01 2.17085325E-01 1.829653770E-01 5.41727017E-02 + 7.53204607E-01 2.17117592E-01 1.831650790E-01 5.41756617E-02 + 7.53307884E-01 2.17149863E-01 1.833649870E-01 5.41786253E-02 + 7.53411162E-01 2.17182138E-01 1.835651010E-01 5.41815926E-02 + 7.53514440E-01 2.17214416E-01 1.837654220E-01 5.41845637E-02 + 7.53617718E-01 2.17246697E-01 1.839659490E-01 5.41875384E-02 + 7.53720995E-01 2.17278983E-01 1.841666820E-01 5.41905169E-02 + 7.53824273E-01 2.17311271E-01 1.843676230E-01 5.41934991E-02 + 7.53927551E-01 2.17343564E-01 1.845687710E-01 5.41964851E-02 + 7.54030829E-01 2.17375860E-01 1.847701260E-01 5.41994748E-02 + 7.54134106E-01 2.17408160E-01 1.849716880E-01 5.42024682E-02 + 7.54237384E-01 2.17440463E-01 1.851734590E-01 5.42054654E-02 + 7.54340662E-01 2.17472770E-01 1.853754370E-01 5.42084663E-02 + 7.54443940E-01 2.17505081E-01 1.855776240E-01 5.42114710E-02 + 7.54547217E-01 2.17537395E-01 1.857800190E-01 5.42144795E-02 + 7.54650495E-01 2.17569713E-01 1.859826230E-01 5.42174917E-02 + 7.54753773E-01 2.17602035E-01 1.861854360E-01 5.42205077E-02 + 7.54857051E-01 2.17634360E-01 1.863884580E-01 5.42235274E-02 + 7.54960328E-01 2.17666689E-01 1.865916900E-01 5.42265509E-02 + 7.55063606E-01 2.17699022E-01 1.867951310E-01 5.42295782E-02 + 7.55166884E-01 2.17731358E-01 1.869987810E-01 5.42326093E-02 + 7.55270162E-01 2.17763698E-01 1.872026420E-01 5.42356442E-02 + 7.55373439E-01 2.17796042E-01 1.874067130E-01 5.42386829E-02 + 7.55476717E-01 2.17828390E-01 1.876109950E-01 5.42417254E-02 + 7.55579995E-01 2.17860741E-01 1.878154880E-01 5.42447717E-02 + 7.55683273E-01 2.17893096E-01 1.880201910E-01 5.42478218E-02 + 7.55786550E-01 2.17925454E-01 1.882251050E-01 5.42508757E-02 + 7.55889828E-01 2.17957816E-01 1.884302310E-01 5.42539335E-02 + 7.55993106E-01 2.17990182E-01 1.886355690E-01 5.42569950E-02 + 7.56096384E-01 2.18022552E-01 1.888411180E-01 5.42600604E-02 + 7.56199661E-01 2.18054925E-01 1.890468800E-01 5.42631297E-02 + 7.56302939E-01 2.18087302E-01 1.892528540E-01 5.42662027E-02 + 7.56406217E-01 2.18119683E-01 1.894590400E-01 5.42692796E-02 + 7.56509495E-01 2.18152068E-01 1.896654390E-01 5.42723604E-02 + 7.56612772E-01 2.18184456E-01 1.898720520E-01 5.42754450E-02 + 7.56716050E-01 2.18216848E-01 1.900788770E-01 5.42785335E-02 + 7.56819328E-01 2.18249244E-01 1.902859160E-01 5.42816258E-02 + 7.56922606E-01 2.18281643E-01 1.904931680E-01 5.42847220E-02 + 7.57025883E-01 2.18314046E-01 1.907006350E-01 5.42878220E-02 + 7.57129161E-01 2.18346454E-01 1.909083160E-01 5.42909260E-02 + 7.57232439E-01 2.18378864E-01 1.911162110E-01 5.42940338E-02 + 7.57335717E-01 2.18411279E-01 1.913243200E-01 5.42971455E-02 + 7.57438994E-01 2.18443697E-01 1.915326450E-01 5.43002611E-02 + 7.57542272E-01 2.18476119E-01 1.917411850E-01 5.43033805E-02 + 7.57645550E-01 2.18508545E-01 1.919499400E-01 5.43065039E-02 + 7.57748828E-01 2.18540975E-01 1.921589100E-01 5.43096312E-02 + 7.57852105E-01 2.18573408E-01 1.923680960E-01 5.43127624E-02 + 7.57955383E-01 2.18605846E-01 1.925774990E-01 5.43158975E-02 + 7.58058661E-01 2.18638287E-01 1.927871170E-01 5.43190365E-02 + 7.58161939E-01 2.18670732E-01 1.929969520E-01 5.43221794E-02 + 7.58265216E-01 2.18703180E-01 1.932070040E-01 5.43253263E-02 + 7.58368494E-01 2.18735633E-01 1.934172730E-01 5.43284771E-02 + 7.58471772E-01 2.18768089E-01 1.936277590E-01 5.43316318E-02 + 7.58575050E-01 2.18800549E-01 1.938384620E-01 5.43347905E-02 + 7.58678327E-01 2.18833013E-01 1.940493830E-01 5.43379531E-02 + 7.58781605E-01 2.18865481E-01 1.942605220E-01 5.43411197E-02 + 7.58884883E-01 2.18897953E-01 1.944718790E-01 5.43442902E-02 + 7.58988161E-01 2.18930428E-01 1.946834540E-01 5.43474647E-02 + 7.59091438E-01 2.18962907E-01 1.948952480E-01 5.43506432E-02 + 7.59194716E-01 2.18995390E-01 1.951072610E-01 5.43538256E-02 + 7.59297994E-01 2.19027877E-01 1.953194930E-01 5.43570120E-02 + 7.59401272E-01 2.19060368E-01 1.955319440E-01 5.43602024E-02 + 7.59504549E-01 2.19092863E-01 1.957446150E-01 5.43633967E-02 + 7.59607827E-01 2.19125362E-01 1.959575050E-01 5.43665951E-02 + 7.59711105E-01 2.19157864E-01 1.961706160E-01 5.43697974E-02 + 7.59814383E-01 2.19190370E-01 1.963839470E-01 5.43730038E-02 + 7.59917660E-01 2.19222881E-01 1.965974980E-01 5.43762141E-02 + 7.60020938E-01 2.19255395E-01 1.968112700E-01 5.43794285E-02 + 7.60124216E-01 2.19287913E-01 1.970252630E-01 5.43826468E-02 + 7.60227494E-01 2.19320434E-01 1.972394780E-01 5.43858692E-02 + 7.60330771E-01 2.19352960E-01 1.974539130E-01 5.43890956E-02 + 7.60434049E-01 2.19385490E-01 1.976685710E-01 5.43923261E-02 + 7.60537327E-01 2.19418023E-01 1.978834500E-01 5.43955605E-02 + 7.60640605E-01 2.19450561E-01 1.980985520E-01 5.43987990E-02 + 7.60743882E-01 2.19483102E-01 1.983138760E-01 5.44020416E-02 + 7.60847160E-01 2.19515648E-01 1.985294230E-01 5.44052882E-02 + 7.60950438E-01 2.19548197E-01 1.987451920E-01 5.44085388E-02 + 7.61053715E-01 2.19580750E-01 1.989611850E-01 5.44117935E-02 + 7.61156993E-01 2.19613307E-01 1.991774010E-01 5.44150523E-02 + 7.61260271E-01 2.19645868E-01 1.993938410E-01 5.44183151E-02 + 7.61363549E-01 2.19678433E-01 1.996105050E-01 5.44215820E-02 + 7.61466826E-01 2.19711002E-01 1.998273920E-01 5.44248530E-02 + 7.61570104E-01 2.19743575E-01 2.000445050E-01 5.44281281E-02 + 7.61673382E-01 2.19776152E-01 2.002618410E-01 5.44314072E-02 + 7.61776660E-01 2.19808732E-01 2.004794030E-01 5.44346905E-02 + 7.61879937E-01 2.19841317E-01 2.006971900E-01 5.44379778E-02 + 7.61983215E-01 2.19873906E-01 2.009152020E-01 5.44412692E-02 + 7.62086493E-01 2.19906499E-01 2.011334400E-01 5.44445648E-02 + 7.62189771E-01 2.19939095E-01 2.013519030E-01 5.44478644E-02 + 7.62293048E-01 2.19971696E-01 2.015705930E-01 5.44511682E-02 + 7.62396326E-01 2.20004301E-01 2.017895090E-01 5.44544761E-02 + 7.62499604E-01 2.20036909E-01 2.020086520E-01 5.44577881E-02 + 7.62602882E-01 2.20069522E-01 2.022280210E-01 5.44611043E-02 + 7.62706159E-01 2.20102139E-01 2.024476180E-01 5.44644245E-02 + 7.62809437E-01 2.20134759E-01 2.026674420E-01 5.44677490E-02 + 7.62912715E-01 2.20167384E-01 2.028874930E-01 5.44710775E-02 + 7.63015993E-01 2.20200012E-01 2.031077720E-01 5.44744103E-02 + 7.63119270E-01 2.20232645E-01 2.033282800E-01 5.44777471E-02 + 7.63222548E-01 2.20265282E-01 2.035490150E-01 5.44810882E-02 + 7.63325826E-01 2.20297923E-01 2.037699790E-01 5.44844334E-02 + 7.63429104E-01 2.20330567E-01 2.039911730E-01 5.44877828E-02 + 7.63532381E-01 2.20363216E-01 2.042125950E-01 5.44911363E-02 + 7.63635659E-01 2.20395869E-01 2.044342460E-01 5.44944941E-02 + 7.63738937E-01 2.20428526E-01 2.046561270E-01 5.44978560E-02 + 7.63842215E-01 2.20461187E-01 2.048782380E-01 5.45012221E-02 + 7.63945492E-01 2.20493852E-01 2.051005790E-01 5.45045924E-02 + 7.64048770E-01 2.20526521E-01 2.053231500E-01 5.45079669E-02 + 7.64152048E-01 2.20559194E-01 2.055459520E-01 5.45113456E-02 + 7.64255326E-01 2.20591871E-01 2.057689850E-01 5.45147286E-02 + 7.64358603E-01 2.20624553E-01 2.059922490E-01 5.45181157E-02 + 7.64461881E-01 2.20657238E-01 2.062157440E-01 5.45215071E-02 + 7.64565159E-01 2.20689927E-01 2.064394710E-01 5.45249027E-02 + 7.64668437E-01 2.20722621E-01 2.066634290E-01 5.45283025E-02 + 7.64771714E-01 2.20755319E-01 2.068876200E-01 5.45317066E-02 + 7.64874992E-01 2.20788020E-01 2.071120430E-01 5.45351149E-02 + 7.64978270E-01 2.20820726E-01 2.073366990E-01 5.45385275E-02 + 7.65081548E-01 2.20853436E-01 2.075615870E-01 5.45419443E-02 + 7.65184825E-01 2.20886150E-01 2.077867090E-01 5.45453653E-02 + 7.65288103E-01 2.20918868E-01 2.080120640E-01 5.45487907E-02 + 7.65391381E-01 2.20951591E-01 2.082376530E-01 5.45522203E-02 + 7.65494659E-01 2.20984317E-01 2.084634760E-01 5.45556541E-02 + 7.65597936E-01 2.21017048E-01 2.086895320E-01 5.45590923E-02 + 7.65701214E-01 2.21049782E-01 2.089158240E-01 5.45625347E-02 + 7.65804492E-01 2.21082521E-01 2.091423490E-01 5.45659815E-02 + 7.65907770E-01 2.21115264E-01 2.093691100E-01 5.45694325E-02 + 7.66011047E-01 2.21148011E-01 2.095961060E-01 5.45728878E-02 + 7.66114325E-01 2.21180762E-01 2.098233380E-01 5.45763474E-02 + 7.66217603E-01 2.21213518E-01 2.100508050E-01 5.45798114E-02 + 7.66320881E-01 2.21246278E-01 2.102785080E-01 5.45832796E-02 + 7.66424158E-01 2.21279041E-01 2.105064470E-01 5.45867522E-02 + 7.66527436E-01 2.21311809E-01 2.107346230E-01 5.45902291E-02 + 7.66630714E-01 2.21344581E-01 2.109630360E-01 5.45937103E-02 + 7.66733992E-01 2.21377358E-01 2.111916850E-01 5.45971959E-02 + 7.66837269E-01 2.21410138E-01 2.114205720E-01 5.46006858E-02 + 7.66940547E-01 2.21442923E-01 2.116496970E-01 5.46041800E-02 + 7.67043825E-01 2.21475712E-01 2.118790590E-01 5.46076786E-02 + 7.67147103E-01 2.21508505E-01 2.121086590E-01 5.46111816E-02 + 7.67250380E-01 2.21541302E-01 2.123384980E-01 5.46146889E-02 + 7.67353658E-01 2.21574104E-01 2.125685750E-01 5.46182006E-02 + 7.67456936E-01 2.21606910E-01 2.127988910E-01 5.46217167E-02 + 7.67560214E-01 2.21639720E-01 2.130294460E-01 5.46252371E-02 + 7.67663491E-01 2.21672534E-01 2.132602400E-01 5.46287620E-02 + 7.67766769E-01 2.21705352E-01 2.134912750E-01 5.46322912E-02 + 7.67870047E-01 2.21738175E-01 2.137225490E-01 5.46358248E-02 + 7.67973325E-01 2.21771002E-01 2.139540630E-01 5.46393628E-02 + 7.68076602E-01 2.21803833E-01 2.141858170E-01 5.46429052E-02 + 7.68179880E-01 2.21836668E-01 2.144178130E-01 5.46464520E-02 + 7.68283158E-01 2.21869508E-01 2.146500490E-01 5.46500033E-02 + 7.68386436E-01 2.21902352E-01 2.148825270E-01 5.46535590E-02 + 7.68489713E-01 2.21935200E-01 2.151152460E-01 5.46571190E-02 + 7.68592991E-01 2.21968053E-01 2.153482070E-01 5.46606836E-02 + 7.68696269E-01 2.22000909E-01 2.155814100E-01 5.46642525E-02 + 7.68799546E-01 2.22033770E-01 2.158148550E-01 5.46678259E-02 + 7.68902824E-01 2.22066636E-01 2.160485420E-01 5.46714038E-02 + 7.69006102E-01 2.22099505E-01 2.162824730E-01 5.46749861E-02 + 7.69109380E-01 2.22132379E-01 2.165166470E-01 5.46785729E-02 + 7.69212657E-01 2.22165257E-01 2.167510640E-01 5.46821641E-02 + 7.69315935E-01 2.22198140E-01 2.169857250E-01 5.46857598E-02 + 7.69419213E-01 2.22231027E-01 2.172206290E-01 5.46893600E-02 + 7.69522491E-01 2.22263918E-01 2.174557780E-01 5.46929646E-02 + 7.69625768E-01 2.22296813E-01 2.176911720E-01 5.46965738E-02 + 7.69729046E-01 2.22329713E-01 2.179268100E-01 5.47001874E-02 + 7.69832324E-01 2.22362617E-01 2.181626930E-01 5.47038055E-02 + 7.69935602E-01 2.22395526E-01 2.183988210E-01 5.47074282E-02 + 7.70038879E-01 2.22428438E-01 2.186351950E-01 5.47110553E-02 + 7.70142157E-01 2.22461356E-01 2.188718150E-01 5.47146870E-02 + 7.70245435E-01 2.22494277E-01 2.191086810E-01 5.47183231E-02 + 7.70348713E-01 2.22527203E-01 2.193457930E-01 5.47219638E-02 + 7.70451990E-01 2.22560133E-01 2.195831520E-01 5.47256091E-02 + 7.70555268E-01 2.22593068E-01 2.198207580E-01 5.47292588E-02 + 7.70658546E-01 2.22626007E-01 2.200586110E-01 5.47329131E-02 + 7.70761824E-01 2.22658950E-01 2.202967110E-01 5.47365720E-02 + 7.70865101E-01 2.22691898E-01 2.205350600E-01 5.47402354E-02 + 7.70968379E-01 2.22724850E-01 2.207736560E-01 5.47439033E-02 + 7.71071657E-01 2.22757806E-01 2.210125010E-01 5.47475759E-02 + 7.71174935E-01 2.22790767E-01 2.212515940E-01 5.47512530E-02 + 7.71278212E-01 2.22823732E-01 2.214909360E-01 5.47549346E-02 + 7.71381490E-01 2.22856702E-01 2.217305270E-01 5.47586209E-02 + 7.71484768E-01 2.22889676E-01 2.219703680E-01 5.47623117E-02 + 7.71588046E-01 2.22922654E-01 2.222104580E-01 5.47660071E-02 + 7.71691323E-01 2.22955637E-01 2.224507980E-01 5.47697072E-02 + 7.71794601E-01 2.22988625E-01 2.226913890E-01 5.47734118E-02 + 7.71897879E-01 2.23021616E-01 2.229322300E-01 5.47771210E-02 + 7.72001157E-01 2.23054613E-01 2.231733220E-01 5.47808349E-02 + 7.72104434E-01 2.23087613E-01 2.234146650E-01 5.47845533E-02 + 7.72207712E-01 2.23120618E-01 2.236562590E-01 5.47882764E-02 + 7.72310990E-01 2.23153628E-01 2.238981050E-01 5.47920041E-02 + 7.72414268E-01 2.23186642E-01 2.241402030E-01 5.47957365E-02 + 7.72517545E-01 2.23219660E-01 2.243825530E-01 5.47994735E-02 + 7.72620823E-01 2.23252683E-01 2.246251550E-01 5.48032151E-02 + 7.72724101E-01 2.23285711E-01 2.248680110E-01 5.48069614E-02 + 7.72827379E-01 2.23318743E-01 2.251111190E-01 5.48107124E-02 + 7.72930656E-01 2.23351779E-01 2.253544810E-01 5.48144680E-02 + 7.73033934E-01 2.23384820E-01 2.255980970E-01 5.48182283E-02 + 7.73137212E-01 2.23417865E-01 2.258419660E-01 5.48219933E-02 + 7.73240490E-01 2.23450915E-01 2.260860900E-01 5.48257629E-02 + 7.73343767E-01 2.23483969E-01 2.263304680E-01 5.48295372E-02 + 7.73447045E-01 2.23517028E-01 2.265751000E-01 5.48333163E-02 + 7.73550323E-01 2.23550091E-01 2.268199880E-01 5.48371000E-02 + 7.73653601E-01 2.23583159E-01 2.270651320E-01 5.48408884E-02 + 7.73756878E-01 2.23616232E-01 2.273105300E-01 5.48446816E-02 + 7.73860156E-01 2.23649308E-01 2.275561850E-01 5.48484794E-02 + 7.73963434E-01 2.23682390E-01 2.278020960E-01 5.48522820E-02 + 7.74066712E-01 2.23715476E-01 2.280482640E-01 5.48560893E-02 + 7.74169989E-01 2.23748566E-01 2.282946880E-01 5.48599013E-02 + 7.74273267E-01 2.23781661E-01 2.285413690E-01 5.48637181E-02 + 7.74376545E-01 2.23814761E-01 2.287883080E-01 5.48675396E-02 + 7.74479823E-01 2.23847865E-01 2.290355040E-01 5.48713659E-02 + 7.74583100E-01 2.23880974E-01 2.292829590E-01 5.48751969E-02 + 7.74686378E-01 2.23914087E-01 2.295306710E-01 5.48790327E-02 + 7.74789656E-01 2.23947205E-01 2.297786420E-01 5.48828733E-02 + 7.74892934E-01 2.23980328E-01 2.300268720E-01 5.48867186E-02 + 7.74996211E-01 2.24013455E-01 2.302753610E-01 5.48905687E-02 + 7.75099489E-01 2.24046586E-01 2.305241090E-01 5.48944236E-02 + 7.75202767E-01 2.24079722E-01 2.307731170E-01 5.48982833E-02 + 7.75306045E-01 2.24112863E-01 2.310223850E-01 5.49021478E-02 + 7.75409322E-01 2.24146009E-01 2.312719140E-01 5.49060171E-02 + 7.75512600E-01 2.24179159E-01 2.315217020E-01 5.49098912E-02 + 7.75615878E-01 2.24212313E-01 2.317717520E-01 5.49137701E-02 + 7.75719156E-01 2.24245473E-01 2.320220630E-01 5.49176538E-02 + 7.75822433E-01 2.24278637E-01 2.322726350E-01 5.49215424E-02 + 7.75925711E-01 2.24311805E-01 2.325234690E-01 5.49254358E-02 + 7.76028989E-01 2.24344978E-01 2.327745650E-01 5.49293340E-02 + 7.76132267E-01 2.24378156E-01 2.330259240E-01 5.49332371E-02 + 7.76235544E-01 2.24411338E-01 2.332775450E-01 5.49371450E-02 + 7.76338822E-01 2.24444526E-01 2.335294290E-01 5.49410578E-02 + 7.76442100E-01 2.24477717E-01 2.337815760E-01 5.49449755E-02 + 7.76545378E-01 2.24510914E-01 2.340339870E-01 5.49488980E-02 + 7.76648655E-01 2.24544115E-01 2.342866610E-01 5.49528253E-02 + 7.76751933E-01 2.24577321E-01 2.345396000E-01 5.49567576E-02 + 7.76855211E-01 2.24610531E-01 2.347928030E-01 5.49606948E-02 + 7.76958488E-01 2.24643746E-01 2.350462710E-01 5.49646368E-02 + 7.77061766E-01 2.24676966E-01 2.353000040E-01 5.49685837E-02 + 7.77165044E-01 2.24710190E-01 2.355540020E-01 5.49725356E-02 + 7.77268322E-01 2.24743420E-01 2.358082660E-01 5.49764923E-02 + 7.77371599E-01 2.24776653E-01 2.360627950E-01 5.49804540E-02 + 7.77474877E-01 2.24809892E-01 2.363175910E-01 5.49844206E-02 + 7.77578155E-01 2.24843135E-01 2.365726540E-01 5.49883921E-02 + 7.77681433E-01 2.24876383E-01 2.368279830E-01 5.49923686E-02 + 7.77784710E-01 2.24909636E-01 2.370835790E-01 5.49963500E-02 + 7.77887988E-01 2.24942894E-01 2.373394430E-01 5.50003363E-02 + 7.77991266E-01 2.24976156E-01 2.375955750E-01 5.50043276E-02 + 7.78094544E-01 2.25009423E-01 2.378519740E-01 5.50083238E-02 + 7.78197821E-01 2.25042695E-01 2.381086420E-01 5.50123251E-02 + 7.78301099E-01 2.25075971E-01 2.383655790E-01 5.50163312E-02 + 7.78404377E-01 2.25109252E-01 2.386227840E-01 5.50203424E-02 + 7.78507655E-01 2.25142538E-01 2.388802590E-01 5.50243585E-02 + 7.78610932E-01 2.25175829E-01 2.391380030E-01 5.50283797E-02 + 7.78714210E-01 2.25209125E-01 2.393960180E-01 5.50324058E-02 + 7.78817488E-01 2.25242425E-01 2.396543020E-01 5.50364369E-02 + 7.78920766E-01 2.25275730E-01 2.399128570E-01 5.50404731E-02 + 7.79024043E-01 2.25309040E-01 2.401716830E-01 5.50445142E-02 + 7.79127321E-01 2.25342355E-01 2.404307800E-01 5.50485604E-02 + 7.79230599E-01 2.25375674E-01 2.406901480E-01 5.50526116E-02 + 7.79333877E-01 2.25408998E-01 2.409497880E-01 5.50566678E-02 + 7.79437154E-01 2.25442328E-01 2.412097000E-01 5.50607290E-02 + 7.79540432E-01 2.25475662E-01 2.414698840E-01 5.50647953E-02 + 7.79643710E-01 2.25509000E-01 2.417303410E-01 5.50688667E-02 + 7.79746988E-01 2.25542344E-01 2.419910710E-01 5.50729431E-02 + 7.79850265E-01 2.25575692E-01 2.422520740E-01 5.50770246E-02 + 7.79953543E-01 2.25609045E-01 2.425133510E-01 5.50811111E-02 + 7.80056821E-01 2.25642404E-01 2.427749020E-01 5.50852027E-02 + 7.80160099E-01 2.25675767E-01 2.430367260E-01 5.50892994E-02 + 7.80263376E-01 2.25709134E-01 2.432988260E-01 5.50934012E-02 + 7.80366654E-01 2.25742507E-01 2.435612000E-01 5.50975081E-02 + 7.80469932E-01 2.25775884E-01 2.438238500E-01 5.51016201E-02 + 7.80573210E-01 2.25809267E-01 2.440867740E-01 5.51057372E-02 + 7.80676487E-01 2.25842654E-01 2.443499750E-01 5.51098593E-02 + 7.80779765E-01 2.25876046E-01 2.446134520E-01 5.51139867E-02 + 7.80883043E-01 2.25909443E-01 2.448772050E-01 5.51181191E-02 + 7.80986321E-01 2.25942845E-01 2.451412350E-01 5.51222567E-02 + 7.81089598E-01 2.25976252E-01 2.454055420E-01 5.51263994E-02 + 7.81192876E-01 2.26009664E-01 2.456701260E-01 5.51305472E-02 + 7.81296154E-01 2.26043080E-01 2.459349880E-01 5.51347002E-02 + 7.81399432E-01 2.26076502E-01 2.462001280E-01 5.51388584E-02 + 7.81502709E-01 2.26109928E-01 2.464655470E-01 5.51430217E-02 + 7.81605987E-01 2.26143360E-01 2.467312440E-01 5.51471902E-02 + 7.81709265E-01 2.26176796E-01 2.469972190E-01 5.51513639E-02 + 7.81812543E-01 2.26210238E-01 2.472634750E-01 5.51555427E-02 + 7.81915820E-01 2.26243684E-01 2.475300090E-01 5.51597267E-02 + 7.82019098E-01 2.26277135E-01 2.477968240E-01 5.51639160E-02 + 7.82122376E-01 2.26310591E-01 2.480639190E-01 5.51681104E-02 + 7.82225654E-01 2.26344052E-01 2.483312950E-01 5.51723100E-02 + 7.82328931E-01 2.26377518E-01 2.485989510E-01 5.51765149E-02 + 7.82432209E-01 2.26410989E-01 2.488668890E-01 5.51807250E-02 + 7.82535487E-01 2.26444465E-01 2.491351080E-01 5.51849403E-02 + 7.82638765E-01 2.26477946E-01 2.494036090E-01 5.51891608E-02 + 7.82742042E-01 2.26511432E-01 2.496723920E-01 5.51933866E-02 + 7.82845320E-01 2.26544923E-01 2.499414580E-01 5.51976176E-02 + 7.82948598E-01 2.26578419E-01 2.502108060E-01 5.52018539E-02 + 7.83051876E-01 2.26611920E-01 2.504804380E-01 5.52060954E-02 + 7.83155153E-01 2.26645426E-01 2.507503530E-01 5.52103422E-02 + 7.83258431E-01 2.26678937E-01 2.510205520E-01 5.52145942E-02 + 7.83361709E-01 2.26712453E-01 2.512910350E-01 5.52188516E-02 + 7.83464987E-01 2.26745974E-01 2.515618020E-01 5.52231142E-02 + 7.83568264E-01 2.26779500E-01 2.518328550E-01 5.52273821E-02 + 7.83671542E-01 2.26813031E-01 2.521041920E-01 5.52316554E-02 + 7.83774820E-01 2.26846567E-01 2.523758150E-01 5.52359339E-02 + 7.83878098E-01 2.26880108E-01 2.526477240E-01 5.52402177E-02 + 7.83981375E-01 2.26913655E-01 2.529199180E-01 5.52445069E-02 + 7.84084653E-01 2.26947206E-01 2.531924000E-01 5.52488013E-02 + 7.84187931E-01 2.26980762E-01 2.534651670E-01 5.52531011E-02 + 7.84291209E-01 2.27014324E-01 2.537382230E-01 5.52574063E-02 + 7.84394486E-01 2.27047890E-01 2.540115650E-01 5.52617168E-02 + 7.84497764E-01 2.27081462E-01 2.542851950E-01 5.52660326E-02 + 7.84601042E-01 2.27115039E-01 2.545591140E-01 5.52703538E-02 + 7.84704319E-01 2.27148620E-01 2.548333200E-01 5.52746803E-02 + 7.84807597E-01 2.27182207E-01 2.551078160E-01 5.52790123E-02 + 7.84910875E-01 2.27215799E-01 2.553826000E-01 5.52833496E-02 + 7.85014153E-01 2.27249396E-01 2.556576740E-01 5.52876923E-02 + 7.85117430E-01 2.27282999E-01 2.559330380E-01 5.52920403E-02 + 7.85220708E-01 2.27316606E-01 2.562086920E-01 5.52963938E-02 + 7.85323986E-01 2.27350218E-01 2.564846370E-01 5.53007527E-02 + 7.85427264E-01 2.27383836E-01 2.567608720E-01 5.53051170E-02 + 7.85530541E-01 2.27417459E-01 2.570373980E-01 5.53094867E-02 + 7.85633819E-01 2.27451087E-01 2.573142160E-01 5.53138618E-02 + 7.85737097E-01 2.27484720E-01 2.575913250E-01 5.53182423E-02 + 7.85840375E-01 2.27518358E-01 2.578687270E-01 5.53226283E-02 + 7.85943652E-01 2.27552001E-01 2.581464210E-01 5.53270198E-02 + 7.86046930E-01 2.27585650E-01 2.584244070E-01 5.53314166E-02 + 7.86150208E-01 2.27619303E-01 2.587026870E-01 5.53358190E-02 + 7.86253486E-01 2.27652962E-01 2.589812610E-01 5.53402268E-02 + 7.86356763E-01 2.27686626E-01 2.592601280E-01 5.53446401E-02 + 7.86460041E-01 2.27720296E-01 2.595392900E-01 5.53490588E-02 + 7.86563319E-01 2.27753970E-01 2.598187460E-01 5.53534831E-02 + 7.86666597E-01 2.27787650E-01 2.600984960E-01 5.53579128E-02 + 7.86769874E-01 2.27821335E-01 2.603785420E-01 5.53623480E-02 + 7.86873152E-01 2.27855025E-01 2.606588840E-01 5.53667887E-02 + 7.86976430E-01 2.27888720E-01 2.609395210E-01 5.53712350E-02 + 7.87079708E-01 2.27922421E-01 2.612204550E-01 5.53756867E-02 + 7.87182985E-01 2.27956126E-01 2.615016850E-01 5.53801440E-02 + 7.87286263E-01 2.27989837E-01 2.617832120E-01 5.53846068E-02 + 7.87389541E-01 2.28023554E-01 2.620650370E-01 5.53890752E-02 + 7.87492819E-01 2.28057275E-01 2.623471590E-01 5.53935491E-02 + 7.87596096E-01 2.28091002E-01 2.626295790E-01 5.53980285E-02 + 7.87699374E-01 2.28124734E-01 2.629122970E-01 5.54025135E-02 + 7.87802652E-01 2.28158471E-01 2.631953140E-01 5.54070041E-02 + 7.87905930E-01 2.28192214E-01 2.634786300E-01 5.54115002E-02 + 7.88009207E-01 2.28225962E-01 2.637622450E-01 5.54160020E-02 + 7.88112485E-01 2.28259715E-01 2.640461600E-01 5.54205093E-02 + 7.88215763E-01 2.28293473E-01 2.643303750E-01 5.54250222E-02 + 7.88319041E-01 2.28327237E-01 2.646148900E-01 5.54295407E-02 + 7.88422318E-01 2.28361006E-01 2.648997060E-01 5.54340648E-02 + 7.88525596E-01 2.28394780E-01 2.651848230E-01 5.54385945E-02 + 7.88628874E-01 2.28428560E-01 2.654702420E-01 5.54431298E-02 + 7.88732152E-01 2.28462345E-01 2.657559630E-01 5.54476708E-02 + 7.88835429E-01 2.28496135E-01 2.660419850E-01 5.54522174E-02 + 7.88938707E-01 2.28529931E-01 2.663283100E-01 5.54567697E-02 + 7.89041985E-01 2.28563732E-01 2.666149380E-01 5.54613276E-02 + 7.89145263E-01 2.28597538E-01 2.669018700E-01 5.54658911E-02 + 7.89248540E-01 2.28631350E-01 2.671891050E-01 5.54704603E-02 + 7.89351818E-01 2.28665167E-01 2.674766430E-01 5.54750352E-02 + 7.89455096E-01 2.28698989E-01 2.677644860E-01 5.54796158E-02 + 7.89558374E-01 2.28732817E-01 2.680526340E-01 5.54842020E-02 + 7.89661651E-01 2.28766650E-01 2.683410870E-01 5.54887940E-02 + 7.89764929E-01 2.28800488E-01 2.686298450E-01 5.54933916E-02 + 7.89868207E-01 2.28834332E-01 2.689189080E-01 5.54979950E-02 + 7.89971485E-01 2.28868181E-01 2.692082780E-01 5.55026040E-02 + 7.90074762E-01 2.28902036E-01 2.694979550E-01 5.55072188E-02 + 7.90178040E-01 2.28935896E-01 2.697879380E-01 5.55118393E-02 + 7.90281318E-01 2.28969762E-01 2.700782280E-01 5.55164655E-02 + 7.90384596E-01 2.29003633E-01 2.703688260E-01 5.55210975E-02 + 7.90487873E-01 2.29037509E-01 2.706597310E-01 5.55257352E-02 + 7.90591151E-01 2.29071391E-01 2.709509450E-01 5.55303787E-02 + 7.90694429E-01 2.29105278E-01 2.712424680E-01 5.55350279E-02 + 7.90797707E-01 2.29139170E-01 2.715342990E-01 5.55396829E-02 + 7.90900984E-01 2.29173068E-01 2.718264400E-01 5.55443437E-02 + 7.91004262E-01 2.29206972E-01 2.721188900E-01 5.55490103E-02 + 7.91107540E-01 2.29240881E-01 2.724116510E-01 5.55536826E-02 + 7.91210818E-01 2.29274795E-01 2.727047220E-01 5.55583608E-02 + 7.91314095E-01 2.29308715E-01 2.729981040E-01 5.55630448E-02 + 7.91417373E-01 2.29342641E-01 2.732917970E-01 5.55677345E-02 + 7.91520651E-01 2.29376572E-01 2.735858010E-01 5.55724301E-02 + 7.91623929E-01 2.29410508E-01 2.738801170E-01 5.55771315E-02 + 7.91727206E-01 2.29444450E-01 2.741747460E-01 5.55818388E-02 + 7.91830484E-01 2.29478397E-01 2.744696870E-01 5.55865519E-02 + 7.91933762E-01 2.29512350E-01 2.747649410E-01 5.55912708E-02 + 7.92037040E-01 2.29546308E-01 2.750605090E-01 5.55959956E-02 + 7.92140317E-01 2.29580272E-01 2.753563900E-01 5.56007263E-02 + 7.92243595E-01 2.29614242E-01 2.756525860E-01 5.56054628E-02 + 7.92346873E-01 2.29648216E-01 2.759490960E-01 5.56102052E-02 + 7.92450150E-01 2.29682197E-01 2.762459200E-01 5.56149535E-02 + 7.92553428E-01 2.29716183E-01 2.765430600E-01 5.56197077E-02 + 7.92656706E-01 2.29750175E-01 2.768405160E-01 5.56244678E-02 + 7.92759984E-01 2.29784172E-01 2.771382880E-01 5.56292338E-02 + 7.92863261E-01 2.29818174E-01 2.774363760E-01 5.56340057E-02 + 7.92966539E-01 2.29852183E-01 2.777347800E-01 5.56387835E-02 + 7.93069817E-01 2.29886196E-01 2.780335020E-01 5.56435672E-02 + 7.93173095E-01 2.29920216E-01 2.783325410E-01 5.56483569E-02 + 7.93276372E-01 2.29954241E-01 2.786318980E-01 5.56531526E-02 + 7.93379650E-01 2.29988271E-01 2.789315740E-01 5.56579542E-02 + 7.93482928E-01 2.30022308E-01 2.792315670E-01 5.56627617E-02 + 7.93586206E-01 2.30056349E-01 2.795318800E-01 5.56675752E-02 + 7.93689483E-01 2.30090397E-01 2.798325130E-01 5.56723947E-02 + 7.93792761E-01 2.30124450E-01 2.801334640E-01 5.56772202E-02 + 7.93896039E-01 2.30158508E-01 2.804347370E-01 5.56820516E-02 + 7.93999317E-01 2.30192573E-01 2.807363290E-01 5.56868890E-02 + 7.94102594E-01 2.30226642E-01 2.810382430E-01 5.56917325E-02 + 7.94205872E-01 2.30260718E-01 2.813404770E-01 5.56965820E-02 + 7.94309150E-01 2.30294799E-01 2.816430340E-01 5.57014374E-02 + 7.94412428E-01 2.30328886E-01 2.819459120E-01 5.57062989E-02 + 7.94515705E-01 2.30362979E-01 2.822491130E-01 5.57111665E-02 + 7.94618983E-01 2.30397077E-01 2.825526370E-01 5.57160401E-02 + 7.94722261E-01 2.30431181E-01 2.828564830E-01 5.57209197E-02 + 7.94825539E-01 2.30465290E-01 2.831606540E-01 5.57258054E-02 + 7.94928816E-01 2.30499405E-01 2.834651480E-01 5.57306971E-02 + 7.95032094E-01 2.30533526E-01 2.837699670E-01 5.57355949E-02 + 7.95135372E-01 2.30567653E-01 2.840751100E-01 5.57404988E-02 + 7.95238650E-01 2.30601785E-01 2.843805790E-01 5.57454088E-02 + 7.95341927E-01 2.30635923E-01 2.846863730E-01 5.57503249E-02 + 7.95445205E-01 2.30670067E-01 2.849924920E-01 5.57552470E-02 + 7.95548483E-01 2.30704216E-01 2.852989390E-01 5.57601753E-02 + 7.95651761E-01 2.30738371E-01 2.856057110E-01 5.57651097E-02 + 7.95755038E-01 2.30772532E-01 2.859128110E-01 5.57700502E-02 + 7.95858316E-01 2.30806699E-01 2.862202380E-01 5.57749969E-02 + 7.95961594E-01 2.30840871E-01 2.865279940E-01 5.57799497E-02 + 7.96064872E-01 2.30875049E-01 2.868360770E-01 5.57849086E-02 + 7.96168149E-01 2.30909233E-01 2.871444890E-01 5.57898737E-02 + 7.96271427E-01 2.30943423E-01 2.874532300E-01 5.57948450E-02 + 7.96374705E-01 2.30977618E-01 2.877623000E-01 5.57998224E-02 + 7.96477983E-01 2.31011820E-01 2.880717000E-01 5.58048060E-02 + 7.96581260E-01 2.31046027E-01 2.883814310E-01 5.58097958E-02 + 7.96684538E-01 2.31080239E-01 2.886914920E-01 5.58147918E-02 + 7.96787816E-01 2.31114458E-01 2.890018840E-01 5.58197940E-02 + 7.96891094E-01 2.31148683E-01 2.893126070E-01 5.58248023E-02 + 7.96994371E-01 2.31182913E-01 2.896236620E-01 5.58298170E-02 + 7.97097649E-01 2.31217149E-01 2.899350500E-01 5.58348378E-02 + 7.97200927E-01 2.31251391E-01 2.902467700E-01 5.58398648E-02 + 7.97304205E-01 2.31285638E-01 2.905588230E-01 5.58448982E-02 + 7.97407482E-01 2.31319892E-01 2.908712090E-01 5.58499377E-02 + 7.97510760E-01 2.31354151E-01 2.911839290E-01 5.58549835E-02 + 7.97614038E-01 2.31388416E-01 2.914969830E-01 5.58600356E-02 + 7.97717316E-01 2.31422688E-01 2.918103720E-01 5.58650939E-02 + 7.97820593E-01 2.31456964E-01 2.921240960E-01 5.58701585E-02 + 7.97923871E-01 2.31491247E-01 2.924381550E-01 5.58752294E-02 + 7.98027149E-01 2.31525536E-01 2.927525500E-01 5.58803066E-02 + 7.98130427E-01 2.31559831E-01 2.930672810E-01 5.58853901E-02 + 7.98233704E-01 2.31594131E-01 2.933823490E-01 5.58904800E-02 + 7.98336982E-01 2.31628437E-01 2.936977540E-01 5.58955761E-02 + 7.98440260E-01 2.31662750E-01 2.940134960E-01 5.59006785E-02 + 7.98543538E-01 2.31697068E-01 2.943295760E-01 5.59057873E-02 + 7.98646815E-01 2.31731392E-01 2.946459940E-01 5.59109025E-02 + 7.98750093E-01 2.31765722E-01 2.949627510E-01 5.59160239E-02 + 7.98853371E-01 2.31800058E-01 2.952798470E-01 5.59211518E-02 + 7.98956649E-01 2.31834400E-01 2.955972820E-01 5.59262860E-02 + 7.99059926E-01 2.31868747E-01 2.959150570E-01 5.59314266E-02 + 7.99163204E-01 2.31903101E-01 2.962331730E-01 5.59365735E-02 + 7.99266482E-01 2.31937461E-01 2.965516290E-01 5.59417269E-02 + 7.99369760E-01 2.31971826E-01 2.968704260E-01 5.59468866E-02 + 7.99473037E-01 2.32006198E-01 2.971895650E-01 5.59520528E-02 + 7.99576315E-01 2.32040576E-01 2.975090450E-01 5.59572254E-02 + 7.99679593E-01 2.32074959E-01 2.978288680E-01 5.59624044E-02 + 7.99782871E-01 2.32109349E-01 2.981490340E-01 5.59675898E-02 + 7.99886148E-01 2.32143744E-01 2.984695430E-01 5.59727816E-02 + 7.99989426E-01 2.32178146E-01 2.987903960E-01 5.59779799E-02 + 8.00092704E-01 2.32212553E-01 2.991115920E-01 5.59831847E-02 + 8.00195981E-01 2.32246967E-01 2.994331330E-01 5.59883959E-02 + 8.00299259E-01 2.32281387E-01 2.997550190E-01 5.59936136E-02 + 8.00402537E-01 2.32315812E-01 3.000772490E-01 5.59988378E-02 + 8.00505815E-01 2.32350244E-01 3.003998260E-01 5.60040684E-02 + 8.00609092E-01 2.32384681E-01 3.007227490E-01 5.60093056E-02 + 8.00712370E-01 2.32419125E-01 3.010460180E-01 5.60145492E-02 + 8.00815648E-01 2.32453575E-01 3.013696340E-01 5.60197994E-02 + 8.00918926E-01 2.32488031E-01 3.016935970E-01 5.60250561E-02 + 8.01022203E-01 2.32522493E-01 3.020179090E-01 5.60303193E-02 + 8.01125481E-01 2.32556961E-01 3.023425680E-01 5.60355891E-02 + 8.01228759E-01 2.32591435E-01 3.026675760E-01 5.60408653E-02 + 8.01332037E-01 2.32625915E-01 3.029929330E-01 5.60461482E-02 + 8.01435314E-01 2.32660401E-01 3.033186390E-01 5.60514376E-02 + 8.01538592E-01 2.32694893E-01 3.036446960E-01 5.60567336E-02 + 8.01641870E-01 2.32729392E-01 3.039711020E-01 5.60620361E-02 + 8.01745148E-01 2.32763896E-01 3.042978600E-01 5.60673452E-02 + 8.01848425E-01 2.32798407E-01 3.046249680E-01 5.60726610E-02 + 8.01951703E-01 2.32832924E-01 3.049524280E-01 5.60779833E-02 + 8.02054981E-01 2.32867447E-01 3.052802400E-01 5.60833122E-02 + 8.02158259E-01 2.32901976E-01 3.056084050E-01 5.60886478E-02 + 8.02261536E-01 2.32936511E-01 3.059369230E-01 5.60939900E-02 + 8.02364814E-01 2.32971052E-01 3.062657930E-01 5.60993388E-02 + 8.02468092E-01 2.33005600E-01 3.065950180E-01 5.61046943E-02 + 8.02571370E-01 2.33040153E-01 3.069245960E-01 5.61100564E-02 + 8.02674647E-01 2.33074713E-01 3.072545300E-01 5.61154252E-02 + 8.02777925E-01 2.33109279E-01 3.075848180E-01 5.61208006E-02 + 8.02881203E-01 2.33143851E-01 3.079154620E-01 5.61261827E-02 + 8.02984481E-01 2.33178430E-01 3.082464610E-01 5.61315715E-02 + 8.03087758E-01 2.33213014E-01 3.085778170E-01 5.61369670E-02 + 8.03191036E-01 2.33247605E-01 3.089095300E-01 5.61423692E-02 + 8.03294314E-01 2.33282202E-01 3.092416000E-01 5.61477781E-02 + 8.03397592E-01 2.33316805E-01 3.095740280E-01 5.61531938E-02 + 8.03500869E-01 2.33351415E-01 3.099068130E-01 5.61586161E-02 + 8.03604147E-01 2.33386030E-01 3.102399580E-01 5.61640452E-02 + 8.03707425E-01 2.33420652E-01 3.105734610E-01 5.61694811E-02 + 8.03810703E-01 2.33455280E-01 3.109073230E-01 5.61749237E-02 + 8.03913980E-01 2.33489915E-01 3.112415460E-01 5.61803730E-02 + 8.04017258E-01 2.33524555E-01 3.115761290E-01 5.61858291E-02 + 8.04120536E-01 2.33559202E-01 3.119110720E-01 5.61912920E-02 + 8.04223814E-01 2.33593856E-01 3.122463770E-01 5.61967617E-02 + 8.04327091E-01 2.33628515E-01 3.125820430E-01 5.62022382E-02 + 8.04430369E-01 2.33663181E-01 3.129180710E-01 5.62077215E-02 + 8.04533647E-01 2.33697853E-01 3.132544620E-01 5.62132116E-02 + 8.04636925E-01 2.33732531E-01 3.135912150E-01 5.62187085E-02 + 8.04740202E-01 2.33767216E-01 3.139283320E-01 5.62242123E-02 + 8.04843480E-01 2.33801907E-01 3.142658130E-01 5.62297229E-02 + 8.04946758E-01 2.33836604E-01 3.146036580E-01 5.62352403E-02 + 8.05050036E-01 2.33871308E-01 3.149418680E-01 5.62407646E-02 + 8.05153313E-01 2.33906018E-01 3.152804430E-01 5.62462958E-02 + 8.05256591E-01 2.33940734E-01 3.156193840E-01 5.62518338E-02 + 8.05359869E-01 2.33975457E-01 3.159586910E-01 5.62573787E-02 + 8.05463147E-01 2.34010186E-01 3.162983640E-01 5.62629305E-02 + 8.05566424E-01 2.34044921E-01 3.166384050E-01 5.62684892E-02 + 8.05669702E-01 2.34079663E-01 3.169788120E-01 5.62740549E-02 + 8.05772980E-01 2.34114411E-01 3.173195880E-01 5.62796274E-02 + 8.05876258E-01 2.34149165E-01 3.176607320E-01 5.62852068E-02 + 8.05979535E-01 2.34183926E-01 3.180022450E-01 5.62907932E-02 + 8.06082813E-01 2.34218693E-01 3.183441270E-01 5.62963866E-02 + 8.06186091E-01 2.34253467E-01 3.186863780E-01 5.63019869E-02 + 8.06289369E-01 2.34288247E-01 3.190290000E-01 5.63075941E-02 + 8.06392646E-01 2.34323034E-01 3.193719930E-01 5.63132083E-02 + 8.06495924E-01 2.34357827E-01 3.197153560E-01 5.63188295E-02 + 8.06599202E-01 2.34392626E-01 3.200590910E-01 5.63244577E-02 + 8.06702480E-01 2.34427432E-01 3.204031980E-01 5.63300929E-02 + 8.06805757E-01 2.34462244E-01 3.207476780E-01 5.63357351E-02 + 8.06909035E-01 2.34497063E-01 3.210925300E-01 5.63413843E-02 + 8.07012313E-01 2.34531888E-01 3.214377560E-01 5.63470405E-02 + 8.07115591E-01 2.34566719E-01 3.217833560E-01 5.63527037E-02 + 8.07218868E-01 2.34601557E-01 3.221293300E-01 5.63583740E-02 + 8.07322146E-01 2.34636402E-01 3.224756780E-01 5.63640514E-02 + 8.07425424E-01 2.34671253E-01 3.228224020E-01 5.63697358E-02 + 8.07528702E-01 2.34706111E-01 3.231695020E-01 5.63754272E-02 + 8.07631979E-01 2.34740975E-01 3.235169780E-01 5.63811258E-02 + 8.07735257E-01 2.34775845E-01 3.238648300E-01 5.63868314E-02 + 8.07838535E-01 2.34810722E-01 3.242130600E-01 5.63925441E-02 + 8.07941813E-01 2.34845606E-01 3.245616670E-01 5.63982640E-02 + 8.08045090E-01 2.34880496E-01 3.249106520E-01 5.64039909E-02 + 8.08148368E-01 2.34915393E-01 3.252600160E-01 5.64097250E-02 + 8.08251646E-01 2.34950296E-01 3.256097580E-01 5.64154662E-02 + 8.08354923E-01 2.34985205E-01 3.259598800E-01 5.64212145E-02 + 8.08458201E-01 2.35020122E-01 3.263103820E-01 5.64269700E-02 + 8.08561479E-01 2.35055045E-01 3.266612640E-01 5.64327326E-02 + 8.08664757E-01 2.35089974E-01 3.270125280E-01 5.64385024E-02 + 8.08768034E-01 2.35124910E-01 3.273641720E-01 5.64442794E-02 + 8.08871312E-01 2.35159853E-01 3.277161980E-01 5.64500636E-02 + 8.08974590E-01 2.35194802E-01 3.280686070E-01 5.64558549E-02 + 8.09077868E-01 2.35229758E-01 3.284213980E-01 5.64616535E-02 + 8.09181145E-01 2.35264720E-01 3.287745730E-01 5.64674592E-02 + 8.09284423E-01 2.35299689E-01 3.291281310E-01 5.64732722E-02 + 8.09387701E-01 2.35334665E-01 3.294820740E-01 5.64790925E-02 + 8.09490979E-01 2.35369647E-01 3.298364010E-01 5.64849199E-02 + 8.09594256E-01 2.35404636E-01 3.301911140E-01 5.64907546E-02 + 8.09697534E-01 2.35439631E-01 3.305462120E-01 5.64965966E-02 + 8.09800812E-01 2.35474633E-01 3.309016960E-01 5.65024459E-02 + 8.09904090E-01 2.35509642E-01 3.312575660E-01 5.65083024E-02 + 8.10007367E-01 2.35544658E-01 3.316138240E-01 5.65141662E-02 + 8.10110645E-01 2.35579680E-01 3.319704700E-01 5.65200373E-02 + 8.10213923E-01 2.35614709E-01 3.323275030E-01 5.65259157E-02 + 8.10317201E-01 2.35649744E-01 3.326849250E-01 5.65318014E-02 + 8.10420478E-01 2.35684786E-01 3.330427360E-01 5.65376944E-02 + 8.10523756E-01 2.35719835E-01 3.334009360E-01 5.65435948E-02 + 8.10627034E-01 2.35754891E-01 3.337595270E-01 5.65495025E-02 + 8.10730312E-01 2.35789953E-01 3.341185080E-01 5.65554176E-02 + 8.10833589E-01 2.35825022E-01 3.344778800E-01 5.65613400E-02 + 8.10936867E-01 2.35860098E-01 3.348376430E-01 5.65672698E-02 + 8.11040145E-01 2.35895181E-01 3.351977990E-01 5.65732070E-02 + 8.11143423E-01 2.35930270E-01 3.355583460E-01 5.65791515E-02 + 8.11246700E-01 2.35965366E-01 3.359192870E-01 5.65851035E-02 + 8.11349978E-01 2.36000469E-01 3.362806210E-01 5.65910629E-02 + 8.11453256E-01 2.36035578E-01 3.366423490E-01 5.65970296E-02 + 8.11556534E-01 2.36070695E-01 3.370044720E-01 5.66030039E-02 + 8.11659811E-01 2.36105818E-01 3.373669900E-01 5.66089855E-02 + 8.11763089E-01 2.36140947E-01 3.377299020E-01 5.66149746E-02 + 8.11866367E-01 2.36176084E-01 3.380932110E-01 5.66209712E-02 + 8.11969645E-01 2.36211228E-01 3.384569160E-01 5.66269752E-02 + 8.12072922E-01 2.36246378E-01 3.388210190E-01 5.66329867E-02 + 8.12176200E-01 2.36281535E-01 3.391855180E-01 5.66390056E-02 + 8.12279478E-01 2.36316699E-01 3.395504160E-01 5.66450321E-02 + 8.12382756E-01 2.36351870E-01 3.399157110E-01 5.66510661E-02 + 8.12486033E-01 2.36387047E-01 3.402814060E-01 5.66571075E-02 + 8.12589311E-01 2.36422232E-01 3.406475000E-01 5.66631565E-02 + 8.12692589E-01 2.36457423E-01 3.410139940E-01 5.66692131E-02 + 8.12795867E-01 2.36492621E-01 3.413808890E-01 5.66752771E-02 + 8.12899144E-01 2.36527826E-01 3.417481840E-01 5.66813488E-02 + 8.13002422E-01 2.36563038E-01 3.421158810E-01 5.66874279E-02 + 8.13105700E-01 2.36598257E-01 3.424839800E-01 5.66935147E-02 + 8.13208978E-01 2.36633482E-01 3.428524820E-01 5.66996090E-02 + 8.13312255E-01 2.36668715E-01 3.432213860E-01 5.67057110E-02 + 8.13415533E-01 2.36703954E-01 3.435906940E-01 5.67118205E-02 + 8.13518811E-01 2.36739200E-01 3.439604050E-01 5.67179376E-02 + 8.13622089E-01 2.36774454E-01 3.443305210E-01 5.67240624E-02 + 8.13725366E-01 2.36809714E-01 3.447010430E-01 5.67301947E-02 + 8.13828644E-01 2.36844981E-01 3.450719690E-01 5.67363348E-02 + 8.13931922E-01 2.36880255E-01 3.454433020E-01 5.67424824E-02 + 8.14035200E-01 2.36915536E-01 3.458150410E-01 5.67486377E-02 + 8.14138477E-01 2.36950824E-01 3.461871880E-01 5.67548007E-02 + 8.14241755E-01 2.36986119E-01 3.465597420E-01 5.67609714E-02 + 8.14345033E-01 2.37021421E-01 3.469327040E-01 5.67671497E-02 + 8.14448311E-01 2.37056730E-01 3.473060740E-01 5.67733358E-02 + 8.14551588E-01 2.37092046E-01 3.476798540E-01 5.67795296E-02 + 8.14654866E-01 2.37127368E-01 3.480540440E-01 5.67857310E-02 + 8.14758144E-01 2.37162698E-01 3.484286430E-01 5.67919402E-02 + 8.14861422E-01 2.37198035E-01 3.488036530E-01 5.67981572E-02 + 8.14964699E-01 2.37233379E-01 3.491790750E-01 5.68043819E-02 + 8.15067977E-01 2.37268730E-01 3.495549080E-01 5.68106143E-02 + 8.15171255E-01 2.37304088E-01 3.499311540E-01 5.68168545E-02 + 8.15274533E-01 2.37339453E-01 3.503078120E-01 5.68231025E-02 + 8.15377810E-01 2.37374825E-01 3.506848830E-01 5.68293583E-02 + 8.15481088E-01 2.37410204E-01 3.510623690E-01 5.68356218E-02 + 8.15584366E-01 2.37445590E-01 3.514402690E-01 5.68418932E-02 + 8.15687644E-01 2.37480983E-01 3.518185830E-01 5.68481724E-02 + 8.15790921E-01 2.37516383E-01 3.521973130E-01 5.68544594E-02 + 8.15894199E-01 2.37551791E-01 3.525764590E-01 5.68607542E-02 + 8.15997477E-01 2.37587205E-01 3.529560220E-01 5.68670569E-02 + 8.16100754E-01 2.37622627E-01 3.533360010E-01 5.68733675E-02 + 8.16204032E-01 2.37658055E-01 3.537163980E-01 5.68796859E-02 + 8.16307310E-01 2.37693491E-01 3.540972130E-01 5.68860122E-02 + 8.16410588E-01 2.37728934E-01 3.544784470E-01 5.68923464E-02 + 8.16513865E-01 2.37764384E-01 3.548601000E-01 5.68986885E-02 + 8.16617143E-01 2.37799841E-01 3.552421720E-01 5.69050385E-02 + 8.16720421E-01 2.37835305E-01 3.556246650E-01 5.69113964E-02 + 8.16823699E-01 2.37870777E-01 3.560075790E-01 5.69177622E-02 + 8.16926976E-01 2.37906255E-01 3.563909140E-01 5.69241360E-02 + 8.17030254E-01 2.37941741E-01 3.567746700E-01 5.69305177E-02 + 8.17133532E-01 2.37977234E-01 3.571588490E-01 5.69369074E-02 + 8.17236810E-01 2.38012734E-01 3.575434510E-01 5.69433050E-02 + 8.17340087E-01 2.38048241E-01 3.579284760E-01 5.69497106E-02 + 8.17443365E-01 2.38083756E-01 3.583139260E-01 5.69561243E-02 + 8.17546643E-01 2.38119277E-01 3.586998000E-01 5.69625459E-02 + 8.17649921E-01 2.38154806E-01 3.590860990E-01 5.69689755E-02 + 8.17753198E-01 2.38190342E-01 3.594728230E-01 5.69754131E-02 + 8.17856476E-01 2.38225886E-01 3.598599740E-01 5.69818588E-02 + 8.17959754E-01 2.38261436E-01 3.602475510E-01 5.69883125E-02 + 8.18063032E-01 2.38296994E-01 3.606355560E-01 5.69947743E-02 + 8.18166309E-01 2.38332559E-01 3.610239890E-01 5.70012441E-02 + 8.18269587E-01 2.38368132E-01 3.614128500E-01 5.70077220E-02 + 8.18372865E-01 2.38403711E-01 3.618021400E-01 5.70142080E-02 + 8.18476143E-01 2.38439298E-01 3.621918590E-01 5.70207020E-02 + 8.18579420E-01 2.38474892E-01 3.625820080E-01 5.70272042E-02 + 8.18682698E-01 2.38510494E-01 3.629725880E-01 5.70337145E-02 + 8.18785976E-01 2.38546102E-01 3.633635990E-01 5.70402329E-02 + 8.18889254E-01 2.38581718E-01 3.637550420E-01 5.70467595E-02 + 8.18992531E-01 2.38617342E-01 3.641469170E-01 5.70532942E-02 + 8.19095809E-01 2.38652972E-01 3.645392250E-01 5.70598370E-02 + 8.19199087E-01 2.38688610E-01 3.649319660E-01 5.70663880E-02 + 8.19302365E-01 2.38724256E-01 3.653251410E-01 5.70729472E-02 + 8.19405642E-01 2.38759908E-01 3.657187510E-01 5.70795146E-02 + 8.19508920E-01 2.38795568E-01 3.661127950E-01 5.70860901E-02 + 8.19612198E-01 2.38831236E-01 3.665072760E-01 5.70926739E-02 + 8.19715476E-01 2.38866910E-01 3.669021920E-01 5.70992659E-02 + 8.19818753E-01 2.38902593E-01 3.672975450E-01 5.71058662E-02 + 8.19922031E-01 2.38938282E-01 3.676933360E-01 5.71124746E-02 + 8.20025309E-01 2.38973979E-01 3.680895640E-01 5.71190913E-02 + 8.20128587E-01 2.39009683E-01 3.684862310E-01 5.71257163E-02 + 8.20231864E-01 2.39045395E-01 3.688833360E-01 5.71323496E-02 + 8.20335142E-01 2.39081114E-01 3.692808810E-01 5.71389911E-02 + 8.20438420E-01 2.39116840E-01 3.696788670E-01 5.71456409E-02 + 8.20541698E-01 2.39152574E-01 3.700772930E-01 5.71522991E-02 + 8.20644975E-01 2.39188316E-01 3.704761600E-01 5.71589655E-02 + 8.20748253E-01 2.39224065E-01 3.708754690E-01 5.71656403E-02 + 8.20851531E-01 2.39259821E-01 3.712752210E-01 5.71723234E-02 + 8.20954809E-01 2.39295585E-01 3.716754150E-01 5.71790149E-02 + 8.21058086E-01 2.39331356E-01 3.720760540E-01 5.71857147E-02 + 8.21161364E-01 2.39367135E-01 3.724771360E-01 5.71924229E-02 + 8.21264642E-01 2.39402921E-01 3.728786630E-01 5.71991394E-02 + 8.21367920E-01 2.39438714E-01 3.732806350E-01 5.72058644E-02 + 8.21471197E-01 2.39474515E-01 3.736830530E-01 5.72125977E-02 + 8.21574475E-01 2.39510324E-01 3.740859180E-01 5.72193395E-02 + 8.21677753E-01 2.39546140E-01 3.744892300E-01 5.72260897E-02 + 8.21781031E-01 2.39581964E-01 3.748929890E-01 5.72328483E-02 + 8.21884308E-01 2.39617795E-01 3.752971960E-01 5.72396154E-02 + 8.21987586E-01 2.39653634E-01 3.757018520E-01 5.72463909E-02 + 8.22090864E-01 2.39689480E-01 3.761069580E-01 5.72531749E-02 + 8.22194142E-01 2.39725334E-01 3.765125140E-01 5.72599674E-02 + 8.22297419E-01 2.39761196E-01 3.769185200E-01 5.72667684E-02 + 8.22400697E-01 2.39797065E-01 3.773249770E-01 5.72735778E-02 + 8.22503975E-01 2.39832941E-01 3.777318860E-01 5.72803958E-02 + 8.22607253E-01 2.39868825E-01 3.781392470E-01 5.72872223E-02 + 8.22710530E-01 2.39904717E-01 3.785470610E-01 5.72940573E-02 + 8.22813808E-01 2.39940617E-01 3.789553290E-01 5.73009009E-02 + 8.22917086E-01 2.39976523E-01 3.793640500E-01 5.73077530E-02 + 8.23020364E-01 2.40012438E-01 3.797732270E-01 5.73146137E-02 + 8.23123641E-01 2.40048360E-01 3.801828580E-01 5.73214830E-02 + 8.23226919E-01 2.40084290E-01 3.805929460E-01 5.73283609E-02 + 8.23330197E-01 2.40120228E-01 3.810034900E-01 5.73352473E-02 + 8.23433475E-01 2.40156173E-01 3.814144910E-01 5.73421424E-02 + 8.23536752E-01 2.40192126E-01 3.818259500E-01 5.73490461E-02 + 8.23640030E-01 2.40228086E-01 3.822378660E-01 5.73559584E-02 + 8.23743308E-01 2.40264054E-01 3.826502420E-01 5.73628794E-02 + 8.23846585E-01 2.40300030E-01 3.830630770E-01 5.73698090E-02 + 8.23949863E-01 2.40336014E-01 3.834763730E-01 5.73767473E-02 + 8.24053141E-01 2.40372005E-01 3.838901290E-01 5.73836943E-02 + 8.24156419E-01 2.40408004E-01 3.843043460E-01 5.73906500E-02 + 8.24259696E-01 2.40444010E-01 3.847190250E-01 5.73976144E-02 + 8.24362974E-01 2.40480025E-01 3.851341660E-01 5.74045874E-02 + 8.24466252E-01 2.40516047E-01 3.855497710E-01 5.74115693E-02 + 8.24569530E-01 2.40552077E-01 3.859658390E-01 5.74185598E-02 + 8.24672807E-01 2.40588114E-01 3.863823720E-01 5.74255591E-02 + 8.24776085E-01 2.40624160E-01 3.867993690E-01 5.74325671E-02 + 8.24879363E-01 2.40660213E-01 3.872168320E-01 5.74395839E-02 + 8.24982641E-01 2.40696274E-01 3.876347620E-01 5.74466095E-02 + 8.25085918E-01 2.40732342E-01 3.880531570E-01 5.74536439E-02 + 8.25189196E-01 2.40768419E-01 3.884720210E-01 5.74606871E-02 + 8.25292474E-01 2.40804503E-01 3.888913520E-01 5.74677391E-02 + 8.25395752E-01 2.40840595E-01 3.893111520E-01 5.74748000E-02 + 8.25499029E-01 2.40876695E-01 3.897314210E-01 5.74818697E-02 + 8.25602307E-01 2.40912803E-01 3.901521600E-01 5.74889482E-02 + 8.25705585E-01 2.40948918E-01 3.905733690E-01 5.74960356E-02 + 8.25808863E-01 2.40985042E-01 3.909950500E-01 5.75031318E-02 + 8.25912140E-01 2.41021173E-01 3.914172020E-01 5.75102370E-02 + 8.26015418E-01 2.41057312E-01 3.918398260E-01 5.75173510E-02 + 8.26118696E-01 2.41093459E-01 3.922629240E-01 5.75244740E-02 + 8.26221974E-01 2.41129614E-01 3.926864950E-01 5.75316058E-02 + 8.26325251E-01 2.41165776E-01 3.931105400E-01 5.75387466E-02 + 8.26428529E-01 2.41201947E-01 3.935350600E-01 5.75458964E-02 + 8.26531807E-01 2.41238125E-01 3.939600550E-01 5.75530551E-02 + 8.26635085E-01 2.41274312E-01 3.943855270E-01 5.75602228E-02 + 8.26738362E-01 2.41310506E-01 3.948114750E-01 5.75673994E-02 + 8.26841640E-01 2.41346708E-01 3.952379010E-01 5.75745850E-02 + 8.26944918E-01 2.41382918E-01 3.956648040E-01 5.75817797E-02 + 8.27048196E-01 2.41419136E-01 3.960921860E-01 5.75889833E-02 + 8.27151473E-01 2.41455362E-01 3.965200480E-01 5.75961960E-02 + 8.27254751E-01 2.41491596E-01 3.969483890E-01 5.76034177E-02 + 8.27358029E-01 2.41527838E-01 3.973772110E-01 5.76106485E-02 + 8.27461307E-01 2.41564088E-01 3.978065140E-01 5.76178883E-02 + 8.27564584E-01 2.41600346E-01 3.982362980E-01 5.76251372E-02 + 8.27667862E-01 2.41636612E-01 3.986665650E-01 5.76323952E-02 + 8.27771140E-01 2.41672885E-01 3.990973160E-01 5.76396622E-02 + 8.27874418E-01 2.41709167E-01 3.995285500E-01 5.76469384E-02 + 8.27977695E-01 2.41745457E-01 3.999602680E-01 5.76542237E-02 + 8.28080973E-01 2.41781755E-01 4.003924710E-01 5.76615182E-02 + 8.28184251E-01 2.41818061E-01 4.008251600E-01 5.76688217E-02 + 8.28287529E-01 2.41854375E-01 4.012583350E-01 5.76761345E-02 + 8.28390806E-01 2.41890697E-01 4.016919980E-01 5.76834564E-02 + 8.28494084E-01 2.41927027E-01 4.021261470E-01 5.76907875E-02 + 8.28597362E-01 2.41963365E-01 4.025607850E-01 5.76981278E-02 + 8.28700640E-01 2.41999711E-01 4.029959120E-01 5.77054772E-02 + 8.28803917E-01 2.42036065E-01 4.034315290E-01 5.77128359E-02 + 8.28907195E-01 2.42072428E-01 4.038676350E-01 5.77202039E-02 + 8.29010473E-01 2.42108798E-01 4.043042330E-01 5.77275810E-02 + 8.29113751E-01 2.42145177E-01 4.047413220E-01 5.77349675E-02 + 8.29217028E-01 2.42181563E-01 4.051789030E-01 5.77423632E-02 + 8.29320306E-01 2.42217958E-01 4.056169770E-01 5.77497681E-02 + 8.29423584E-01 2.42254361E-01 4.060555450E-01 5.77571824E-02 + 8.29526862E-01 2.42290772E-01 4.064946060E-01 5.77646059E-02 + 8.29630139E-01 2.42327191E-01 4.069341630E-01 5.77720388E-02 + 8.29733417E-01 2.42363619E-01 4.073742150E-01 5.77794810E-02 + 8.29836695E-01 2.42400054E-01 4.078147630E-01 5.77869325E-02 + 8.29939973E-01 2.42436498E-01 4.082558080E-01 5.77943934E-02 + 8.30043250E-01 2.42472950E-01 4.086973500E-01 5.78018637E-02 + 8.30146528E-01 2.42509410E-01 4.091393900E-01 5.78093433E-02 + 8.30249806E-01 2.42545878E-01 4.095819290E-01 5.78168323E-02 + 8.30353084E-01 2.42582354E-01 4.100249680E-01 5.78243307E-02 + 8.30456361E-01 2.42618839E-01 4.104685070E-01 5.78318386E-02 + 8.30559639E-01 2.42655332E-01 4.109125470E-01 5.78393558E-02 + 8.30662917E-01 2.42691833E-01 4.113570880E-01 5.78468825E-02 + 8.30766195E-01 2.42728343E-01 4.118021310E-01 5.78544186E-02 + 8.30869472E-01 2.42764860E-01 4.122476770E-01 5.78619642E-02 + 8.30972750E-01 2.42801386E-01 4.126937270E-01 5.78695193E-02 + 8.31076028E-01 2.42837920E-01 4.131402800E-01 5.78770839E-02 + 8.31179306E-01 2.42874463E-01 4.135873390E-01 5.78846579E-02 + 8.31282583E-01 2.42911013E-01 4.140349030E-01 5.78922415E-02 + 8.31385861E-01 2.42947572E-01 4.144829730E-01 5.78998346E-02 + 8.31489139E-01 2.42984139E-01 4.149315510E-01 5.79074372E-02 + 8.31592416E-01 2.43020715E-01 4.153806350E-01 5.79150494E-02 + 8.31695694E-01 2.43057299E-01 4.158302290E-01 5.79226712E-02 + 8.31798972E-01 2.43093891E-01 4.162803310E-01 5.79303025E-02 + 8.31902250E-01 2.43130492E-01 4.167309420E-01 5.79379434E-02 + 8.32005527E-01 2.43167101E-01 4.171820640E-01 5.79455939E-02 + 8.32108805E-01 2.43203718E-01 4.176336980E-01 5.79532541E-02 + 8.32212083E-01 2.43240344E-01 4.180858420E-01 5.79609238E-02 + 8.32315361E-01 2.43276978E-01 4.185384990E-01 5.79686032E-02 + 8.32418638E-01 2.43313620E-01 4.189916700E-01 5.79762923E-02 + 8.32521916E-01 2.43350271E-01 4.194453540E-01 5.79839910E-02 + 8.32625194E-01 2.43386930E-01 4.198995520E-01 5.79916994E-02 + 8.32728472E-01 2.43423597E-01 4.203542660E-01 5.79994174E-02 + 8.32831749E-01 2.43460273E-01 4.208094960E-01 5.80071452E-02 + 8.32935027E-01 2.43496958E-01 4.212652420E-01 5.80148827E-02 + 8.33038305E-01 2.43533651E-01 4.217215050E-01 5.80226299E-02 + 8.33141583E-01 2.43570352E-01 4.221782870E-01 5.80303869E-02 + 8.33244860E-01 2.43607062E-01 4.226355870E-01 5.80381536E-02 + 8.33348138E-01 2.43643780E-01 4.230934060E-01 5.80459301E-02 + 8.33451416E-01 2.43680506E-01 4.235517460E-01 5.80537164E-02 + 8.33554694E-01 2.43717241E-01 4.240106060E-01 5.80615124E-02 + 8.33657971E-01 2.43753985E-01 4.244699880E-01 5.80693183E-02 + 8.33761249E-01 2.43790737E-01 4.249298920E-01 5.80771340E-02 + 8.33864527E-01 2.43827498E-01 4.253903190E-01 5.80849595E-02 + 8.33967805E-01 2.43864267E-01 4.258512690E-01 5.80927948E-02 + 8.34071082E-01 2.43901044E-01 4.263127440E-01 5.81006401E-02 + 8.34174360E-01 2.43937830E-01 4.267747440E-01 5.81084952E-02 + 8.34277638E-01 2.43974625E-01 4.272372700E-01 5.81163601E-02 + 8.34380916E-01 2.44011428E-01 4.277003220E-01 5.81242350E-02 + 8.34484193E-01 2.44048240E-01 4.281639010E-01 5.81321198E-02 + 8.34587471E-01 2.44085060E-01 4.286280090E-01 5.81400145E-02 + 8.34690749E-01 2.44121889E-01 4.290926450E-01 5.81479191E-02 + 8.34794027E-01 2.44158727E-01 4.295578100E-01 5.81558337E-02 + 8.34897304E-01 2.44195573E-01 4.300235060E-01 5.81637583E-02 + 8.35000582E-01 2.44232428E-01 4.304897320E-01 5.81716928E-02 + 8.35103860E-01 2.44269291E-01 4.309564890E-01 5.81796374E-02 + 8.35207138E-01 2.44306163E-01 4.314237790E-01 5.81875919E-02 + 8.35310415E-01 2.44343043E-01 4.318916020E-01 5.81955564E-02 + 8.35413693E-01 2.44379932E-01 4.323599590E-01 5.82035310E-02 + 8.35516971E-01 2.44416830E-01 4.328288500E-01 5.82115156E-02 + 8.35620249E-01 2.44453736E-01 4.332982770E-01 5.82195103E-02 + 8.35723526E-01 2.44490652E-01 4.337682390E-01 5.82275150E-02 + 8.35826804E-01 2.44527575E-01 4.342387380E-01 5.82355299E-02 + 8.35930082E-01 2.44564508E-01 4.347097740E-01 5.82435548E-02 + 8.36033360E-01 2.44601449E-01 4.351813480E-01 5.82515898E-02 + 8.36136637E-01 2.44638399E-01 4.356534610E-01 5.82596350E-02 + 8.36239915E-01 2.44675357E-01 4.361261140E-01 5.82676903E-02 + 8.36343193E-01 2.44712324E-01 4.365993070E-01 5.82757557E-02 + 8.36446471E-01 2.44749300E-01 4.370730410E-01 5.82838313E-02 + 8.36549748E-01 2.44786285E-01 4.375473170E-01 5.82919171E-02 + 8.36653026E-01 2.44823278E-01 4.380221360E-01 5.83000131E-02 + 8.36756304E-01 2.44860281E-01 4.384974970E-01 5.83081193E-02 + 8.36859582E-01 2.44897292E-01 4.389734030E-01 5.83162357E-02 + 8.36962859E-01 2.44934311E-01 4.394498540E-01 5.83243623E-02 + 8.37066137E-01 2.44971340E-01 4.399268500E-01 5.83324992E-02 + 8.37169415E-01 2.45008377E-01 4.404043930E-01 5.83406464E-02 + 8.37272693E-01 2.45045423E-01 4.408824820E-01 5.83488038E-02 + 8.37375970E-01 2.45082478E-01 4.413611190E-01 5.83569715E-02 + 8.37479248E-01 2.45119542E-01 4.418403050E-01 5.83651495E-02 + 8.37582526E-01 2.45156614E-01 4.423200400E-01 5.83733378E-02 + 8.37685804E-01 2.45193695E-01 4.428003260E-01 5.83815364E-02 + 8.37789081E-01 2.45230785E-01 4.432811620E-01 5.83897454E-02 + 8.37892359E-01 2.45267884E-01 4.437625490E-01 5.83979648E-02 + 8.37995637E-01 2.45304992E-01 4.442444890E-01 5.84061945E-02 + 8.38098915E-01 2.45342109E-01 4.447269820E-01 5.84144346E-02 + 8.38202192E-01 2.45379235E-01 4.452100290E-01 5.84226851E-02 + 8.38305470E-01 2.45416369E-01 4.456936310E-01 5.84309460E-02 + 8.38408748E-01 2.45453512E-01 4.461777880E-01 5.84392173E-02 + 8.38512026E-01 2.45490665E-01 4.466625010E-01 5.84474991E-02 + 8.38615303E-01 2.45527826E-01 4.471477710E-01 5.84557913E-02 + 8.38718581E-01 2.45564996E-01 4.476335990E-01 5.84640940E-02 + 8.38821859E-01 2.45602175E-01 4.481199850E-01 5.84724072E-02 + 8.38925137E-01 2.45639363E-01 4.486069310E-01 5.84807308E-02 + 8.39028414E-01 2.45676560E-01 4.490944360E-01 5.84890650E-02 + 8.39131692E-01 2.45713766E-01 4.495825030E-01 5.84974097E-02 + 8.39234970E-01 2.45750981E-01 4.500711310E-01 5.85057650E-02 + 8.39338248E-01 2.45788205E-01 4.505603210E-01 5.85141308E-02 + 8.39441525E-01 2.45825437E-01 4.510500740E-01 5.85225071E-02 + 8.39544803E-01 2.45862679E-01 4.515403920E-01 5.85308941E-02 + 8.39648081E-01 2.45899930E-01 4.520312740E-01 5.85392916E-02 + 8.39751358E-01 2.45937190E-01 4.525227220E-01 5.85476997E-02 + 8.39854636E-01 2.45974459E-01 4.530147350E-01 5.85561185E-02 + 8.39957914E-01 2.46011736E-01 4.535073160E-01 5.85645479E-02 + 8.40061192E-01 2.46049023E-01 4.540004650E-01 5.85729879E-02 + 8.40164469E-01 2.46086319E-01 4.544941830E-01 5.85814387E-02 + 8.40267747E-01 2.46123624E-01 4.549884690E-01 5.85899001E-02 + 8.40371025E-01 2.46160938E-01 4.554833270E-01 5.85983722E-02 + 8.40474303E-01 2.46198262E-01 4.559787550E-01 5.86068550E-02 + 8.40577580E-01 2.46235594E-01 4.564747550E-01 5.86153485E-02 + 8.40680858E-01 2.46272935E-01 4.569713270E-01 5.86238527E-02 + 8.40784136E-01 2.46310286E-01 4.574684730E-01 5.86323678E-02 + 8.40887414E-01 2.46347645E-01 4.579661930E-01 5.86408935E-02 + 8.40990691E-01 2.46385014E-01 4.584644880E-01 5.86494301E-02 + 8.41093969E-01 2.46422392E-01 4.589633590E-01 5.86579775E-02 + 8.41197247E-01 2.46459779E-01 4.594628070E-01 5.86665356E-02 + 8.41300525E-01 2.46497175E-01 4.599628320E-01 5.86751046E-02 + 8.41403802E-01 2.46534580E-01 4.604634350E-01 5.86836845E-02 + 8.41507080E-01 2.46571994E-01 4.609646180E-01 5.86922751E-02 + 8.41610358E-01 2.46609418E-01 4.614663800E-01 5.87008767E-02 + 8.41713636E-01 2.46646851E-01 4.619687230E-01 5.87094891E-02 + 8.41816913E-01 2.46684293E-01 4.624716470E-01 5.87181125E-02 + 8.41920191E-01 2.46721744E-01 4.629751540E-01 5.87267467E-02 + 8.42023469E-01 2.46759205E-01 4.634792440E-01 5.87353919E-02 + 8.42126747E-01 2.46796674E-01 4.639839170E-01 5.87440480E-02 + 8.42230024E-01 2.46834153E-01 4.644891760E-01 5.87527151E-02 + 8.42333302E-01 2.46871641E-01 4.649950200E-01 5.87613931E-02 + 8.42436580E-01 2.46909139E-01 4.655014500E-01 5.87700822E-02 + 8.42539858E-01 2.46946645E-01 4.660084680E-01 5.87787822E-02 + 8.42643135E-01 2.46984161E-01 4.665160730E-01 5.87874932E-02 + 8.42746413E-01 2.47021686E-01 4.670242680E-01 5.87962153E-02 + 8.42849691E-01 2.47059221E-01 4.675330520E-01 5.88049484E-02 + 8.42952969E-01 2.47096765E-01 4.680424260E-01 5.88136926E-02 + 8.43056246E-01 2.47134318E-01 4.685523920E-01 5.88224479E-02 + 8.43159524E-01 2.47171880E-01 4.690629510E-01 5.88312142E-02 + 8.43262802E-01 2.47209452E-01 4.695741020E-01 5.88399917E-02 + 8.43366080E-01 2.47247033E-01 4.700858470E-01 5.88487803E-02 + 8.43469357E-01 2.47284624E-01 4.705981870E-01 5.88575800E-02 + 8.43572635E-01 2.47322223E-01 4.711111220E-01 5.88663908E-02 + 8.43675913E-01 2.47359833E-01 4.716246540E-01 5.88752129E-02 + 8.43779191E-01 2.47397451E-01 4.721387820E-01 5.88840461E-02 + 8.43882468E-01 2.47435079E-01 4.726535090E-01 5.88928905E-02 + 8.43985746E-01 2.47472716E-01 4.731688350E-01 5.89017461E-02 + 8.44089024E-01 2.47510363E-01 4.736847610E-01 5.89106130E-02 + 8.44192302E-01 2.47548019E-01 4.742012870E-01 5.89194910E-02 + 8.44295579E-01 2.47585685E-01 4.747184140E-01 5.89283804E-02 + 8.44398857E-01 2.47623360E-01 4.752361440E-01 5.89372810E-02 + 8.44502135E-01 2.47661044E-01 4.757544770E-01 5.89461929E-02 + 8.44605413E-01 2.47698738E-01 4.762734140E-01 5.89551161E-02 + 8.44708690E-01 2.47736442E-01 4.767929560E-01 5.89640506E-02 + 8.44811968E-01 2.47774154E-01 4.773131030E-01 5.89729965E-02 + 8.44915246E-01 2.47811877E-01 4.778338570E-01 5.89819537E-02 + 8.45018524E-01 2.47849609E-01 4.783552190E-01 5.89909223E-02 + 8.45121801E-01 2.47887350E-01 4.788771890E-01 5.89999022E-02 + 8.45225079E-01 2.47925101E-01 4.793997670E-01 5.90088936E-02 + 8.45328357E-01 2.47962861E-01 4.799229560E-01 5.90178963E-02 + 8.45431635E-01 2.48000631E-01 4.804467560E-01 5.90269105E-02 + 8.45534912E-01 2.48038410E-01 4.809711680E-01 5.90359361E-02 + 8.45638190E-01 2.48076199E-01 4.814961920E-01 5.90449732E-02 + 8.45741468E-01 2.48113998E-01 4.820218290E-01 5.90540218E-02 + 8.45844746E-01 2.48151806E-01 4.825480810E-01 5.90630818E-02 + 8.45948023E-01 2.48189624E-01 4.830749480E-01 5.90721533E-02 + 8.46051301E-01 2.48227451E-01 4.836024320E-01 5.90812364E-02 + 8.46154579E-01 2.48265288E-01 4.841305320E-01 5.90903310E-02 + 8.46257857E-01 2.48303134E-01 4.846592500E-01 5.90994372E-02 + 8.46361134E-01 2.48340990E-01 4.851885870E-01 5.91085549E-02 + 8.46464412E-01 2.48378856E-01 4.857185430E-01 5.91176842E-02 + 8.46567690E-01 2.48416731E-01 4.862491200E-01 5.91268251E-02 + 8.46670968E-01 2.48454616E-01 4.867803190E-01 5.91359776E-02 + 8.46774245E-01 2.48492511E-01 4.873121390E-01 5.91451417E-02 + 8.46877523E-01 2.48530415E-01 4.878445830E-01 5.91543175E-02 + 8.46980801E-01 2.48568329E-01 4.883776510E-01 5.91635050E-02 + 8.47084079E-01 2.48606253E-01 4.889113440E-01 5.91727041E-02 + 8.47187356E-01 2.48644186E-01 4.894456620E-01 5.91819149E-02 + 8.47290634E-01 2.48682129E-01 4.899806080E-01 5.91911375E-02 + 8.47393912E-01 2.48720082E-01 4.905161810E-01 5.92003717E-02 + 8.47497189E-01 2.48758045E-01 4.910523820E-01 5.92096177E-02 + 8.47600467E-01 2.48796017E-01 4.915892130E-01 5.92188755E-02 + 8.47703745E-01 2.48833999E-01 4.921266750E-01 5.92281450E-02 + 8.47807023E-01 2.48871991E-01 4.926647670E-01 5.92374263E-02 + 8.47910300E-01 2.48909992E-01 4.932034920E-01 5.92467194E-02 + 8.48013578E-01 2.48948004E-01 4.937428490E-01 5.92560244E-02 + 8.48116856E-01 2.48986025E-01 4.942828410E-01 5.92653412E-02 + 8.48220134E-01 2.49024055E-01 4.948234680E-01 5.92746698E-02 + 8.48323411E-01 2.49062096E-01 4.953647300E-01 5.92840103E-02 + 8.48426689E-01 2.49100147E-01 4.959066290E-01 5.92933627E-02 + 8.48529967E-01 2.49138207E-01 4.964491650E-01 5.93027270E-02 + 8.48633245E-01 2.49176277E-01 4.969923400E-01 5.93121032E-02 + 8.48736522E-01 2.49214357E-01 4.975361550E-01 5.93214914E-02 + 8.48839800E-01 2.49252447E-01 4.980806100E-01 5.93308915E-02 + 8.48943078E-01 2.49290546E-01 4.986257060E-01 5.93403035E-02 + 8.49046356E-01 2.49328656E-01 4.991714440E-01 5.93497276E-02 + 8.49149633E-01 2.49366775E-01 4.997178260E-01 5.93591637E-02 + 8.49252911E-01 2.49404905E-01 5.002648510E-01 5.93686117E-02 + 8.49356189E-01 2.49443044E-01 5.008125210E-01 5.93780718E-02 + 8.49459467E-01 2.49481193E-01 5.013608380E-01 5.93875440E-02 + 8.49562744E-01 2.49519352E-01 5.019098010E-01 5.93970282E-02 + 8.49666022E-01 2.49557521E-01 5.024594120E-01 5.94065245E-02 + 8.49769300E-01 2.49595700E-01 5.030096720E-01 5.94160329E-02 + 8.49872578E-01 2.49633889E-01 5.035605810E-01 5.94255535E-02 + 8.49975855E-01 2.49672088E-01 5.041121410E-01 5.94350861E-02 + 8.50079133E-01 2.49710297E-01 5.046643520E-01 5.94446309E-02 + 8.50182411E-01 2.49748515E-01 5.052172160E-01 5.94541879E-02 + 8.50285689E-01 2.49786744E-01 5.057707330E-01 5.94637571E-02 + 8.50388966E-01 2.49824983E-01 5.063249050E-01 5.94733384E-02 + 8.50492244E-01 2.49863232E-01 5.068797320E-01 5.94829320E-02 + 8.50595522E-01 2.49901490E-01 5.074352150E-01 5.94925378E-02 + 8.50698800E-01 2.49939759E-01 5.079913560E-01 5.95021559E-02 + 8.50802077E-01 2.49978038E-01 5.085481540E-01 5.95117862E-02 + 8.50905355E-01 2.50016327E-01 5.091056120E-01 5.95214288E-02 + 8.51008633E-01 2.50054626E-01 5.096637300E-01 5.95310837E-02 + 8.51111911E-01 2.50092935E-01 5.102225080E-01 5.95407510E-02 + 8.51215188E-01 2.50131254E-01 5.107819490E-01 5.95504305E-02 + 8.51318466E-01 2.50169584E-01 5.113420530E-01 5.95601224E-02 + 8.51421744E-01 2.50207923E-01 5.119028200E-01 5.95698267E-02 + 8.51525022E-01 2.50246272E-01 5.124642530E-01 5.95795434E-02 + 8.51628299E-01 2.50284632E-01 5.130263510E-01 5.95892725E-02 + 8.51731577E-01 2.50323002E-01 5.135891160E-01 5.95990140E-02 + 8.51834855E-01 2.50361381E-01 5.141525490E-01 5.96087679E-02 + 8.51938133E-01 2.50399771E-01 5.147166510E-01 5.96185343E-02 + 8.52041410E-01 2.50438172E-01 5.152814220E-01 5.96283132E-02 + 8.52144688E-01 2.50476582E-01 5.158468640E-01 5.96381045E-02 + 8.52247966E-01 2.50515002E-01 5.164129780E-01 5.96479084E-02 + 8.52351244E-01 2.50553433E-01 5.169797640E-01 5.96577247E-02 + 8.52454521E-01 2.50591874E-01 5.175472240E-01 5.96675537E-02 + 8.52557799E-01 2.50630325E-01 5.181153590E-01 5.96773951E-02 + 8.52661077E-01 2.50668787E-01 5.186841690E-01 5.96872492E-02 + 8.52764355E-01 2.50707258E-01 5.192536560E-01 5.96971158E-02 + 8.52867632E-01 2.50745740E-01 5.198238200E-01 5.97069951E-02 + 8.52970910E-01 2.50784232E-01 5.203946630E-01 5.97168870E-02 + 8.53074188E-01 2.50822734E-01 5.209661860E-01 5.97267915E-02 + 8.53177466E-01 2.50861247E-01 5.215383890E-01 5.97367087E-02 + 8.53280743E-01 2.50899770E-01 5.221112730E-01 5.97466385E-02 + 8.53384021E-01 2.50938303E-01 5.226848400E-01 5.97565811E-02 + 8.53487299E-01 2.50976846E-01 5.232590910E-01 5.97665364E-02 + 8.53590577E-01 2.51015400E-01 5.238340260E-01 5.97765044E-02 + 8.53693854E-01 2.51053964E-01 5.244096470E-01 5.97864852E-02 + 8.53797132E-01 2.51092539E-01 5.249859550E-01 5.97964787E-02 + 8.53900410E-01 2.51131124E-01 5.255629500E-01 5.98064850E-02 + 8.54003688E-01 2.51169719E-01 5.261406330E-01 5.98165041E-02 + 8.54106965E-01 2.51208324E-01 5.267190060E-01 5.98265361E-02 + 8.54210243E-01 2.51246940E-01 5.272980700E-01 5.98365808E-02 + 8.54313521E-01 2.51285567E-01 5.278778250E-01 5.98466385E-02 + 8.54416799E-01 2.51324203E-01 5.284582730E-01 5.98567090E-02 + 8.54520076E-01 2.51362850E-01 5.290394150E-01 5.98667924E-02 + 8.54623354E-01 2.51401508E-01 5.296212510E-01 5.98768887E-02 + 8.54726632E-01 2.51440176E-01 5.302037830E-01 5.98869979E-02 + 8.54829910E-01 2.51478854E-01 5.307870120E-01 5.98971201E-02 + 8.54933187E-01 2.51517543E-01 5.313709390E-01 5.99072553E-02 + 8.55036465E-01 2.51556242E-01 5.319555640E-01 5.99174034E-02 + 8.55139743E-01 2.51594952E-01 5.325408890E-01 5.99275645E-02 + 8.55243020E-01 2.51633672E-01 5.331269150E-01 5.99377387E-02 + 8.55346298E-01 2.51672403E-01 5.337136430E-01 5.99479259E-02 + 8.55449576E-01 2.51711144E-01 5.343010730E-01 5.99581261E-02 + 8.55552854E-01 2.51749896E-01 5.348892080E-01 5.99683394E-02 + 8.55656131E-01 2.51788658E-01 5.354780470E-01 5.99785658E-02 + 8.55759409E-01 2.51827431E-01 5.360675930E-01 5.99888053E-02 + 8.55862687E-01 2.51866214E-01 5.366578460E-01 5.99990580E-02 + 8.55965965E-01 2.51905008E-01 5.372488070E-01 6.00093238E-02 + 8.56069242E-01 2.51943812E-01 5.378404760E-01 6.00196027E-02 + 8.56172520E-01 2.51982627E-01 5.384328570E-01 6.00298948E-02 + 8.56275798E-01 2.52021453E-01 5.390259480E-01 6.00402002E-02 + 8.56379076E-01 2.52060289E-01 5.396197520E-01 6.00505187E-02 + 8.56482353E-01 2.52099136E-01 5.402142690E-01 6.00608505E-02 + 8.56585631E-01 2.52137993E-01 5.408095010E-01 6.00711956E-02 + 8.56688909E-01 2.52176861E-01 5.414054480E-01 6.00815539E-02 + 8.56792187E-01 2.52215740E-01 5.420021110E-01 6.00919255E-02 + 8.56895464E-01 2.52254629E-01 5.425994930E-01 6.01023104E-02 + 8.56998742E-01 2.52293529E-01 5.431975930E-01 6.01127086E-02 + 8.57102020E-01 2.52332440E-01 5.437964120E-01 6.01231202E-02 + 8.57205298E-01 2.52371361E-01 5.443959530E-01 6.01335452E-02 + 8.57308575E-01 2.52410293E-01 5.449962150E-01 6.01439836E-02 + 8.57411853E-01 2.52449236E-01 5.455972010E-01 6.01544353E-02 + 8.57515131E-01 2.52488189E-01 5.461989100E-01 6.01649005E-02 + 8.57618409E-01 2.52527153E-01 5.468013450E-01 6.01753791E-02 + 8.57721686E-01 2.52566128E-01 5.474045050E-01 6.01858712E-02 + 8.57824964E-01 2.52605114E-01 5.480083930E-01 6.01963767E-02 + 8.57928242E-01 2.52644110E-01 5.486130100E-01 6.02068958E-02 + 8.58031520E-01 2.52683117E-01 5.492183560E-01 6.02174284E-02 + 8.58134797E-01 2.52722135E-01 5.498244320E-01 6.02279745E-02 + 8.58238075E-01 2.52761164E-01 5.504312400E-01 6.02385342E-02 + 8.58341353E-01 2.52800203E-01 5.510387810E-01 6.02491074E-02 + 8.58444631E-01 2.52839254E-01 5.516470550E-01 6.02596942E-02 + 8.58547908E-01 2.52878315E-01 5.522560650E-01 6.02702947E-02 + 8.58651186E-01 2.52917387E-01 5.528658100E-01 6.02809087E-02 + 8.58754464E-01 2.52956469E-01 5.534762930E-01 6.02915365E-02 + 8.58857742E-01 2.52995563E-01 5.540875140E-01 6.03021779E-02 + 8.58961019E-01 2.53034667E-01 5.546994740E-01 6.03128329E-02 + 8.59064297E-01 2.53073783E-01 5.553121750E-01 6.03235017E-02 + 8.59167575E-01 2.53112909E-01 5.559256170E-01 6.03341842E-02 + 8.59270853E-01 2.53152046E-01 5.565398020E-01 6.03448805E-02 + 8.59374130E-01 2.53191194E-01 5.571547300E-01 6.03555905E-02 + 8.59477408E-01 2.53230353E-01 5.577704040E-01 6.03663144E-02 + 8.59580686E-01 2.53269522E-01 5.583868230E-01 6.03770520E-02 + 8.59683964E-01 2.53308703E-01 5.590039900E-01 6.03878034E-02 + 8.59787241E-01 2.53347895E-01 5.596219050E-01 6.03985687E-02 + 8.59890519E-01 2.53387097E-01 5.602405690E-01 6.04093478E-02 + 8.59993797E-01 2.53426311E-01 5.608599840E-01 6.04201409E-02 + 8.60097075E-01 2.53465536E-01 5.614801500E-01 6.04309478E-02 + 8.60200352E-01 2.53504771E-01 5.621010690E-01 6.04417686E-02 + 8.60303630E-01 2.53544018E-01 5.627227420E-01 6.04526034E-02 + 8.60406908E-01 2.53583275E-01 5.633451700E-01 6.04634522E-02 + 8.60510186E-01 2.53622544E-01 5.639683540E-01 6.04743149E-02 + 8.60613463E-01 2.53661823E-01 5.645922960E-01 6.04851916E-02 + 8.60716741E-01 2.53701114E-01 5.652169950E-01 6.04960824E-02 + 8.60820019E-01 2.53740416E-01 5.658424550E-01 6.05069872E-02 + 8.60923297E-01 2.53779729E-01 5.664686750E-01 6.05179060E-02 + 8.61026574E-01 2.53819052E-01 5.670956570E-01 6.05288389E-02 + 8.61129852E-01 2.53858387E-01 5.677234020E-01 6.05397860E-02 + 8.61233130E-01 2.53897733E-01 5.683519120E-01 6.05507471E-02 + 8.61336408E-01 2.53937090E-01 5.689811860E-01 6.05617224E-02 + 8.61439685E-01 2.53976459E-01 5.696112270E-01 6.05727118E-02 + 8.61542963E-01 2.54015838E-01 5.702420360E-01 6.05837154E-02 + 8.61646241E-01 2.54055228E-01 5.708736140E-01 6.05947333E-02 + 8.61749519E-01 2.54094630E-01 5.715059610E-01 6.06057653E-02 + 8.61852796E-01 2.54134043E-01 5.721390800E-01 6.06168116E-02 + 8.61956074E-01 2.54173467E-01 5.727729710E-01 6.06278721E-02 + 8.62059352E-01 2.54212902E-01 5.734076360E-01 6.06389469E-02 + 8.62162630E-01 2.54252348E-01 5.740430750E-01 6.06500360E-02 + 8.62265907E-01 2.54291806E-01 5.746792900E-01 6.06611394E-02 + 8.62369185E-01 2.54331274E-01 5.753162820E-01 6.06722572E-02 + 8.62472463E-01 2.54370754E-01 5.759540520E-01 6.06833893E-02 + 8.62575741E-01 2.54410246E-01 5.765926010E-01 6.06945358E-02 + 8.62679018E-01 2.54449748E-01 5.772319320E-01 6.07056967E-02 + 8.62782296E-01 2.54489262E-01 5.778720430E-01 6.07168720E-02 + 8.62885574E-01 2.54528787E-01 5.785129380E-01 6.07280618E-02 + 8.62988851E-01 2.54568323E-01 5.791546170E-01 6.07392660E-02 + 8.63092129E-01 2.54607871E-01 5.797970810E-01 6.07504847E-02 + 8.63195407E-01 2.54647429E-01 5.804403320E-01 6.07617179E-02 + 8.63298685E-01 2.54686999E-01 5.810843710E-01 6.07729656E-02 + 8.63401962E-01 2.54726581E-01 5.817291980E-01 6.07842279E-02 + 8.63505240E-01 2.54766174E-01 5.823748160E-01 6.07955047E-02 + 8.63608518E-01 2.54805778E-01 5.830212240E-01 6.08067961E-02 + 8.63711796E-01 2.54845393E-01 5.836684260E-01 6.08181022E-02 + 8.63815073E-01 2.54885020E-01 5.843164210E-01 6.08294228E-02 + 8.63918351E-01 2.54924659E-01 5.849652110E-01 6.08407581E-02 + 8.64021629E-01 2.54964308E-01 5.856147970E-01 6.08521081E-02 + 8.64124907E-01 2.55003969E-01 5.862651800E-01 6.08634727E-02 + 8.64228184E-01 2.55043642E-01 5.869163630E-01 6.08748521E-02 + 8.64331462E-01 2.55083325E-01 5.875683450E-01 6.08862462E-02 + 8.64434740E-01 2.55123021E-01 5.882211280E-01 6.08976550E-02 + 8.64538018E-01 2.55162727E-01 5.888747130E-01 6.09090786E-02 + 8.64641295E-01 2.55202446E-01 5.895291020E-01 6.09205171E-02 + 8.64744573E-01 2.55242175E-01 5.901842950E-01 6.09319703E-02 + 8.64847851E-01 2.55281916E-01 5.908402950E-01 6.09434383E-02 + 8.64951129E-01 2.55321669E-01 5.914971010E-01 6.09549212E-02 + 8.65054406E-01 2.55361433E-01 5.921547160E-01 6.09664190E-02 + 8.65157684E-01 2.55401209E-01 5.928131410E-01 6.09779317E-02 + 8.65260962E-01 2.55440996E-01 5.934723770E-01 6.09894593E-02 + 8.65364240E-01 2.55480795E-01 5.941324250E-01 6.10010019E-02 + 8.65467517E-01 2.55520605E-01 5.947932860E-01 6.10125594E-02 + 8.65570795E-01 2.55560427E-01 5.954549620E-01 6.10241319E-02 + 8.65674073E-01 2.55600260E-01 5.961174540E-01 6.10357194E-02 + 8.65777351E-01 2.55640105E-01 5.967807630E-01 6.10473219E-02 + 8.65880628E-01 2.55679961E-01 5.974448910E-01 6.10589395E-02 + 8.65983906E-01 2.55719830E-01 5.981098380E-01 6.10705721E-02 + 8.66087184E-01 2.55759709E-01 5.987756060E-01 6.10822199E-02 + 8.66190462E-01 2.55799601E-01 5.994421960E-01 6.10938827E-02 + 8.66293739E-01 2.55839504E-01 6.001096100E-01 6.11055607E-02 + 8.66397017E-01 2.55879418E-01 6.007778490E-01 6.11172538E-02 + 8.66500295E-01 2.55919344E-01 6.014469140E-01 6.11289621E-02 + 8.66603573E-01 2.55959282E-01 6.021168060E-01 6.11406856E-02 + 8.66706850E-01 2.55999232E-01 6.027875260E-01 6.11524244E-02 + 8.66810128E-01 2.56039193E-01 6.034590770E-01 6.11641783E-02 + 8.66913406E-01 2.56079166E-01 6.041314580E-01 6.11759476E-02 + 8.67016684E-01 2.56119151E-01 6.048046720E-01 6.11877321E-02 + 8.67119961E-01 2.56159148E-01 6.054787200E-01 6.11995319E-02 + 8.67223239E-01 2.56199156E-01 6.061536030E-01 6.12113471E-02 + 8.67326517E-01 2.56239176E-01 6.068293220E-01 6.12231776E-02 + 8.67429795E-01 2.56279207E-01 6.075058780E-01 6.12350235E-02 + 8.67533072E-01 2.56319251E-01 6.081832740E-01 6.12468848E-02 + 8.67636350E-01 2.56359306E-01 6.088615100E-01 6.12587615E-02 + 8.67739628E-01 2.56399373E-01 6.095405870E-01 6.12706536E-02 + 8.67842906E-01 2.56439452E-01 6.102205070E-01 6.12825612E-02 + 8.67946183E-01 2.56479542E-01 6.109012710E-01 6.12944843E-02 + 8.68049461E-01 2.56519645E-01 6.115828810E-01 6.13064229E-02 + 8.68152739E-01 2.56559759E-01 6.122653370E-01 6.13183770E-02 + 8.68256017E-01 2.56599885E-01 6.129486420E-01 6.13303467E-02 + 8.68359294E-01 2.56640023E-01 6.136327960E-01 6.13423319E-02 + 8.68462572E-01 2.56680173E-01 6.143178000E-01 6.13543328E-02 + 8.68565850E-01 2.56720335E-01 6.150036570E-01 6.13663492E-02 + 8.68669128E-01 2.56760509E-01 6.156903670E-01 6.13783813E-02 + 8.68772405E-01 2.56800694E-01 6.163779310E-01 6.13904291E-02 + 8.68875683E-01 2.56840892E-01 6.170663520E-01 6.14024925E-02 + 8.68978961E-01 2.56881101E-01 6.177556300E-01 6.14145717E-02 + 8.69082239E-01 2.56921322E-01 6.184457670E-01 6.14266666E-02 + 8.69185516E-01 2.56961555E-01 6.191367630E-01 6.14387772E-02 + 8.69288794E-01 2.57001801E-01 6.198286210E-01 6.14509036E-02 + 8.69392072E-01 2.57042058E-01 6.205213420E-01 6.14630458E-02 + 8.69495350E-01 2.57082327E-01 6.212149270E-01 6.14752039E-02 + 8.69598627E-01 2.57122608E-01 6.219093770E-01 6.14873778E-02 + 8.69701905E-01 2.57162901E-01 6.226046940E-01 6.14995675E-02 + 8.69805183E-01 2.57203207E-01 6.233008790E-01 6.15117731E-02 + 8.69908461E-01 2.57243524E-01 6.239979340E-01 6.15239947E-02 + 8.70011738E-01 2.57283853E-01 6.246958590E-01 6.15362322E-02 + 8.70115016E-01 2.57324195E-01 6.253946570E-01 6.15484856E-02 + 8.70218294E-01 2.57364548E-01 6.260943280E-01 6.15607550E-02 + 8.70321572E-01 2.57404913E-01 6.267948740E-01 6.15730404E-02 + 8.70424849E-01 2.57445291E-01 6.274962970E-01 6.15853419E-02 + 8.70528127E-01 2.57485681E-01 6.281985970E-01 6.15976594E-02 + 8.70631405E-01 2.57526082E-01 6.289017760E-01 6.16099930E-02 + 8.70734683E-01 2.57566496E-01 6.296058360E-01 6.16223427E-02 + 8.70837960E-01 2.57606922E-01 6.303107770E-01 6.16347085E-02 + 8.70941238E-01 2.57647360E-01 6.310166020E-01 6.16470904E-02 + 8.71044516E-01 2.57687811E-01 6.317233110E-01 6.16594885E-02 + 8.71147793E-01 2.57728273E-01 6.324309070E-01 6.16719028E-02 + 8.71251071E-01 2.57768748E-01 6.331393900E-01 6.16843333E-02 + 8.71354349E-01 2.57809235E-01 6.338487610E-01 6.16967801E-02 + 8.71457627E-01 2.57849734E-01 6.345590230E-01 6.17092431E-02 + 8.71560904E-01 2.57890245E-01 6.352701760E-01 6.17217224E-02 + 8.71664182E-01 2.57930769E-01 6.359822220E-01 6.17342180E-02 + 8.71767460E-01 2.57971304E-01 6.366951630E-01 6.17467299E-02 + 8.71870738E-01 2.58011852E-01 6.374090000E-01 6.17592582E-02 + 8.71974015E-01 2.58052413E-01 6.381237330E-01 6.17718029E-02 + 8.72077293E-01 2.58092985E-01 6.388393660E-01 6.17843639E-02 + 8.72180571E-01 2.58133570E-01 6.395558980E-01 6.17969414E-02 + 8.72283849E-01 2.58174167E-01 6.402733320E-01 6.18095354E-02 + 8.72387126E-01 2.58214776E-01 6.409916690E-01 6.18221458E-02 + 8.72490404E-01 2.58255398E-01 6.417109100E-01 6.18347727E-02 + 8.72593682E-01 2.58296032E-01 6.424310570E-01 6.18474162E-02 + 8.72696960E-01 2.58336679E-01 6.431521110E-01 6.18600761E-02 + 8.72800237E-01 2.58377337E-01 6.438740740E-01 6.18727527E-02 + 8.72903515E-01 2.58418008E-01 6.445969470E-01 6.18854459E-02 + 8.73006793E-01 2.58458692E-01 6.453207320E-01 6.18981556E-02 + 8.73110071E-01 2.58499388E-01 6.460454290E-01 6.19108820E-02 + 8.73213348E-01 2.58540096E-01 6.467710410E-01 6.19236251E-02 + 8.73316626E-01 2.58580817E-01 6.474975690E-01 6.19363849E-02 + 8.73419904E-01 2.58621550E-01 6.482250140E-01 6.19491614E-02 + 8.73523182E-01 2.58662295E-01 6.489533780E-01 6.19619546E-02 + 8.73626459E-01 2.58703053E-01 6.496826620E-01 6.19747646E-02 + 8.73729737E-01 2.58743824E-01 6.504128670E-01 6.19875914E-02 + 8.73833015E-01 2.58784607E-01 6.511439960E-01 6.20004350E-02 + 8.73936293E-01 2.58825402E-01 6.518760500E-01 6.20132954E-02 + 8.74039570E-01 2.58866210E-01 6.526090300E-01 6.20261727E-02 + 8.74142848E-01 2.58907031E-01 6.533429370E-01 6.20390668E-02 + 8.74246126E-01 2.58947864E-01 6.540777730E-01 6.20519779E-02 + 8.74349404E-01 2.58988709E-01 6.548135400E-01 6.20649059E-02 + 8.74452681E-01 2.59029567E-01 6.555502390E-01 6.20778509E-02 + 8.74555959E-01 2.59070438E-01 6.562878720E-01 6.20908129E-02 + 8.74659237E-01 2.59111321E-01 6.570264390E-01 6.21037919E-02 + 8.74762515E-01 2.59152216E-01 6.577659430E-01 6.21167879E-02 + 8.74865792E-01 2.59193125E-01 6.585063860E-01 6.21298010E-02 + 8.74969070E-01 2.59234046E-01 6.592477670E-01 6.21428311E-02 + 8.75072348E-01 2.59274979E-01 6.599900900E-01 6.21558784E-02 + 8.75175626E-01 2.59315925E-01 6.607333550E-01 6.21689428E-02 + 8.75278903E-01 2.59356884E-01 6.614775640E-01 6.21820243E-02 + 8.75382181E-01 2.59397856E-01 6.622227180E-01 6.21951231E-02 + 8.75485459E-01 2.59438840E-01 6.629688200E-01 6.22082390E-02 + 8.75588737E-01 2.59479836E-01 6.637158700E-01 6.22213722E-02 + 8.75692014E-01 2.59520846E-01 6.644638700E-01 6.22345227E-02 + 8.75795292E-01 2.59561868E-01 6.652128220E-01 6.22476904E-02 + 8.75898570E-01 2.59602903E-01 6.659627270E-01 6.22608754E-02 + 8.76001848E-01 2.59643950E-01 6.667135870E-01 6.22740778E-02 + 8.76105125E-01 2.59685011E-01 6.674654030E-01 6.22872975E-02 + 8.76208403E-01 2.59726084E-01 6.682181760E-01 6.23005347E-02 + 8.76311681E-01 2.59767169E-01 6.689719090E-01 6.23137892E-02 + 8.76414959E-01 2.59808268E-01 6.697266030E-01 6.23270612E-02 + 8.76518236E-01 2.59849379E-01 6.704822590E-01 6.23403506E-02 + 8.76621514E-01 2.59890504E-01 6.712388790E-01 6.23536576E-02 + 8.76724792E-01 2.59931640E-01 6.719964640E-01 6.23669820E-02 + 8.76828070E-01 2.59972790E-01 6.727550170E-01 6.23803240E-02 + 8.76931347E-01 2.60013953E-01 6.735145380E-01 6.23936835E-02 + 8.77034625E-01 2.60055128E-01 6.742750290E-01 6.24070607E-02 + 8.77137903E-01 2.60096317E-01 6.750364920E-01 6.24204554E-02 + 8.77241181E-01 2.60137518E-01 6.757989280E-01 6.24338679E-02 + 8.77344458E-01 2.60178732E-01 6.765623390E-01 6.24472979E-02 + 8.77447736E-01 2.60219959E-01 6.773267260E-01 6.24607457E-02 + 8.77551014E-01 2.60261198E-01 6.780920910E-01 6.24742112E-02 + 8.77654292E-01 2.60302451E-01 6.788584360E-01 6.24876944E-02 + 8.77757569E-01 2.60343717E-01 6.796257620E-01 6.25011954E-02 + 8.77860847E-01 2.60384995E-01 6.803940710E-01 6.25147143E-02 + 8.77964125E-01 2.60426287E-01 6.811633640E-01 6.25282509E-02 + 8.78067403E-01 2.60467591E-01 6.819336430E-01 6.25418054E-02 + 8.78170680E-01 2.60508909E-01 6.827049100E-01 6.25553778E-02 + 8.78273958E-01 2.60550239E-01 6.834771650E-01 6.25689680E-02 + 8.78377236E-01 2.60591583E-01 6.842504120E-01 6.25825763E-02 + 8.78480514E-01 2.60632939E-01 6.850246510E-01 6.25962024E-02 + 8.78583791E-01 2.60674309E-01 6.857998830E-01 6.26098466E-02 + 8.78687069E-01 2.60715691E-01 6.865761110E-01 6.26235087E-02 + 8.78790347E-01 2.60757087E-01 6.873533370E-01 6.26371889E-02 + 8.78893624E-01 2.60798495E-01 6.881315610E-01 6.26508872E-02 + 8.78996902E-01 2.60839917E-01 6.889107860E-01 6.26646036E-02 + 8.79100180E-01 2.60881352E-01 6.896910120E-01 6.26783380E-02 + 8.79203458E-01 2.60922800E-01 6.904722430E-01 6.26920907E-02 + 8.79306735E-01 2.60964260E-01 6.912544780E-01 6.27058615E-02 + 8.79410013E-01 2.61005735E-01 6.920377210E-01 6.27196504E-02 + 8.79513291E-01 2.61047222E-01 6.928219720E-01 6.27334577E-02 + 8.79616569E-01 2.61088722E-01 6.936072340E-01 6.27472831E-02 + 8.79719846E-01 2.61130236E-01 6.943935070E-01 6.27611269E-02 + 8.79823124E-01 2.61171762E-01 6.951807940E-01 6.27749889E-02 + 8.79926402E-01 2.61213302E-01 6.959690960E-01 6.27888693E-02 + 8.80029680E-01 2.61254855E-01 6.967584150E-01 6.28027681E-02 + 8.80132957E-01 2.61296421E-01 6.975487520E-01 6.28166852E-02 + 8.80236235E-01 2.61338001E-01 6.983401090E-01 6.28306207E-02 + 8.80339513E-01 2.61379594E-01 6.991324890E-01 6.28445747E-02 + 8.80442791E-01 2.61421199E-01 6.999258910E-01 6.28585472E-02 + 8.80546068E-01 2.61462819E-01 7.007203190E-01 6.28725382E-02 + 8.80649346E-01 2.61504451E-01 7.015157740E-01 6.28865476E-02 + 8.80752624E-01 2.61546097E-01 7.023122580E-01 6.29005757E-02 + 8.80855902E-01 2.61587756E-01 7.031097710E-01 6.29146223E-02 + 8.80959179E-01 2.61629428E-01 7.039083170E-01 6.29286875E-02 + 8.81062457E-01 2.61671114E-01 7.047078960E-01 6.29427714E-02 + 8.81165735E-01 2.61712813E-01 7.055085100E-01 6.29568739E-02 + 8.81269013E-01 2.61754525E-01 7.063101620E-01 6.29709951E-02 + 8.81372290E-01 2.61796251E-01 7.071128520E-01 6.29851350E-02 + 8.81475568E-01 2.61837990E-01 7.079165820E-01 6.29992937E-02 + 8.81578846E-01 2.61879742E-01 7.087213550E-01 6.30134712E-02 + 8.81682124E-01 2.61921508E-01 7.095271710E-01 6.30276674E-02 + 8.81785401E-01 2.61963287E-01 7.103340330E-01 6.30418825E-02 + 8.81888679E-01 2.62005079E-01 7.111419430E-01 6.30561164E-02 + 8.81991957E-01 2.62046885E-01 7.119509010E-01 6.30703692E-02 + 8.82095235E-01 2.62088705E-01 7.127609100E-01 6.30846410E-02 + 8.82198512E-01 2.62130538E-01 7.135719710E-01 6.30989317E-02 + 8.82301790E-01 2.62172384E-01 7.143840870E-01 6.31132413E-02 + 8.82405068E-01 2.62214244E-01 7.151972580E-01 6.31275700E-02 + 8.82508346E-01 2.62256117E-01 7.160114880E-01 6.31419176E-02 + 8.82611623E-01 2.62298004E-01 7.168267760E-01 6.31562844E-02 + 8.82714901E-01 2.62339904E-01 7.176431260E-01 6.31706702E-02 + 8.82818179E-01 2.62381818E-01 7.184605390E-01 6.31850751E-02 + 8.82921457E-01 2.62423746E-01 7.192790160E-01 6.31994992E-02 + 8.83024734E-01 2.62465687E-01 7.200985600E-01 6.32139424E-02 + 8.83128012E-01 2.62507641E-01 7.209191710E-01 6.32284048E-02 + 8.83231290E-01 2.62549609E-01 7.217408530E-01 6.32428865E-02 + 8.83334568E-01 2.62591591E-01 7.225636070E-01 6.32573874E-02 + 8.83437845E-01 2.62633586E-01 7.233874340E-01 6.32719076E-02 + 8.83541123E-01 2.62675595E-01 7.242123360E-01 6.32864471E-02 + 8.83644401E-01 2.62717617E-01 7.250383160E-01 6.33010060E-02 + 8.83747679E-01 2.62759654E-01 7.258653740E-01 6.33155842E-02 + 8.83850956E-01 2.62801703E-01 7.266935130E-01 6.33301819E-02 + 8.83954234E-01 2.62843767E-01 7.275227350E-01 6.33447989E-02 + 8.84057512E-01 2.62885844E-01 7.283530400E-01 6.33594354E-02 + 8.84160790E-01 2.62927935E-01 7.291844320E-01 6.33740915E-02 + 8.84264067E-01 2.62970039E-01 7.300169110E-01 6.33887670E-02 + 8.84367345E-01 2.63012157E-01 7.308504810E-01 6.34034620E-02 + 8.84470623E-01 2.63054289E-01 7.316851410E-01 6.34181767E-02 + 8.84573901E-01 2.63096435E-01 7.325208950E-01 6.34329109E-02 + 8.84677178E-01 2.63138594E-01 7.333577440E-01 6.34476648E-02 + 8.84780456E-01 2.63180768E-01 7.341956900E-01 6.34624384E-02 + 8.84883734E-01 2.63222955E-01 7.350347350E-01 6.34772316E-02 + 8.84987012E-01 2.63265155E-01 7.358748800E-01 6.34920446E-02 + 8.85090289E-01 2.63307370E-01 7.367161270E-01 6.35068773E-02 + 8.85193567E-01 2.63349598E-01 7.375584790E-01 6.35217298E-02 + 8.85296845E-01 2.63391840E-01 7.384019370E-01 6.35366021E-02 + 8.85400123E-01 2.63434096E-01 7.392465030E-01 6.35514942E-02 + 8.85503400E-01 2.63476366E-01 7.400921790E-01 6.35664062E-02 + 8.85606678E-01 2.63518650E-01 7.409389660E-01 6.35813382E-02 + 8.85709956E-01 2.63560947E-01 7.417868670E-01 6.35962900E-02 + 8.85813234E-01 2.63603259E-01 7.426358840E-01 6.36112618E-02 + 8.85916511E-01 2.63645584E-01 7.434860170E-01 6.36262536E-02 + 8.86019789E-01 2.63687924E-01 7.443372700E-01 6.36412655E-02 + 8.86123067E-01 2.63730277E-01 7.451896440E-01 6.36562974E-02 + 8.86226345E-01 2.63772644E-01 7.460431400E-01 6.36713493E-02 + 8.86329622E-01 2.63815025E-01 7.468977610E-01 6.36864214E-02 + 8.86432900E-01 2.63857420E-01 7.477535090E-01 6.37015136E-02 + 8.86536178E-01 2.63899829E-01 7.486103860E-01 6.37166260E-02 + 8.86639455E-01 2.63942252E-01 7.494683920E-01 6.37317586E-02 + 8.86742733E-01 2.63984689E-01 7.503275320E-01 6.37469114E-02 + 8.86846011E-01 2.64027140E-01 7.511878050E-01 6.37620845E-02 + 8.86949289E-01 2.64069605E-01 7.520492150E-01 6.37772779E-02 + 8.87052566E-01 2.64112085E-01 7.529117620E-01 6.37924916E-02 + 8.87155844E-01 2.64154578E-01 7.537754500E-01 6.38077257E-02 + 8.87259122E-01 2.64197085E-01 7.546402790E-01 6.38229801E-02 + 8.87362400E-01 2.64239606E-01 7.555062520E-01 6.38382550E-02 + 8.87465677E-01 2.64282142E-01 7.563733710E-01 6.38535503E-02 + 8.87568955E-01 2.64324691E-01 7.572416380E-01 6.38688661E-02 + 8.87672233E-01 2.64367255E-01 7.581110540E-01 6.38842025E-02 + 8.87775511E-01 2.64409833E-01 7.589816220E-01 6.38995593E-02 + 8.87878788E-01 2.64452425E-01 7.598533430E-01 6.39149367E-02 + 8.87982066E-01 2.64495031E-01 7.607262190E-01 6.39303348E-02 + 8.88085344E-01 2.64537651E-01 7.616002530E-01 6.39457535E-02 + 8.88188622E-01 2.64580285E-01 7.624754470E-01 6.39611928E-02 + 8.88291899E-01 2.64622934E-01 7.633518010E-01 6.39766528E-02 + 8.88395177E-01 2.64665597E-01 7.642293190E-01 6.39921336E-02 + 8.88498455E-01 2.64708274E-01 7.651080020E-01 6.40076351E-02 + 8.88601733E-01 2.64750965E-01 7.659878530E-01 6.40231574E-02 + 8.88705010E-01 2.64793670E-01 7.668688720E-01 6.40387006E-02 + 8.88808288E-01 2.64836390E-01 7.677510630E-01 6.40542646E-02 + 8.88911566E-01 2.64879124E-01 7.686344260E-01 6.40698495E-02 + 8.89014844E-01 2.64921872E-01 7.695189650E-01 6.40854553E-02 + 8.89118121E-01 2.64964635E-01 7.704046810E-01 6.41010820E-02 + 8.89221399E-01 2.65007412E-01 7.712915770E-01 6.41167298E-02 + 8.89324677E-01 2.65050203E-01 7.721796530E-01 6.41323985E-02 + 8.89427955E-01 2.65093009E-01 7.730689120E-01 6.41480883E-02 + 8.89531232E-01 2.65135829E-01 7.739593570E-01 6.41637992E-02 + 8.89634510E-01 2.65178663E-01 7.748509890E-01 6.41795312E-02 + 8.89737788E-01 2.65221511E-01 7.757438100E-01 6.41952844E-02 + 8.89841066E-01 2.65264375E-01 7.766378220E-01 6.42110587E-02 + 8.89944343E-01 2.65307252E-01 7.775330270E-01 6.42268542E-02 + 8.90047621E-01 2.65350144E-01 7.784294280E-01 6.42426710E-02 + 8.90150899E-01 2.65393050E-01 7.793270260E-01 6.42585090E-02 + 8.90254177E-01 2.65435971E-01 7.802258230E-01 6.42743683E-02 + 8.90357454E-01 2.65478906E-01 7.811258210E-01 6.42902490E-02 + 8.90460732E-01 2.65521855E-01 7.820270240E-01 6.43061510E-02 + 8.90564010E-01 2.65564820E-01 7.829294310E-01 6.43220745E-02 + 8.90667288E-01 2.65607798E-01 7.838330460E-01 6.43380194E-02 + 8.90770565E-01 2.65650791E-01 7.847378710E-01 6.43539857E-02 + 8.90873843E-01 2.65693799E-01 7.856439080E-01 6.43699736E-02 + 8.90977121E-01 2.65736821E-01 7.865511580E-01 6.43859830E-02 + 8.91080399E-01 2.65779858E-01 7.874596240E-01 6.44020139E-02 + 8.91183676E-01 2.65822909E-01 7.883693080E-01 6.44180665E-02 + 8.91286954E-01 2.65865975E-01 7.892802120E-01 6.44341407E-02 + 8.91390232E-01 2.65909055E-01 7.901923380E-01 6.44502365E-02 + 8.91493510E-01 2.65952150E-01 7.911056880E-01 6.44663541E-02 + 8.91596787E-01 2.65995259E-01 7.920202650E-01 6.44824934E-02 + 8.91700065E-01 2.66038384E-01 7.929360700E-01 6.44986544E-02 + 8.91803343E-01 2.66081522E-01 7.938531050E-01 6.45148373E-02 + 8.91906621E-01 2.66124676E-01 7.947713730E-01 6.45310419E-02 + 8.92009898E-01 2.66167844E-01 7.956908760E-01 6.45472685E-02 + 8.92113176E-01 2.66211027E-01 7.966116160E-01 6.45635169E-02 + 8.92216454E-01 2.66254224E-01 7.975335950E-01 6.45797873E-02 + 8.92319732E-01 2.66297436E-01 7.984568140E-01 6.45960797E-02 + 8.92423009E-01 2.66340663E-01 7.993812770E-01 6.46123940E-02 + 8.92526287E-01 2.66383905E-01 8.003069860E-01 6.46287304E-02 + 8.92629565E-01 2.66427161E-01 8.012339420E-01 6.46450888E-02 + 8.92732843E-01 2.66470432E-01 8.021621480E-01 6.46614694E-02 + 8.92836120E-01 2.66513718E-01 8.030916050E-01 6.46778721E-02 + 8.92939398E-01 2.66557019E-01 8.040223170E-01 6.46942969E-02 + 8.93042676E-01 2.66600334E-01 8.049542840E-01 6.47107440E-02 + 8.93145954E-01 2.66643665E-01 8.058875100E-01 6.47272133E-02 + 8.93249231E-01 2.66687010E-01 8.068219970E-01 6.47437049E-02 + 8.93352509E-01 2.66730369E-01 8.077577460E-01 6.47602188E-02 + 8.93455787E-01 2.66773744E-01 8.086947600E-01 6.47767550E-02 + 8.93559065E-01 2.66817134E-01 8.096330410E-01 6.47933136E-02 + 8.93662342E-01 2.66860538E-01 8.105725920E-01 6.48098946E-02 + 8.93765620E-01 2.66903957E-01 8.115134140E-01 6.48264981E-02 + 8.93868898E-01 2.66947392E-01 8.124555090E-01 6.48431240E-02 + 8.93972176E-01 2.66990841E-01 8.133988810E-01 6.48597724E-02 + 8.94075453E-01 2.67034305E-01 8.143435300E-01 6.48764434E-02 + 8.94178731E-01 2.67077784E-01 8.152894600E-01 6.48931370E-02 + 8.94282009E-01 2.67121278E-01 8.162366720E-01 6.49098532E-02 + 8.94385286E-01 2.67164787E-01 8.171851690E-01 6.49265921E-02 + 8.94488564E-01 2.67208310E-01 8.181349530E-01 6.49433536E-02 + 8.94591842E-01 2.67251849E-01 8.190860260E-01 6.49601379E-02 + 8.94695120E-01 2.67295403E-01 8.200383910E-01 6.49769449E-02 + 8.94798397E-01 2.67338972E-01 8.209920490E-01 6.49937747E-02 + 8.94901675E-01 2.67382556E-01 8.219470030E-01 6.50106274E-02 + 8.95004953E-01 2.67426155E-01 8.229032560E-01 6.50275029E-02 + 8.95108231E-01 2.67469769E-01 8.238608090E-01 6.50444013E-02 + 8.95211508E-01 2.67513398E-01 8.248196640E-01 6.50613226E-02 + 8.95314786E-01 2.67557042E-01 8.257798250E-01 6.50782669E-02 + 8.95418064E-01 2.67600701E-01 8.267412930E-01 6.50952343E-02 + 8.95521342E-01 2.67644375E-01 8.277040700E-01 6.51122246E-02 + 8.95624619E-01 2.67688065E-01 8.286681590E-01 6.51292381E-02 + 8.95727897E-01 2.67731769E-01 8.296335630E-01 6.51462746E-02 + 8.95831175E-01 2.67775489E-01 8.306002830E-01 6.51633343E-02 + 8.95934453E-01 2.67819224E-01 8.315683210E-01 6.51804172E-02 + 8.96037730E-01 2.67862974E-01 8.325376810E-01 6.51975234E-02 + 8.96141008E-01 2.67906739E-01 8.335083640E-01 6.52146527E-02 + 8.96244286E-01 2.67950520E-01 8.344803720E-01 6.52318054E-02 + 8.96347564E-01 2.67994315E-01 8.354537090E-01 6.52489814E-02 + 8.96450841E-01 2.68038126E-01 8.364283760E-01 6.52661808E-02 + 8.96554119E-01 2.68081952E-01 8.374043750E-01 6.52834035E-02 + 8.96657397E-01 2.68125794E-01 8.383817100E-01 6.53006497E-02 + 8.96760675E-01 2.68169650E-01 8.393603810E-01 6.53179194E-02 + 8.96863952E-01 2.68213522E-01 8.403403930E-01 6.53352126E-02 + 8.96967230E-01 2.68257409E-01 8.413217460E-01 6.53525293E-02 + 8.97070508E-01 2.68301312E-01 8.423044440E-01 6.53698697E-02 + 8.97173786E-01 2.68345230E-01 8.432884880E-01 6.53872336E-02 + 8.97277063E-01 2.68389163E-01 8.442738820E-01 6.54046212E-02 + 8.97380341E-01 2.68433111E-01 8.452606270E-01 6.54220325E-02 + 8.97483619E-01 2.68477075E-01 8.462487260E-01 6.54394676E-02 + 8.97586897E-01 2.68521054E-01 8.472381810E-01 6.54569264E-02 + 8.97690174E-01 2.68565049E-01 8.482289950E-01 6.54744090E-02 + 8.97793452E-01 2.68609059E-01 8.492211700E-01 6.54919154E-02 + 8.97896730E-01 2.68653084E-01 8.502147080E-01 6.55094458E-02 + 8.98000008E-01 2.68697125E-01 8.512096120E-01 6.55270000E-02 + 8.98103285E-01 2.68741182E-01 8.522058840E-01 6.55445782E-02 + 8.98206563E-01 2.68785253E-01 8.532035270E-01 6.55621804E-02 + 8.98309841E-01 2.68829341E-01 8.542025430E-01 6.55798067E-02 + 8.98413119E-01 2.68873443E-01 8.552029340E-01 6.55974570E-02 + 8.98516396E-01 2.68917561E-01 8.562047040E-01 6.56151314E-02 + 8.98619674E-01 2.68961695E-01 8.572078530E-01 6.56328299E-02 + 8.98722952E-01 2.69005844E-01 8.582123860E-01 6.56505527E-02 + 8.98826230E-01 2.69050009E-01 8.592183040E-01 6.56682996E-02 + 8.98929507E-01 2.69094189E-01 8.602256090E-01 6.56860709E-02 + 8.99032785E-01 2.69138385E-01 8.612343050E-01 6.57038664E-02 + 8.99136063E-01 2.69182597E-01 8.622443930E-01 6.57216862E-02 + 8.99239341E-01 2.69226824E-01 8.632558760E-01 6.57395304E-02 + 8.99342618E-01 2.69271066E-01 8.642687570E-01 6.57573990E-02 + 8.99445896E-01 2.69315324E-01 8.652830380E-01 6.57752921E-02 + 8.99549174E-01 2.69359598E-01 8.662987210E-01 6.57932097E-02 + 8.99652452E-01 2.69403888E-01 8.673158100E-01 6.58111518E-02 + 8.99755729E-01 2.69448193E-01 8.683343060E-01 6.58291184E-02 + 8.99859007E-01 2.69492514E-01 8.693542120E-01 6.58471097E-02 + 8.99962285E-01 2.69536850E-01 8.703755300E-01 6.58651255E-02 + 9.00065563E-01 2.69581203E-01 8.713982640E-01 6.58831661E-02 + 9.00168840E-01 2.69625570E-01 8.724224150E-01 6.59012314E-02 + 9.00272118E-01 2.69669954E-01 8.734479860E-01 6.59193215E-02 + 9.00375396E-01 2.69714353E-01 8.744749800E-01 6.59374363E-02 + 9.00478674E-01 2.69758769E-01 8.755033990E-01 6.59555760E-02 + 9.00581951E-01 2.69803200E-01 8.765332450E-01 6.59737405E-02 + 9.00685229E-01 2.69847646E-01 8.775645220E-01 6.59919300E-02 + 9.00788507E-01 2.69892109E-01 8.785972320E-01 6.60101444E-02 + 9.00891785E-01 2.69936587E-01 8.796313770E-01 6.60283838E-02 + 9.00995062E-01 2.69981081E-01 8.806669600E-01 6.60466483E-02 + 9.01098340E-01 2.70025591E-01 8.817039830E-01 6.60649378E-02 + 9.01201618E-01 2.70070117E-01 8.827424500E-01 6.60832524E-02 + 9.01304896E-01 2.70114658E-01 8.837823620E-01 6.61015922E-02 + 9.01408173E-01 2.70159216E-01 8.848237220E-01 6.61199571E-02 + 9.01511451E-01 2.70203789E-01 8.858665330E-01 6.61383473E-02 + 9.01614729E-01 2.70248378E-01 8.869107980E-01 6.61567628E-02 + 9.01718007E-01 2.70292984E-01 8.879565190E-01 6.61752036E-02 + 9.01821284E-01 2.70337605E-01 8.890036980E-01 6.61936697E-02 + 9.01924562E-01 2.70382242E-01 8.900523380E-01 6.62121612E-02 + 9.02027840E-01 2.70426895E-01 8.911024430E-01 6.62306782E-02 + 9.02131117E-01 2.70471564E-01 8.921540140E-01 6.62492206E-02 + 9.02234395E-01 2.70516249E-01 8.932070540E-01 6.62677885E-02 + 9.02337673E-01 2.70560950E-01 8.942615660E-01 6.62863820E-02 + 9.02440951E-01 2.70605667E-01 8.953175520E-01 6.63050010E-02 + 9.02544228E-01 2.70650400E-01 8.963750150E-01 6.63236457E-02 + 9.02647506E-01 2.70695149E-01 8.974339580E-01 6.63423161E-02 + 9.02750784E-01 2.70739914E-01 8.984943840E-01 6.63610122E-02 + 9.02854062E-01 2.70784695E-01 8.995562940E-01 6.63797340E-02 + 9.02957339E-01 2.70829492E-01 9.006196930E-01 6.63984817E-02 + 9.03060617E-01 2.70874305E-01 9.016845810E-01 6.64172551E-02 + 9.03163895E-01 2.70919135E-01 9.027509630E-01 6.64360545E-02 + 9.03267173E-01 2.70963980E-01 9.038188410E-01 6.64548797E-02 + 9.03370450E-01 2.71008842E-01 9.048882170E-01 6.64737310E-02 + 9.03473728E-01 2.71053720E-01 9.059590950E-01 6.64926082E-02 + 9.03577006E-01 2.71098614E-01 9.070314760E-01 6.65115114E-02 + 9.03680284E-01 2.71143524E-01 9.081053640E-01 6.65304408E-02 + 9.03783561E-01 2.71188450E-01 9.091807610E-01 6.65493963E-02 + 9.03886839E-01 2.71233393E-01 9.102576710E-01 6.65683779E-02 + 9.03990117E-01 2.71278352E-01 9.113360950E-01 6.65873857E-02 + 9.04093395E-01 2.71323326E-01 9.124160370E-01 6.66064198E-02 + 9.04196672E-01 2.71368318E-01 9.134975000E-01 6.66254802E-02 + 9.04299950E-01 2.71413325E-01 9.145804850E-01 6.66445669E-02 + 9.04403228E-01 2.71458349E-01 9.156649960E-01 6.66636800E-02 + 9.04506506E-01 2.71503389E-01 9.167510360E-01 6.66828196E-02 + 9.04609783E-01 2.71548445E-01 9.178386080E-01 6.67019855E-02 + 9.04713061E-01 2.71593518E-01 9.189277130E-01 6.67211780E-02 + 9.04816339E-01 2.71638607E-01 9.200183560E-01 6.67403970E-02 + 9.04919617E-01 2.71683712E-01 9.211105380E-01 6.67596426E-02 + 9.05022894E-01 2.71728834E-01 9.222042630E-01 6.67789148E-02 + 9.05126172E-01 2.71773972E-01 9.232995330E-01 6.67982138E-02 + 9.05229450E-01 2.71819126E-01 9.243963510E-01 6.68175394E-02 + 9.05332728E-01 2.71864297E-01 9.254947210E-01 6.68368917E-02 + 9.05436005E-01 2.71909484E-01 9.265946440E-01 6.68562709E-02 + 9.05539283E-01 2.71954688E-01 9.276961240E-01 6.68756769E-02 + 9.05642561E-01 2.71999908E-01 9.287991640E-01 6.68951098E-02 + 9.05745839E-01 2.72045144E-01 9.299037650E-01 6.69145697E-02 + 9.05849116E-01 2.72090397E-01 9.310099320E-01 6.69340565E-02 + 9.05952394E-01 2.72135667E-01 9.321176670E-01 6.69535703E-02 + 9.06055672E-01 2.72180953E-01 9.332269730E-01 6.69731112E-02 + 9.06158950E-01 2.72226255E-01 9.343378530E-01 6.69926791E-02 + 9.06262227E-01 2.72271574E-01 9.354503100E-01 6.70122742E-02 + 9.06365505E-01 2.72316910E-01 9.365643460E-01 6.70318966E-02 + 9.06468783E-01 2.72362262E-01 9.376799640E-01 6.70515461E-02 + 9.06572061E-01 2.72407630E-01 9.387971680E-01 6.70712229E-02 + 9.06675338E-01 2.72453016E-01 9.399159600E-01 6.70909270E-02 + 9.06778616E-01 2.72498417E-01 9.410363430E-01 6.71106585E-02 + 9.06881894E-01 2.72543836E-01 9.421583210E-01 6.71304174E-02 + 9.06985172E-01 2.72589271E-01 9.432818950E-01 6.71502038E-02 + 9.07088449E-01 2.72634722E-01 9.444070700E-01 6.71700177E-02 + 9.07191727E-01 2.72680190E-01 9.455338470E-01 6.71898590E-02 + 9.07295005E-01 2.72725675E-01 9.466622300E-01 6.72097280E-02 + 9.07398283E-01 2.72771177E-01 9.477922220E-01 6.72296246E-02 + 9.07501560E-01 2.72816695E-01 9.489238250E-01 6.72495489E-02 + 9.07604838E-01 2.72862230E-01 9.500570430E-01 6.72695009E-02 + 9.07708116E-01 2.72907782E-01 9.511918790E-01 6.72894807E-02 + 9.07811394E-01 2.72953350E-01 9.523283360E-01 6.73094882E-02 + 9.07914671E-01 2.72998935E-01 9.534664160E-01 6.73295236E-02 + 9.08017949E-01 2.73044537E-01 9.546061230E-01 6.73495869E-02 + 9.08121227E-01 2.73090156E-01 9.557474590E-01 6.73696782E-02 + 9.08224505E-01 2.73135792E-01 9.568904280E-01 6.73897974E-02 + 9.08327782E-01 2.73181444E-01 9.580350330E-01 6.74099447E-02 + 9.08431060E-01 2.73227113E-01 9.591812760E-01 6.74301201E-02 + 9.08534338E-01 2.73272799E-01 9.603291610E-01 6.74503235E-02 + 9.08637616E-01 2.73318501E-01 9.614786910E-01 6.74705552E-02 + 9.08740893E-01 2.73364221E-01 9.626298690E-01 6.74908150E-02 + 9.08844171E-01 2.73409958E-01 9.637826970E-01 6.75111031E-02 + 9.08947449E-01 2.73455711E-01 9.649371800E-01 6.75314196E-02 + 9.09050727E-01 2.73501481E-01 9.660933190E-01 6.75517643E-02 + 9.09154004E-01 2.73547268E-01 9.672511180E-01 6.75721375E-02 + 9.09257282E-01 2.73593072E-01 9.684105800E-01 6.75925391E-02 + 9.09360560E-01 2.73638893E-01 9.695717090E-01 6.76129692E-02 + 9.09463838E-01 2.73684731E-01 9.707345060E-01 6.76334278E-02 + 9.09567115E-01 2.73730586E-01 9.718989760E-01 6.76539150E-02 + 9.09670393E-01 2.73776458E-01 9.730651220E-01 6.76744309E-02 + 9.09773671E-01 2.73822347E-01 9.742329460E-01 6.76949754E-02 + 9.09876949E-01 2.73868253E-01 9.754024520E-01 6.77155486E-02 + 9.09980226E-01 2.73914176E-01 9.765736420E-01 6.77361506E-02 + 9.10083504E-01 2.73960116E-01 9.777465210E-01 6.77567814E-02 + 9.10186782E-01 2.74006073E-01 9.789210910E-01 6.77774411E-02 + 9.10290059E-01 2.74052047E-01 9.800973540E-01 6.77981297E-02 + 9.10393337E-01 2.74098038E-01 9.812753160E-01 6.78188472E-02 + 9.10496615E-01 2.74144046E-01 9.824549770E-01 6.78395937E-02 + 9.10599893E-01 2.74190071E-01 9.836363430E-01 6.78603693E-02 + 9.10703170E-01 2.74236114E-01 9.848194150E-01 6.78811740E-02 + 9.10806448E-01 2.74282174E-01 9.860041980E-01 6.79020078E-02 + 9.10909726E-01 2.74328250E-01 9.871906940E-01 6.79228708E-02 + 9.11013004E-01 2.74374344E-01 9.883789060E-01 6.79437631E-02 + 9.11116281E-01 2.74420455E-01 9.895688380E-01 6.79646846E-02 + 9.11219559E-01 2.74466584E-01 9.907604930E-01 6.79856355E-02 + 9.11322837E-01 2.74512729E-01 9.919538740E-01 6.80066158E-02 + 9.11426115E-01 2.74558892E-01 9.931489840E-01 6.80276254E-02 + 9.11529392E-01 2.74605072E-01 9.943458270E-01 6.80486646E-02 + 9.11632670E-01 2.74651269E-01 9.955444060E-01 6.80697333E-02 + 9.11735948E-01 2.74697483E-01 9.967447240E-01 6.80908315E-02 + 9.11839226E-01 2.74743715E-01 9.979467840E-01 6.81119594E-02 + 9.11942503E-01 2.74789964E-01 9.991505900E-01 6.81331170E-02 + 9.12045781E-01 2.74836230E-01 1.000356150E+00 6.81543042E-02 + 9.12149059E-01 2.74882514E-01 1.001563450E+00 6.81755213E-02 + 9.12252337E-01 2.74928815E-01 1.002772510E+00 6.81967681E-02 + 9.12355614E-01 2.74975133E-01 1.003983340E+00 6.82180449E-02 + 9.12458892E-01 2.75021469E-01 1.005195920E+00 6.82393515E-02 + 9.12562170E-01 2.75067822E-01 1.006410270E+00 6.82606881E-02 + 9.12665448E-01 2.75114192E-01 1.007626390E+00 6.82820547E-02 + 9.12768725E-01 2.75160580E-01 1.008844270E+00 6.83034514E-02 + 9.12872003E-01 2.75206985E-01 1.010063940E+00 6.83248781E-02 + 9.12975281E-01 2.75253408E-01 1.011285380E+00 6.83463351E-02 + 9.13078559E-01 2.75299848E-01 1.012508610E+00 6.83678222E-02 + 9.13181836E-01 2.75346305E-01 1.013733620E+00 6.83893396E-02 + 9.13285114E-01 2.75392781E-01 1.014960420E+00 6.84108873E-02 + 9.13388392E-01 2.75439273E-01 1.016189010E+00 6.84324654E-02 + 9.13491670E-01 2.75485783E-01 1.017419400E+00 6.84540739E-02 + 9.13594947E-01 2.75532311E-01 1.018651590E+00 6.84757128E-02 + 9.13698225E-01 2.75578856E-01 1.019885570E+00 6.84973823E-02 + 9.13801503E-01 2.75625418E-01 1.021121370E+00 6.85190823E-02 + 9.13904781E-01 2.75671998E-01 1.022358970E+00 6.85408129E-02 + 9.14008058E-01 2.75718596E-01 1.023598390E+00 6.85625741E-02 + 9.14111336E-01 2.75765212E-01 1.024839620E+00 6.85843661E-02 + 9.14214614E-01 2.75811844E-01 1.026082670E+00 6.86061888E-02 + 9.14317892E-01 2.75858495E-01 1.027327550E+00 6.86280424E-02 + 9.14421169E-01 2.75905163E-01 1.028574250E+00 6.86499268E-02 + 9.14524447E-01 2.75951849E-01 1.029822780E+00 6.86718421E-02 + 9.14627725E-01 2.75998552E-01 1.031073150E+00 6.86937884E-02 + 9.14731003E-01 2.76045274E-01 1.032325350E+00 6.87157657E-02 + 9.14834280E-01 2.76092012E-01 1.033579390E+00 6.87377741E-02 + 9.14937558E-01 2.76138769E-01 1.034835280E+00 6.87598135E-02 + 9.15040836E-01 2.76185543E-01 1.036093010E+00 6.87818842E-02 + 9.15144114E-01 2.76232335E-01 1.037352590E+00 6.88039860E-02 + 9.15247391E-01 2.76279145E-01 1.038614030E+00 6.88261192E-02 + 9.15350669E-01 2.76325972E-01 1.039877330E+00 6.88482836E-02 + 9.15453947E-01 2.76372818E-01 1.041142480E+00 6.88704795E-02 + 9.15557225E-01 2.76419681E-01 1.042409510E+00 6.88927067E-02 + 9.15660502E-01 2.76466561E-01 1.043678400E+00 6.89149654E-02 + 9.15763780E-01 2.76513460E-01 1.044949160E+00 6.89372557E-02 + 9.15867058E-01 2.76560377E-01 1.046221800E+00 6.89595776E-02 + 9.15970336E-01 2.76607311E-01 1.047496320E+00 6.89819310E-02 + 9.16073613E-01 2.76654263E-01 1.048772720E+00 6.90043162E-02 + 9.16176891E-01 2.76701233E-01 1.050051000E+00 6.90267331E-02 + 9.16280169E-01 2.76748221E-01 1.051331180E+00 6.90491818E-02 + 9.16383447E-01 2.76795227E-01 1.052613250E+00 6.90716624E-02 + 9.16486724E-01 2.76842251E-01 1.053897220E+00 6.90941748E-02 + 9.16590002E-01 2.76889292E-01 1.055183090E+00 6.91167192E-02 + 9.16693280E-01 2.76936352E-01 1.056470860E+00 6.91392956E-02 + 9.16796558E-01 2.76983429E-01 1.057760540E+00 6.91619040E-02 + 9.16899835E-01 2.77030525E-01 1.059052140E+00 6.91845446E-02 + 9.17003113E-01 2.77077639E-01 1.060345650E+00 6.92072173E-02 + 9.17106391E-01 2.77124770E-01 1.061641070E+00 6.92299223E-02 + 9.17209669E-01 2.77171920E-01 1.062938430E+00 6.92526595E-02 + 9.17312946E-01 2.77219087E-01 1.064237700E+00 6.92754290E-02 + 9.17416224E-01 2.77266273E-01 1.065538910E+00 6.92982309E-02 + 9.17519502E-01 2.77313476E-01 1.066842050E+00 6.93210653E-02 + 9.17622780E-01 2.77360698E-01 1.068147130E+00 6.93439321E-02 + 9.17726057E-01 2.77407938E-01 1.069454150E+00 6.93668315E-02 + 9.17829335E-01 2.77455196E-01 1.070763120E+00 6.93897635E-02 + 9.17932613E-01 2.77502472E-01 1.072074040E+00 6.94127281E-02 + 9.18035890E-01 2.77549766E-01 1.073386910E+00 6.94357254E-02 + 9.18139168E-01 2.77597078E-01 1.074701730E+00 6.94587555E-02 + 9.18242446E-01 2.77644409E-01 1.076018510E+00 6.94818184E-02 + 9.18345724E-01 2.77691758E-01 1.077337260E+00 6.95049141E-02 + 9.18449001E-01 2.77739124E-01 1.078657980E+00 6.95280428E-02 + 9.18552279E-01 2.77786509E-01 1.079980670E+00 6.95512044E-02 + 9.18655557E-01 2.77833913E-01 1.081305330E+00 6.95743991E-02 + 9.18758835E-01 2.77881334E-01 1.082631980E+00 6.95976269E-02 + 9.18862112E-01 2.77928774E-01 1.083960600E+00 6.96208878E-02 + 9.18965390E-01 2.77976232E-01 1.085291220E+00 6.96441819E-02 + 9.19068668E-01 2.78023708E-01 1.086623820E+00 6.96675093E-02 + 9.19171946E-01 2.78071203E-01 1.087958420E+00 6.96908700E-02 + 9.19275223E-01 2.78118715E-01 1.089295020E+00 6.97142640E-02 + 9.19378501E-01 2.78166247E-01 1.090633610E+00 6.97376915E-02 + 9.19481779E-01 2.78213796E-01 1.091974220E+00 6.97611524E-02 + 9.19585057E-01 2.78261364E-01 1.093316840E+00 6.97846469E-02 + 9.19688334E-01 2.78308950E-01 1.094661470E+00 6.98081749E-02 + 9.19791612E-01 2.78356555E-01 1.096008110E+00 6.98317366E-02 + 9.19894890E-01 2.78404177E-01 1.097356780E+00 6.98553320E-02 + 9.19998168E-01 2.78451819E-01 1.098707480E+00 6.98789612E-02 + 9.20101445E-01 2.78499479E-01 1.100060210E+00 6.99026242E-02 + 9.20204723E-01 2.78547157E-01 1.101414960E+00 6.99263210E-02 + 9.20308001E-01 2.78594853E-01 1.102771760E+00 6.99500518E-02 + 9.20411279E-01 2.78642568E-01 1.104130600E+00 6.99738166E-02 + 9.20514556E-01 2.78690302E-01 1.105491480E+00 6.99976154E-02 + 9.20617834E-01 2.78738054E-01 1.106854420E+00 7.00214483E-02 + 9.20721112E-01 2.78785825E-01 1.108219400E+00 7.00453154E-02 + 9.20824390E-01 2.78833614E-01 1.109586450E+00 7.00692167E-02 + 9.20927667E-01 2.78881421E-01 1.110955560E+00 7.00931522E-02 + 9.21030945E-01 2.78929247E-01 1.112326730E+00 7.01171221E-02 + 9.21134223E-01 2.78977092E-01 1.113699970E+00 7.01411264E-02 + 9.21237501E-01 2.79024955E-01 1.115075290E+00 7.01651651E-02 + 9.21340778E-01 2.79072837E-01 1.116452680E+00 7.01892384E-02 + 9.21444056E-01 2.79120738E-01 1.117832160E+00 7.02133461E-02 + 9.21547334E-01 2.79168657E-01 1.119213720E+00 7.02374886E-02 + 9.21650612E-01 2.79216594E-01 1.120597370E+00 7.02616656E-02 + 9.21753889E-01 2.79264551E-01 1.121983110E+00 7.02858775E-02 + 9.21857167E-01 2.79312526E-01 1.123370960E+00 7.03101241E-02 + 9.21960445E-01 2.79360520E-01 1.124760910E+00 7.03344056E-02 + 9.22063723E-01 2.79408532E-01 1.126152960E+00 7.03587220E-02 + 9.22167000E-01 2.79456563E-01 1.127547120E+00 7.03830734E-02 + 9.22270278E-01 2.79504613E-01 1.128943400E+00 7.04074598E-02 + 9.22373556E-01 2.79552681E-01 1.130341800E+00 7.04318813E-02 + 9.22476834E-01 2.79600769E-01 1.131742320E+00 7.04563379E-02 + 9.22580111E-01 2.79648875E-01 1.133144970E+00 7.04808298E-02 + 9.22683389E-01 2.79696999E-01 1.134549740E+00 7.05053569E-02 + 9.22786667E-01 2.79745143E-01 1.135956660E+00 7.05299194E-02 + 9.22889945E-01 2.79793305E-01 1.137365710E+00 7.05545172E-02 + 9.22993222E-01 2.79841487E-01 1.138776910E+00 7.05791505E-02 + 9.23096500E-01 2.79889687E-01 1.140190260E+00 7.06038194E-02 + 9.23199778E-01 2.79937906E-01 1.141605760E+00 7.06285237E-02 + 9.23303056E-01 2.79986143E-01 1.143023420E+00 7.06532638E-02 + 9.23406333E-01 2.80034400E-01 1.144443230E+00 7.06780395E-02 + 9.23509611E-01 2.80082676E-01 1.145865220E+00 7.07028509E-02 + 9.23612889E-01 2.80130970E-01 1.147289370E+00 7.07276982E-02 + 9.23716167E-01 2.80179284E-01 1.148715700E+00 7.07525814E-02 + 9.23819444E-01 2.80227616E-01 1.150144200E+00 7.07775004E-02 + 9.23922722E-01 2.80275967E-01 1.151574890E+00 7.08024555E-02 + 9.24026000E-01 2.80324337E-01 1.153007760E+00 7.08274467E-02 + 9.24129278E-01 2.80372727E-01 1.154442830E+00 7.08524739E-02 + 9.24232555E-01 2.80421135E-01 1.155880090E+00 7.08775374E-02 + 9.24335833E-01 2.80469562E-01 1.157319550E+00 7.09026371E-02 + 9.24439111E-01 2.80518008E-01 1.158761220E+00 7.09277731E-02 + 9.24542389E-01 2.80566473E-01 1.160205090E+00 7.09529454E-02 + 9.24645666E-01 2.80614958E-01 1.161651180E+00 7.09781542E-02 + 9.24748944E-01 2.80663461E-01 1.163099480E+00 7.10033995E-02 + 9.24852222E-01 2.80711983E-01 1.164550010E+00 7.10286813E-02 + 9.24955500E-01 2.80760525E-01 1.166002760E+00 7.10539997E-02 + 9.25058777E-01 2.80809086E-01 1.167457740E+00 7.10793549E-02 + 9.25162055E-01 2.80857665E-01 1.168914960E+00 7.11047467E-02 + 9.25265333E-01 2.80906264E-01 1.170374420E+00 7.11301754E-02 + 9.25368611E-01 2.80954882E-01 1.171836120E+00 7.11556409E-02 + 9.25471888E-01 2.81003520E-01 1.173300070E+00 7.11811434E-02 + 9.25575166E-01 2.81052176E-01 1.174766280E+00 7.12066828E-02 + 9.25678444E-01 2.81100852E-01 1.176234740E+00 7.12322594E-02 + 9.25781721E-01 2.81149546E-01 1.177705460E+00 7.12578730E-02 + 9.25884999E-01 2.81198261E-01 1.179178450E+00 7.12835238E-02 + 9.25988277E-01 2.81246994E-01 1.180653710E+00 7.13092119E-02 + 9.26091555E-01 2.81295746E-01 1.182131250E+00 7.13349372E-02 + 9.26194832E-01 2.81344518E-01 1.183611060E+00 7.13607000E-02 + 9.26298110E-01 2.81393309E-01 1.185093170E+00 7.13865002E-02 + 9.26401388E-01 2.81442120E-01 1.186577560E+00 7.14123378E-02 + 9.26504666E-01 2.81490949E-01 1.188064240E+00 7.14382131E-02 + 9.26607943E-01 2.81539798E-01 1.189553220E+00 7.14641260E-02 + 9.26711221E-01 2.81588667E-01 1.191044510E+00 7.14900766E-02 + 9.26814499E-01 2.81637554E-01 1.192538100E+00 7.15160649E-02 + 9.26917777E-01 2.81686461E-01 1.194034010E+00 7.15420911E-02 + 9.27021054E-01 2.81735388E-01 1.195532230E+00 7.15681552E-02 + 9.27124332E-01 2.81784334E-01 1.197032780E+00 7.15942572E-02 + 9.27227610E-01 2.81833299E-01 1.198535650E+00 7.16203972E-02 + 9.27330888E-01 2.81882284E-01 1.200040850E+00 7.16465754E-02 + 9.27434165E-01 2.81931288E-01 1.201548390E+00 7.16727917E-02 + 9.27537443E-01 2.81980311E-01 1.203058270E+00 7.16990462E-02 + 9.27640721E-01 2.82029354E-01 1.204570490E+00 7.17253390E-02 + 9.27743999E-01 2.82078417E-01 1.206085060E+00 7.17516701E-02 + 9.27847276E-01 2.82127499E-01 1.207601990E+00 7.17780397E-02 + 9.27950554E-01 2.82176601E-01 1.209121280E+00 7.18044477E-02 + 9.28053832E-01 2.82225722E-01 1.210642930E+00 7.18308943E-02 + 9.28157110E-01 2.82274862E-01 1.212166950E+00 7.18573795E-02 + 9.28260387E-01 2.82324023E-01 1.213693340E+00 7.18839034E-02 + 9.28363665E-01 2.82373202E-01 1.215222110E+00 7.19104660E-02 + 9.28466943E-01 2.82422402E-01 1.216753270E+00 7.19370675E-02 + 9.28570221E-01 2.82471621E-01 1.218286810E+00 7.19637079E-02 + 9.28673498E-01 2.82520859E-01 1.219822750E+00 7.19903872E-02 + 9.28776776E-01 2.82570117E-01 1.221361080E+00 7.20171055E-02 + 9.28880054E-01 2.82619395E-01 1.222901820E+00 7.20438629E-02 + 9.28983332E-01 2.82668693E-01 1.224444960E+00 7.20706594E-02 + 9.29086609E-01 2.82718010E-01 1.225990520E+00 7.20974952E-02 + 9.29189887E-01 2.82767347E-01 1.227538490E+00 7.21243703E-02 + 9.29293165E-01 2.82816703E-01 1.229088890E+00 7.21512847E-02 + 9.29396443E-01 2.82866080E-01 1.230641710E+00 7.21782386E-02 + 9.29499720E-01 2.82915476E-01 1.232196960E+00 7.22052320E-02 + 9.29602998E-01 2.82964891E-01 1.233754650E+00 7.22322649E-02 + 9.29706276E-01 2.83014327E-01 1.235314790E+00 7.22593374E-02 + 9.29809554E-01 2.83063782E-01 1.236877370E+00 7.22864497E-02 + 9.29912831E-01 2.83113257E-01 1.238442400E+00 7.23136017E-02 + 9.30016109E-01 2.83162752E-01 1.240009890E+00 7.23407936E-02 + 9.30119387E-01 2.83212267E-01 1.241579840E+00 7.23680254E-02 + 9.30222665E-01 2.83261801E-01 1.243152260E+00 7.23952971E-02 + 9.30325942E-01 2.83311356E-01 1.244727150E+00 7.24226089E-02 + 9.30429220E-01 2.83360930E-01 1.246304510E+00 7.24499609E-02 + 9.30532498E-01 2.83410524E-01 1.247884360E+00 7.24773530E-02 + 9.30635776E-01 2.83460138E-01 1.249466700E+00 7.25047853E-02 + 9.30739053E-01 2.83509772E-01 1.251051530E+00 7.25322580E-02 + 9.30842331E-01 2.83559426E-01 1.252638850E+00 7.25597711E-02 + 9.30945609E-01 2.83609099E-01 1.254228680E+00 7.25873247E-02 + 9.31048887E-01 2.83658793E-01 1.255821010E+00 7.26149188E-02 + 9.31152164E-01 2.83708507E-01 1.257415860E+00 7.26425535E-02 + 9.31255442E-01 2.83758241E-01 1.259013220E+00 7.26702289E-02 + 9.31358720E-01 2.83807994E-01 1.260613110E+00 7.26979451E-02 + 9.31461998E-01 2.83857768E-01 1.262215530E+00 7.27257021E-02 + 9.31565275E-01 2.83907561E-01 1.263820480E+00 7.27534999E-02 + 9.31668553E-01 2.83957375E-01 1.265427960E+00 7.27813388E-02 + 9.31771831E-01 2.84007209E-01 1.267037990E+00 7.28092187E-02 + 9.31875109E-01 2.84057063E-01 1.268650570E+00 7.28371396E-02 + 9.31978386E-01 2.84106937E-01 1.270265710E+00 7.28651018E-02 + 9.32081664E-01 2.84156831E-01 1.271883400E+00 7.28931052E-02 + 9.32184942E-01 2.84206745E-01 1.273503660E+00 7.29211500E-02 + 9.32288220E-01 2.84256679E-01 1.275126490E+00 7.29492362E-02 + 9.32391497E-01 2.84306633E-01 1.276751890E+00 7.29773638E-02 + 9.32494775E-01 2.84356608E-01 1.278379870E+00 7.30055330E-02 + 9.32598053E-01 2.84406602E-01 1.280010440E+00 7.30337437E-02 + 9.32701331E-01 2.84456617E-01 1.281643600E+00 7.30619962E-02 + 9.32804608E-01 2.84506652E-01 1.283279360E+00 7.30902905E-02 + 9.32907886E-01 2.84556708E-01 1.284917720E+00 7.31186266E-02 + 9.33011164E-01 2.84606783E-01 1.286558690E+00 7.31470046E-02 + 9.33114442E-01 2.84656879E-01 1.288202260E+00 7.31754245E-02 + 9.33217719E-01 2.84706995E-01 1.289848460E+00 7.32038866E-02 + 9.33320997E-01 2.84757131E-01 1.291497280E+00 7.32323908E-02 + 9.33424275E-01 2.84807288E-01 1.293148730E+00 7.32609371E-02 + 9.33527552E-01 2.84857464E-01 1.294802810E+00 7.32895258E-02 + 9.33630830E-01 2.84907661E-01 1.296459540E+00 7.33181568E-02 + 9.33734108E-01 2.84957879E-01 1.298118910E+00 7.33468303E-02 + 9.33837386E-01 2.85008117E-01 1.299780920E+00 7.33755462E-02 + 9.33940663E-01 2.85058375E-01 1.301445600E+00 7.34043048E-02 + 9.34043941E-01 2.85108653E-01 1.303112940E+00 7.34331060E-02 + 9.34147219E-01 2.85158952E-01 1.304782940E+00 7.34619499E-02 + 9.34250497E-01 2.85209272E-01 1.306455620E+00 7.34908366E-02 + 9.34353774E-01 2.85259611E-01 1.308130970E+00 7.35197662E-02 + 9.34457052E-01 2.85309971E-01 1.309809010E+00 7.35487388E-02 + 9.34560330E-01 2.85360352E-01 1.311489740E+00 7.35777544E-02 + 9.34663608E-01 2.85410753E-01 1.313173160E+00 7.36068131E-02 + 9.34766885E-01 2.85461174E-01 1.314859290E+00 7.36359150E-02 + 9.34870163E-01 2.85511616E-01 1.316548120E+00 7.36650602E-02 + 9.34973441E-01 2.85562079E-01 1.318239660E+00 7.36942487E-02 + 9.35076719E-01 2.85612562E-01 1.319933920E+00 7.37234806E-02 + 9.35179996E-01 2.85663065E-01 1.321630900E+00 7.37527560E-02 + 9.35283274E-01 2.85713589E-01 1.323330610E+00 7.37820750E-02 + 9.35386552E-01 2.85764134E-01 1.325033060E+00 7.38114377E-02 + 9.35489830E-01 2.85814699E-01 1.326738250E+00 7.38408440E-02 + 9.35593107E-01 2.85865285E-01 1.328446180E+00 7.38702942E-02 + 9.35696385E-01 2.85915891E-01 1.330156860E+00 7.38997882E-02 + 9.35799663E-01 2.85966518E-01 1.331870310E+00 7.39293262E-02 + 9.35902941E-01 2.86017166E-01 1.333586510E+00 7.39589083E-02 + 9.36006218E-01 2.86067834E-01 1.335305490E+00 7.39885344E-02 + 9.36109496E-01 2.86118523E-01 1.337027240E+00 7.40182048E-02 + 9.36212774E-01 2.86169233E-01 1.338751770E+00 7.40479194E-02 + 9.36316052E-01 2.86219963E-01 1.340479080E+00 7.40776784E-02 + 9.36419329E-01 2.86270714E-01 1.342209190E+00 7.41074818E-02 + 9.36522607E-01 2.86321486E-01 1.343942100E+00 7.41373297E-02 + 9.36625885E-01 2.86372278E-01 1.345677810E+00 7.41672222E-02 + 9.36729163E-01 2.86423091E-01 1.347416340E+00 7.41971594E-02 + 9.36832440E-01 2.86473925E-01 1.349157670E+00 7.42271413E-02 + 9.36935718E-01 2.86524780E-01 1.350901830E+00 7.42571681E-02 + 9.37038996E-01 2.86575655E-01 1.352648820E+00 7.42872397E-02 + 9.37142274E-01 2.86626552E-01 1.354398640E+00 7.43173563E-02 + 9.37245551E-01 2.86677469E-01 1.356151300E+00 7.43475181E-02 + 9.37348829E-01 2.86728407E-01 1.357906810E+00 7.43777249E-02 + 9.37452107E-01 2.86779365E-01 1.359665170E+00 7.44079770E-02 + 9.37555385E-01 2.86830345E-01 1.361426380E+00 7.44382744E-02 + 9.37658662E-01 2.86881345E-01 1.363190460E+00 7.44686172E-02 + 9.37761940E-01 2.86932367E-01 1.364957410E+00 7.44990055E-02 + 9.37865218E-01 2.86983409E-01 1.366727240E+00 7.45294393E-02 + 9.37968496E-01 2.87034472E-01 1.368499950E+00 7.45599187E-02 + 9.38071773E-01 2.87085556E-01 1.370275540E+00 7.45904439E-02 + 9.38175051E-01 2.87136661E-01 1.372054030E+00 7.46210149E-02 + 9.38278329E-01 2.87187787E-01 1.373835420E+00 7.46516317E-02 + 9.38381607E-01 2.87238934E-01 1.375619720E+00 7.46822945E-02 + 9.38484884E-01 2.87290102E-01 1.377406920E+00 7.47130034E-02 + 9.38588162E-01 2.87341291E-01 1.379197050E+00 7.47437584E-02 + 9.38691440E-01 2.87392501E-01 1.380990100E+00 7.47745596E-02 + 9.38794718E-01 2.87443733E-01 1.382786090E+00 7.48054071E-02 + 9.38897995E-01 2.87494985E-01 1.384585010E+00 7.48363010E-02 + 9.39001273E-01 2.87546258E-01 1.386386870E+00 7.48672413E-02 + 9.39104551E-01 2.87597552E-01 1.388191690E+00 7.48982282E-02 + 9.39207829E-01 2.87648867E-01 1.389999460E+00 7.49292617E-02 + 9.39311106E-01 2.87700204E-01 1.391810190E+00 7.49603419E-02 + 9.39414384E-01 2.87751561E-01 1.393623890E+00 7.49914690E-02 + 9.39517662E-01 2.87802940E-01 1.395440570E+00 7.50226429E-02 + 9.39620940E-01 2.87854340E-01 1.397260220E+00 7.50538637E-02 + 9.39724217E-01 2.87905761E-01 1.399082870E+00 7.50851317E-02 + 9.39827495E-01 2.87957203E-01 1.400908510E+00 7.51164467E-02 + 9.39930773E-01 2.88008666E-01 1.402737150E+00 7.51478090E-02 + 9.40034051E-01 2.88060151E-01 1.404568790E+00 7.51792186E-02 + 9.40137328E-01 2.88111656E-01 1.406403450E+00 7.52106756E-02 + 9.40240606E-01 2.88163183E-01 1.408241130E+00 7.52421800E-02 + 9.40343884E-01 2.88214732E-01 1.410081840E+00 7.52737320E-02 + 9.40447162E-01 2.88266301E-01 1.411925580E+00 7.53053317E-02 + 9.40550439E-01 2.88317892E-01 1.413772350E+00 7.53369791E-02 + 9.40653717E-01 2.88369504E-01 1.415622180E+00 7.53686743E-02 + 9.40756995E-01 2.88421137E-01 1.417475050E+00 7.54004174E-02 + 9.40860273E-01 2.88472792E-01 1.419330980E+00 7.54322085E-02 + 9.40963550E-01 2.88524468E-01 1.421189980E+00 7.54640477E-02 + 9.41066828E-01 2.88576165E-01 1.423052050E+00 7.54959351E-02 + 9.41170106E-01 2.88627884E-01 1.424917200E+00 7.55278707E-02 + 9.41273384E-01 2.88679624E-01 1.426785440E+00 7.55598547E-02 + 9.41376661E-01 2.88731386E-01 1.428656760E+00 7.55918871E-02 + 9.41479939E-01 2.88783169E-01 1.430531180E+00 7.56239680E-02 + 9.41583217E-01 2.88834973E-01 1.432408710E+00 7.56560976E-02 + 9.41686494E-01 2.88886799E-01 1.434289350E+00 7.56882758E-02 + 9.41789772E-01 2.88938646E-01 1.436173110E+00 7.57205028E-02 + 9.41893050E-01 2.88990514E-01 1.438059990E+00 7.57527787E-02 + 9.41996328E-01 2.89042404E-01 1.439950010E+00 7.57851035E-02 + 9.42099605E-01 2.89094316E-01 1.441843160E+00 7.58174774E-02 + 9.42202883E-01 2.89146249E-01 1.443739460E+00 7.58499004E-02 + 9.42306161E-01 2.89198204E-01 1.445638910E+00 7.58823727E-02 + 9.42409439E-01 2.89250180E-01 1.447541520E+00 7.59148943E-02 + 9.42512716E-01 2.89302178E-01 1.449447300E+00 7.59474653E-02 + 9.42615994E-01 2.89354197E-01 1.451356240E+00 7.59800857E-02 + 9.42719272E-01 2.89406238E-01 1.453268370E+00 7.60127558E-02 + 9.42822550E-01 2.89458300E-01 1.455183680E+00 7.60454756E-02 + 9.42925827E-01 2.89510384E-01 1.457102190E+00 7.60782451E-02 + 9.43029105E-01 2.89562490E-01 1.459023900E+00 7.61110645E-02 + 9.43132383E-01 2.89614617E-01 1.460948810E+00 7.61439338E-02 + 9.43235661E-01 2.89666766E-01 1.462876940E+00 7.61768532E-02 + 9.43338938E-01 2.89718937E-01 1.464808280E+00 7.62098227E-02 + 9.43442216E-01 2.89771129E-01 1.466742860E+00 7.62428425E-02 + 9.43545494E-01 2.89823343E-01 1.468680670E+00 7.62759125E-02 + 9.43648772E-01 2.89875578E-01 1.470621720E+00 7.63090330E-02 + 9.43752049E-01 2.89927836E-01 1.472566020E+00 7.63422040E-02 + 9.43855327E-01 2.89980115E-01 1.474513580E+00 7.63754256E-02 + 9.43958605E-01 2.90032416E-01 1.476464400E+00 7.64086978E-02 + 9.44061883E-01 2.90084738E-01 1.478418490E+00 7.64420209E-02 + 9.44165160E-01 2.90137083E-01 1.480375860E+00 7.64753948E-02 + 9.44268438E-01 2.90189449E-01 1.482336510E+00 7.65088197E-02 + 9.44371716E-01 2.90241837E-01 1.484300450E+00 7.65422956E-02 + 9.44474994E-01 2.90294246E-01 1.486267690E+00 7.65758227E-02 + 9.44578271E-01 2.90346678E-01 1.488238240E+00 7.66094011E-02 + 9.44681549E-01 2.90399131E-01 1.490212100E+00 7.66430308E-02 + 9.44784827E-01 2.90451607E-01 1.492189280E+00 7.66767119E-02 + 9.44888105E-01 2.90504104E-01 1.494169790E+00 7.67104446E-02 + 9.44991382E-01 2.90556623E-01 1.496153630E+00 7.67442289E-02 + 9.45094660E-01 2.90609164E-01 1.498140820E+00 7.67780649E-02 + 9.45197938E-01 2.90661727E-01 1.500131350E+00 7.68119527E-02 + 9.45301216E-01 2.90714312E-01 1.502125250E+00 7.68458925E-02 + 9.45404493E-01 2.90766918E-01 1.504122500E+00 7.68798842E-02 + 9.45507771E-01 2.90819547E-01 1.506123130E+00 7.69139281E-02 + 9.45611049E-01 2.90872198E-01 1.508127130E+00 7.69480241E-02 + 9.45714327E-01 2.90924870E-01 1.510134530E+00 7.69821725E-02 + 9.45817604E-01 2.90977565E-01 1.512145310E+00 7.70163732E-02 + 9.45920882E-01 2.91030282E-01 1.514159500E+00 7.70506265E-02 + 9.46024160E-01 2.91083020E-01 1.516177090E+00 7.70849323E-02 + 9.46127438E-01 2.91135781E-01 1.518198100E+00 7.71192908E-02 + 9.46230715E-01 2.91188564E-01 1.520222540E+00 7.71537021E-02 + 9.46333993E-01 2.91241368E-01 1.522250410E+00 7.71881663E-02 + 9.46437271E-01 2.91294195E-01 1.524281710E+00 7.72226834E-02 + 9.46540549E-01 2.91347044E-01 1.526316460E+00 7.72572536E-02 + 9.46643826E-01 2.91399916E-01 1.528354670E+00 7.72918770E-02 + 9.46747104E-01 2.91452809E-01 1.530396330E+00 7.73265537E-02 + 9.46850382E-01 2.91505724E-01 1.532441470E+00 7.73612837E-02 + 9.46953660E-01 2.91558662E-01 1.534490080E+00 7.73960673E-02 + 9.47056937E-01 2.91611621E-01 1.536542170E+00 7.74309043E-02 + 9.47160215E-01 2.91664603E-01 1.538597760E+00 7.74657951E-02 + 9.47263493E-01 2.91717607E-01 1.540656850E+00 7.75007396E-02 + 9.47366771E-01 2.91770634E-01 1.542719450E+00 7.75357380E-02 + 9.47470048E-01 2.91823682E-01 1.544785560E+00 7.75707903E-02 + 9.47573326E-01 2.91876753E-01 1.546855190E+00 7.76058967E-02 + 9.47676604E-01 2.91929846E-01 1.548928350E+00 7.76410573E-02 + 9.47779882E-01 2.91982961E-01 1.551005060E+00 7.76762722E-02 + 9.47883159E-01 2.92036099E-01 1.553085310E+00 7.77115414E-02 + 9.47986437E-01 2.92089259E-01 1.555169110E+00 7.77468651E-02 + 9.48089715E-01 2.92142441E-01 1.557256480E+00 7.77822434E-02 + 9.48192993E-01 2.92195645E-01 1.559347410E+00 7.78176763E-02 + 9.48296270E-01 2.92248872E-01 1.561441930E+00 7.78531640E-02 + 9.48399548E-01 2.92302121E-01 1.563540020E+00 7.78887066E-02 + 9.48502826E-01 2.92355393E-01 1.565641720E+00 7.79243042E-02 + 9.48606104E-01 2.92408686E-01 1.567747010E+00 7.79599569E-02 + 9.48709381E-01 2.92462003E-01 1.569855920E+00 7.79956647E-02 + 9.48812659E-01 2.92515341E-01 1.571968440E+00 7.80314278E-02 + 9.48915937E-01 2.92568702E-01 1.574084590E+00 7.80672464E-02 + 9.49019215E-01 2.92622086E-01 1.576204380E+00 7.81031204E-02 + 9.49122492E-01 2.92675492E-01 1.578327800E+00 7.81390500E-02 + 9.49225770E-01 2.92728920E-01 1.580454880E+00 7.81750354E-02 + 9.49329048E-01 2.92782371E-01 1.582585610E+00 7.82110765E-02 + 9.49432325E-01 2.92835845E-01 1.584720010E+00 7.82471736E-02 + 9.49535603E-01 2.92889340E-01 1.586858090E+00 7.82833266E-02 + 9.49638881E-01 2.92942859E-01 1.588999840E+00 7.83195358E-02 + 9.49742159E-01 2.92996400E-01 1.591145290E+00 7.83558012E-02 + 9.49845436E-01 2.93049963E-01 1.593294440E+00 7.83921230E-02 + 9.49948714E-01 2.93103549E-01 1.595447300E+00 7.84285012E-02 + 9.50051992E-01 2.93157158E-01 1.597603870E+00 7.84649359E-02 + 9.50155270E-01 2.93210789E-01 1.599764170E+00 7.85014273E-02 + 9.50258547E-01 2.93264443E-01 1.601928200E+00 7.85379755E-02 + 9.50361825E-01 2.93318119E-01 1.604095970E+00 7.85745805E-02 + 9.50465103E-01 2.93371818E-01 1.606267490E+00 7.86112424E-02 + 9.50568381E-01 2.93425540E-01 1.608442770E+00 7.86479615E-02 + 9.50671658E-01 2.93479284E-01 1.610621810E+00 7.86847378E-02 + 9.50774936E-01 2.93533051E-01 1.612804630E+00 7.87215713E-02 + 9.50878214E-01 2.93586841E-01 1.614991230E+00 7.87584622E-02 + 9.50981492E-01 2.93640653E-01 1.617181630E+00 7.87954107E-02 + 9.51084769E-01 2.93694488E-01 1.619375820E+00 7.88324167E-02 + 9.51188047E-01 2.93748346E-01 1.621573820E+00 7.88694805E-02 + 9.51291325E-01 2.93802226E-01 1.623775640E+00 7.89066022E-02 + 9.51394603E-01 2.93856129E-01 1.625981290E+00 7.89437817E-02 + 9.51497880E-01 2.93910055E-01 1.628190770E+00 7.89810193E-02 + 9.51601158E-01 2.93964004E-01 1.630404090E+00 7.90183151E-02 + 9.51704436E-01 2.94017976E-01 1.632621270E+00 7.90556692E-02 + 9.51807714E-01 2.94071970E-01 1.634842310E+00 7.90930816E-02 + 9.51910991E-01 2.94125987E-01 1.637067210E+00 7.91305526E-02 + 9.52014269E-01 2.94180027E-01 1.639295990E+00 7.91680821E-02 + 9.52117547E-01 2.94234090E-01 1.641528670E+00 7.92056704E-02 + 9.52220825E-01 2.94288176E-01 1.643765230E+00 7.92433175E-02 + 9.52324102E-01 2.94342284E-01 1.646005700E+00 7.92810235E-02 + 9.52427380E-01 2.94396416E-01 1.648250080E+00 7.93187885E-02 + 9.52530658E-01 2.94450570E-01 1.650498390E+00 7.93566128E-02 + 9.52633936E-01 2.94504747E-01 1.652750630E+00 7.93944963E-02 + 9.52737213E-01 2.94558948E-01 1.655006800E+00 7.94324392E-02 + 9.52840491E-01 2.94613171E-01 1.657266930E+00 7.94704415E-02 + 9.52943769E-01 2.94667417E-01 1.659531010E+00 7.95085035E-02 + 9.53047047E-01 2.94721686E-01 1.661799060E+00 7.95466253E-02 + 9.53150324E-01 2.94775978E-01 1.664071090E+00 7.95848068E-02 + 9.53253602E-01 2.94830293E-01 1.666347100E+00 7.96230483E-02 + 9.53356880E-01 2.94884631E-01 1.668627100E+00 7.96613499E-02 + 9.53460158E-01 2.94938992E-01 1.670911110E+00 7.96997117E-02 + 9.53563435E-01 2.94993376E-01 1.673199130E+00 7.97381337E-02 + 9.53666713E-01 2.95047783E-01 1.675491170E+00 7.97766162E-02 + 9.53769991E-01 2.95102213E-01 1.677787240E+00 7.98151592E-02 + 9.53873269E-01 2.95156667E-01 1.680087350E+00 7.98537628E-02 + 9.53976546E-01 2.95211143E-01 1.682391510E+00 7.98924272E-02 + 9.54079824E-01 2.95265642E-01 1.684699730E+00 7.99311525E-02 + 9.54183102E-01 2.95320165E-01 1.687012010E+00 7.99699387E-02 + 9.54286380E-01 2.95374711E-01 1.689328370E+00 8.00087861E-02 + 9.54389657E-01 2.95429279E-01 1.691648820E+00 8.00476946E-02 + 9.54492935E-01 2.95483871E-01 1.693973360E+00 8.00866645E-02 + 9.54596213E-01 2.95538486E-01 1.696302010E+00 8.01256959E-02 + 9.54699491E-01 2.95593125E-01 1.698634770E+00 8.01647888E-02 + 9.54802768E-01 2.95647786E-01 1.700971650E+00 8.02039435E-02 + 9.54906046E-01 2.95702471E-01 1.703312670E+00 8.02431599E-02 + 9.55009324E-01 2.95757179E-01 1.705657830E+00 8.02824383E-02 + 9.55112602E-01 2.95811910E-01 1.708007140E+00 8.03217787E-02 + 9.55215879E-01 2.95866665E-01 1.710360610E+00 8.03611812E-02 + 9.55319157E-01 2.95921442E-01 1.712718250E+00 8.04006461E-02 + 9.55422435E-01 2.95976243E-01 1.715080080E+00 8.04401734E-02 + 9.55525713E-01 2.96031067E-01 1.717446090E+00 8.04797631E-02 + 9.55628990E-01 2.96085915E-01 1.719816300E+00 8.05194156E-02 + 9.55732268E-01 2.96140786E-01 1.722190720E+00 8.05591307E-02 + 9.55835546E-01 2.96195680E-01 1.724569370E+00 8.05989088E-02 + 9.55938824E-01 2.96250598E-01 1.726952240E+00 8.06387499E-02 + 9.56042101E-01 2.96305538E-01 1.729339340E+00 8.06786541E-02 + 9.56145379E-01 2.96360503E-01 1.731730700E+00 8.07186215E-02 + 9.56248657E-01 2.96415490E-01 1.734126320E+00 8.07586524E-02 + 9.56351935E-01 2.96470501E-01 1.736526200E+00 8.07987467E-02 + 9.56455212E-01 2.96525536E-01 1.738930360E+00 8.08389046E-02 + 9.56558490E-01 2.96580594E-01 1.741338810E+00 8.08791262E-02 + 9.56661768E-01 2.96635675E-01 1.743751550E+00 8.09194117E-02 + 9.56765046E-01 2.96690780E-01 1.746168610E+00 8.09597612E-02 + 9.56868323E-01 2.96745908E-01 1.748589980E+00 8.10001748E-02 + 9.56971601E-01 2.96801059E-01 1.751015680E+00 8.10406527E-02 + 9.57074879E-01 2.96856235E-01 1.753445710E+00 8.10811948E-02 + 9.57178156E-01 2.96911433E-01 1.755880090E+00 8.11218015E-02 + 9.57281434E-01 2.96966655E-01 1.758318830E+00 8.11624728E-02 + 9.57384712E-01 2.97021901E-01 1.760761940E+00 8.12032087E-02 + 9.57487990E-01 2.97077170E-01 1.763209430E+00 8.12440096E-02 + 9.57591267E-01 2.97132463E-01 1.765661300E+00 8.12848754E-02 + 9.57694545E-01 2.97187779E-01 1.768117570E+00 8.13258063E-02 + 9.57797823E-01 2.97243119E-01 1.770578250E+00 8.13668025E-02 + 9.57901101E-01 2.97298483E-01 1.773043350E+00 8.14078640E-02 + 9.58004378E-01 2.97353870E-01 1.775512880E+00 8.14489909E-02 + 9.58107656E-01 2.97409281E-01 1.777986850E+00 8.14901835E-02 + 9.58210934E-01 2.97464715E-01 1.780465260E+00 8.15314419E-02 + 9.58314212E-01 2.97520173E-01 1.782948140E+00 8.15727660E-02 + 9.58417489E-01 2.97575655E-01 1.785435480E+00 8.16141562E-02 + 9.58520767E-01 2.97631160E-01 1.787927310E+00 8.16556125E-02 + 9.58624045E-01 2.97686689E-01 1.790423630E+00 8.16971351E-02 + 9.58727323E-01 2.97742242E-01 1.792924450E+00 8.17387240E-02 + 9.58830600E-01 2.97797818E-01 1.795429780E+00 8.17803795E-02 + 9.58933878E-01 2.97853418E-01 1.797939630E+00 8.18221015E-02 + 9.59037156E-01 2.97909042E-01 1.800454020E+00 8.18638904E-02 + 9.59140434E-01 2.97964690E-01 1.802972950E+00 8.19057461E-02 + 9.59243711E-01 2.98020361E-01 1.805496440E+00 8.19476689E-02 + 9.59346989E-01 2.98076056E-01 1.808024490E+00 8.19896588E-02 + 9.59450267E-01 2.98131775E-01 1.810557120E+00 8.20317160E-02 + 9.59553545E-01 2.98187518E-01 1.813094330E+00 8.20738406E-02 + 9.59656822E-01 2.98243285E-01 1.815636140E+00 8.21160328E-02 + 9.59760100E-01 2.98299075E-01 1.818182560E+00 8.21582926E-02 + 9.59863378E-01 2.98354889E-01 1.820733600E+00 8.22006203E-02 + 9.59966656E-01 2.98410727E-01 1.823289270E+00 8.22430159E-02 + 9.60069933E-01 2.98466589E-01 1.825849570E+00 8.22854796E-02 + 9.60173211E-01 2.98522475E-01 1.828414530E+00 8.23280115E-02 + 9.60276489E-01 2.98578385E-01 1.830984150E+00 8.23706118E-02 + 9.60379767E-01 2.98634318E-01 1.833558450E+00 8.24132805E-02 + 9.60483044E-01 2.98690276E-01 1.836137430E+00 8.24560178E-02 + 9.60586322E-01 2.98746257E-01 1.838721100E+00 8.24988239E-02 + 9.60689600E-01 2.98802262E-01 1.841309490E+00 8.25416989E-02 + 9.60792878E-01 2.98858292E-01 1.843902590E+00 8.25846429E-02 + 9.60896155E-01 2.98914345E-01 1.846500410E+00 8.26276561E-02 + 9.60999433E-01 2.98970422E-01 1.849102980E+00 8.26707385E-02 + 9.61102711E-01 2.99026524E-01 1.851710300E+00 8.27138904E-02 + 9.61205989E-01 2.99082649E-01 1.854322380E+00 8.27571118E-02 + 9.61309266E-01 2.99138798E-01 1.856939240E+00 8.28004029E-02 + 9.61412544E-01 2.99194971E-01 1.859560880E+00 8.28437639E-02 + 9.61515822E-01 2.99251169E-01 1.862187310E+00 8.28871948E-02 + 9.61619100E-01 2.99307390E-01 1.864818560E+00 8.29306959E-02 + 9.61722377E-01 2.99363636E-01 1.867454620E+00 8.29742672E-02 + 9.61825655E-01 2.99419905E-01 1.870095510E+00 8.30179088E-02 + 9.61928933E-01 2.99476199E-01 1.872741250E+00 8.30616210E-02 + 9.62032211E-01 2.99532516E-01 1.875391830E+00 8.31054039E-02 + 9.62135488E-01 2.99588858E-01 1.878047290E+00 8.31492576E-02 + 9.62238766E-01 2.99645224E-01 1.880707620E+00 8.31931822E-02 + 9.62342044E-01 2.99701614E-01 1.883372830E+00 8.32371779E-02 + 9.62445322E-01 2.99758029E-01 1.886042950E+00 8.32812449E-02 + 9.62548599E-01 2.99814467E-01 1.888717980E+00 8.33253831E-02 + 9.62651877E-01 2.99870930E-01 1.891397930E+00 8.33695929E-02 + 9.62755155E-01 2.99927417E-01 1.894082810E+00 8.34138744E-02 + 9.62858433E-01 2.99983928E-01 1.896772640E+00 8.34582276E-02 + 9.62961710E-01 3.00040463E-01 1.899467430E+00 8.35026528E-02 + 9.63064988E-01 3.00097022E-01 1.902167190E+00 8.35471500E-02 + 9.63168266E-01 3.00153606E-01 1.904871930E+00 8.35917195E-02 + 9.63271544E-01 3.00210214E-01 1.907581670E+00 8.36363613E-02 + 9.63374821E-01 3.00266846E-01 1.910296410E+00 8.36810756E-02 + 9.63478099E-01 3.00323503E-01 1.913016170E+00 8.37258626E-02 + 9.63581377E-01 3.00380184E-01 1.915740960E+00 8.37707223E-02 + 9.63684655E-01 3.00436889E-01 1.918470790E+00 8.38156550E-02 + 9.63787932E-01 3.00493618E-01 1.921205670E+00 8.38606608E-02 + 9.63891210E-01 3.00550372E-01 1.923945620E+00 8.39057398E-02 + 9.63994488E-01 3.00607150E-01 1.926690650E+00 8.39508922E-02 + 9.64097766E-01 3.00663952E-01 1.929440760E+00 8.39961181E-02 + 9.64201043E-01 3.00720779E-01 1.932195980E+00 8.40414176E-02 + 9.64304321E-01 3.00777630E-01 1.934956320E+00 8.40867910E-02 + 9.64407599E-01 3.00834506E-01 1.937721780E+00 8.41322383E-02 + 9.64510877E-01 3.00891406E-01 1.940492380E+00 8.41777597E-02 + 9.64614154E-01 3.00948330E-01 1.943268130E+00 8.42233554E-02 + 9.64717432E-01 3.01005279E-01 1.946049050E+00 8.42690254E-02 + 9.64820710E-01 3.01062252E-01 1.948835140E+00 8.43147700E-02 + 9.64923987E-01 3.01119250E-01 1.951626420E+00 8.43605893E-02 + 9.65027265E-01 3.01176272E-01 1.954422900E+00 8.44064835E-02 + 9.65130543E-01 3.01233319E-01 1.957224600E+00 8.44524527E-02 + 9.65233821E-01 3.01290390E-01 1.960031520E+00 8.44984970E-02 + 9.65337098E-01 3.01347486E-01 1.962843680E+00 8.45446165E-02 + 9.65440376E-01 3.01404606E-01 1.965661090E+00 8.45908116E-02 + 9.65543654E-01 3.01461751E-01 1.968483770E+00 8.46370822E-02 + 9.65646932E-01 3.01518920E-01 1.971311720E+00 8.46834286E-02 + 9.65750209E-01 3.01576113E-01 1.974144960E+00 8.47298509E-02 + 9.65853487E-01 3.01633332E-01 1.976983510E+00 8.47763492E-02 + 9.65956765E-01 3.01690575E-01 1.979827370E+00 8.48229238E-02 + 9.66060043E-01 3.01747842E-01 1.982676560E+00 8.48695747E-02 + 9.66163320E-01 3.01805134E-01 1.985531090E+00 8.49163021E-02 + 9.66266598E-01 3.01862451E-01 1.988390970E+00 8.49631061E-02 + 9.66369876E-01 3.01919792E-01 1.991256220E+00 8.50099870E-02 + 9.66473154E-01 3.01977158E-01 1.994126850E+00 8.50569449E-02 + 9.66576431E-01 3.02034549E-01 1.997002880E+00 8.51039799E-02 + 9.66679709E-01 3.02091964E-01 1.999884310E+00 8.51510922E-02 + 9.66782987E-01 3.02149404E-01 2.002771160E+00 8.51982819E-02 + 9.66886265E-01 3.02206868E-01 2.005663440E+00 8.52455492E-02 + 9.66989542E-01 3.02264358E-01 2.008561170E+00 8.52928942E-02 + 9.67092820E-01 3.02321872E-01 2.011464360E+00 8.53403172E-02 + 9.67196098E-01 3.02379410E-01 2.014373010E+00 8.53878182E-02 + 9.67299376E-01 3.02436974E-01 2.017287160E+00 8.54353974E-02 + 9.67402653E-01 3.02494562E-01 2.020206800E+00 8.54830550E-02 + 9.67505931E-01 3.02552175E-01 2.023131960E+00 8.55307912E-02 + 9.67609209E-01 3.02609813E-01 2.026062640E+00 8.55786060E-02 + 9.67712487E-01 3.02667475E-01 2.028998860E+00 8.56264997E-02 + 9.67815764E-01 3.02725162E-01 2.031940630E+00 8.56744725E-02 + 9.67919042E-01 3.02782874E-01 2.034887970E+00 8.57225244E-02 + 9.68022320E-01 3.02840611E-01 2.037840890E+00 8.57706556E-02 + 9.68125598E-01 3.02898373E-01 2.040799410E+00 8.58188663E-02 + 9.68228875E-01 3.02956159E-01 2.043763530E+00 8.58671567E-02 + 9.68332153E-01 3.03013971E-01 2.046733270E+00 8.59155268E-02 + 9.68435431E-01 3.03071807E-01 2.049708640E+00 8.59639770E-02 + 9.68538709E-01 3.03129668E-01 2.052689670E+00 8.60125073E-02 + 9.68641986E-01 3.03187554E-01 2.055676360E+00 8.60611179E-02 + 9.68745264E-01 3.03245465E-01 2.058668720E+00 8.61098090E-02 + 9.68848542E-01 3.03303400E-01 2.061666770E+00 8.61585807E-02 + 9.68951820E-01 3.03361361E-01 2.064670530E+00 8.62074332E-02 + 9.69055097E-01 3.03419347E-01 2.067680010E+00 8.62563666E-02 + 9.69158375E-01 3.03477357E-01 2.070695210E+00 8.63053812E-02 + 9.69261653E-01 3.03535393E-01 2.073716170E+00 8.63544770E-02 + 9.69364931E-01 3.03593453E-01 2.076742880E+00 8.64036543E-02 + 9.69468208E-01 3.03651538E-01 2.079775370E+00 8.64529132E-02 + 9.69571486E-01 3.03709649E-01 2.082813650E+00 8.65022539E-02 + 9.69674764E-01 3.03767784E-01 2.085857730E+00 8.65516766E-02 + 9.69778042E-01 3.03825945E-01 2.088907630E+00 8.66011814E-02 + 9.69881319E-01 3.03884130E-01 2.091963360E+00 8.66507684E-02 + 9.69984597E-01 3.03942341E-01 2.095024940E+00 8.67004379E-02 + 9.70087875E-01 3.04000576E-01 2.098092380E+00 8.67501900E-02 + 9.70191153E-01 3.04058837E-01 2.101165690E+00 8.68000249E-02 + 9.70294430E-01 3.04117122E-01 2.104244890E+00 8.68499428E-02 + 9.70397708E-01 3.04175433E-01 2.107330000E+00 8.68999438E-02 + 9.70500986E-01 3.04233769E-01 2.110421030E+00 8.69500281E-02 + 9.70604264E-01 3.04292129E-01 2.113517990E+00 8.70001958E-02 + 9.70707541E-01 3.04350515E-01 2.116620890E+00 8.70504472E-02 + 9.70810819E-01 3.04408926E-01 2.119729760E+00 8.71007825E-02 + 9.70914097E-01 3.04467363E-01 2.122844610E+00 8.71512016E-02 + 9.71017375E-01 3.04525824E-01 2.125965450E+00 8.72017050E-02 + 9.71120652E-01 3.04584311E-01 2.129092300E+00 8.72522926E-02 + 9.71223930E-01 3.04642822E-01 2.132225170E+00 8.73029648E-02 + 9.71327208E-01 3.04701359E-01 2.135364080E+00 8.73537217E-02 + 9.71430486E-01 3.04759921E-01 2.138509040E+00 8.74045633E-02 + 9.71533763E-01 3.04818508E-01 2.141660070E+00 8.74554900E-02 + 9.71637041E-01 3.04877121E-01 2.144817180E+00 8.75065019E-02 + 9.71740319E-01 3.04935759E-01 2.147980380E+00 8.75575992E-02 + 9.71843597E-01 3.04994421E-01 2.151149700E+00 8.76087820E-02 + 9.71946874E-01 3.05053110E-01 2.154325150E+00 8.76600506E-02 + 9.72050152E-01 3.05111823E-01 2.157506740E+00 8.77114050E-02 + 9.72153430E-01 3.05170562E-01 2.160694490E+00 8.77628455E-02 + 9.72256708E-01 3.05229326E-01 2.163888420E+00 8.78143723E-02 + 9.72359985E-01 3.05288115E-01 2.167088530E+00 8.78659854E-02 + 9.72463263E-01 3.05346929E-01 2.170294850E+00 8.79176852E-02 + 9.72566541E-01 3.05405769E-01 2.173507390E+00 8.79694718E-02 + 9.72669819E-01 3.05464634E-01 2.176726170E+00 8.80213454E-02 + 9.72773096E-01 3.05523525E-01 2.179951190E+00 8.80733061E-02 + 9.72876374E-01 3.05582441E-01 2.183182490E+00 8.81253541E-02 + 9.72979652E-01 3.05641382E-01 2.186420070E+00 8.81774896E-02 + 9.73082929E-01 3.05700348E-01 2.189663940E+00 8.82297129E-02 + 9.73186207E-01 3.05759340E-01 2.192914130E+00 8.82820239E-02 + 9.73289485E-01 3.05818358E-01 2.196170650E+00 8.83344231E-02 + 9.73392763E-01 3.05877400E-01 2.199433520E+00 8.83869104E-02 + 9.73496040E-01 3.05936468E-01 2.202702750E+00 8.84394862E-02 + 9.73599318E-01 3.05995562E-01 2.205978360E+00 8.84921506E-02 + 9.73702596E-01 3.06054681E-01 2.209260360E+00 8.85449038E-02 + 9.73805874E-01 3.06113825E-01 2.212548770E+00 8.85977459E-02 + 9.73909151E-01 3.06172995E-01 2.215843610E+00 8.86506772E-02 + 9.74012429E-01 3.06232191E-01 2.219144900E+00 8.87036978E-02 + 9.74115707E-01 3.06291411E-01 2.222452640E+00 8.87568080E-02 + 9.74218985E-01 3.06350658E-01 2.225766850E+00 8.88100078E-02 + 9.74322262E-01 3.06409929E-01 2.229087560E+00 8.88632975E-02 + 9.74425540E-01 3.06469227E-01 2.232414780E+00 8.89166774E-02 + 9.74528818E-01 3.06528549E-01 2.235748520E+00 8.89701475E-02 + 9.74632096E-01 3.06587898E-01 2.239088800E+00 8.90237080E-02 + 9.74735373E-01 3.06647271E-01 2.242435640E+00 8.90773592E-02 + 9.74838651E-01 3.06706671E-01 2.245789050E+00 8.91311013E-02 + 9.74941929E-01 3.06766096E-01 2.249149050E+00 8.91849343E-02 + 9.75045207E-01 3.06825546E-01 2.252515660E+00 8.92388586E-02 + 9.75148484E-01 3.06885022E-01 2.255888900E+00 8.92928743E-02 + 9.75251762E-01 3.06944524E-01 2.259268770E+00 8.93469815E-02 + 9.75355040E-01 3.07004051E-01 2.262655310E+00 8.94011806E-02 + 9.75458318E-01 3.07063604E-01 2.266048510E+00 8.94554716E-02 + 9.75561595E-01 3.07123183E-01 2.269448410E+00 8.95098548E-02 + 9.75664873E-01 3.07182787E-01 2.272855020E+00 8.95643304E-02 + 9.75768151E-01 3.07242417E-01 2.276268360E+00 8.96188985E-02 + 9.75871429E-01 3.07302072E-01 2.279688430E+00 8.96735594E-02 + 9.75974706E-01 3.07361753E-01 2.283115270E+00 8.97283132E-02 + 9.76077984E-01 3.07421460E-01 2.286548880E+00 8.97831602E-02 + 9.76181262E-01 3.07481192E-01 2.289989290E+00 8.98381005E-02 + 9.76284540E-01 3.07540950E-01 2.293436510E+00 8.98931343E-02 + 9.76387817E-01 3.07600734E-01 2.296890560E+00 8.99482619E-02 + 9.76491095E-01 3.07660544E-01 2.300351460E+00 9.00034834E-02 + 9.76594373E-01 3.07720379E-01 2.303819220E+00 9.00587990E-02 + 9.76697651E-01 3.07780240E-01 2.307293860E+00 9.01142089E-02 + 9.76800928E-01 3.07840127E-01 2.310775400E+00 9.01697133E-02 + 9.76904206E-01 3.07900039E-01 2.314263850E+00 9.02253125E-02 + 9.77007484E-01 3.07959977E-01 2.317759250E+00 9.02810066E-02 + 9.77110762E-01 3.08019941E-01 2.321261590E+00 9.03367958E-02 + 9.77214039E-01 3.08079931E-01 2.324770900E+00 9.03926803E-02 + 9.77317317E-01 3.08139947E-01 2.328287200E+00 9.04486603E-02 + 9.77420595E-01 3.08199988E-01 2.331810510E+00 9.05047360E-02 + 9.77523873E-01 3.08260055E-01 2.335340840E+00 9.05609077E-02 + 9.77627150E-01 3.08320148E-01 2.338878220E+00 9.06171755E-02 + 9.77730428E-01 3.08380267E-01 2.342422650E+00 9.06735396E-02 + 9.77833706E-01 3.08440412E-01 2.345974160E+00 9.07300002E-02 + 9.77936984E-01 3.08500582E-01 2.349532770E+00 9.07865576E-02 + 9.78040261E-01 3.08560779E-01 2.353098490E+00 9.08432119E-02 + 9.78143539E-01 3.08621001E-01 2.356671340E+00 9.08999633E-02 + 9.78246817E-01 3.08681249E-01 2.360251350E+00 9.09568122E-02 + 9.78350095E-01 3.08741523E-01 2.363838520E+00 9.10137585E-02 + 9.78453372E-01 3.08801823E-01 2.367432890E+00 9.10708026E-02 + 9.78556650E-01 3.08862149E-01 2.371034450E+00 9.11279447E-02 + 9.78659928E-01 3.08922501E-01 2.374643250E+00 9.11851850E-02 + 9.78763206E-01 3.08982878E-01 2.378259290E+00 9.12425236E-02 + 9.78866483E-01 3.09043282E-01 2.381882590E+00 9.12999609E-02 + 9.78969761E-01 3.09103712E-01 2.385513170E+00 9.13574969E-02 + 9.79073039E-01 3.09164167E-01 2.389151050E+00 9.14151320E-02 + 9.79176317E-01 3.09224649E-01 2.392796260E+00 9.14728663E-02 + 9.79279594E-01 3.09285156E-01 2.396448790E+00 9.15307000E-02 + 9.79382872E-01 3.09345690E-01 2.400108690E+00 9.15886334E-02 + 9.79486150E-01 3.09406249E-01 2.403775960E+00 9.16466666E-02 + 9.79589428E-01 3.09466835E-01 2.407450630E+00 9.17047999E-02 + 9.79692705E-01 3.09527446E-01 2.411132710E+00 9.17630335E-02 + 9.79795983E-01 3.09588084E-01 2.414822230E+00 9.18213675E-02 + 9.79899261E-01 3.09648747E-01 2.418519200E+00 9.18798023E-02 + 9.80002539E-01 3.09709437E-01 2.422223640E+00 9.19383381E-02 + 9.80105816E-01 3.09770153E-01 2.425935570E+00 9.19969749E-02 + 9.80209094E-01 3.09830894E-01 2.429655010E+00 9.20557131E-02 + 9.80312372E-01 3.09891662E-01 2.433381990E+00 9.21145529E-02 + 9.80415650E-01 3.09952456E-01 2.437116510E+00 9.21734945E-02 + 9.80518927E-01 3.10013276E-01 2.440858610E+00 9.22325381E-02 + 9.80622205E-01 3.10074122E-01 2.444608290E+00 9.22916840E-02 + 9.80725483E-01 3.10134994E-01 2.448365590E+00 9.23509323E-02 + 9.80828760E-01 3.10195893E-01 2.452130510E+00 9.24102832E-02 + 9.80932038E-01 3.10256817E-01 2.455903080E+00 9.24697370E-02 + 9.81035316E-01 3.10317768E-01 2.459683330E+00 9.25292940E-02 + 9.81138594E-01 3.10378745E-01 2.463471260E+00 9.25889543E-02 + 9.81241871E-01 3.10439747E-01 2.467266900E+00 9.26487181E-02 + 9.81345149E-01 3.10500776E-01 2.471070270E+00 9.27085857E-02 + 9.81448427E-01 3.10561832E-01 2.474881390E+00 9.27685573E-02 + 9.81551705E-01 3.10622913E-01 2.478700280E+00 9.28286331E-02 + 9.81654982E-01 3.10684021E-01 2.482526960E+00 9.28888134E-02 + 9.81758260E-01 3.10745155E-01 2.486361450E+00 9.29490983E-02 + 9.81861538E-01 3.10806315E-01 2.490203780E+00 9.30094881E-02 + 9.81964816E-01 3.10867501E-01 2.494053950E+00 9.30699831E-02 + 9.82068093E-01 3.10928713E-01 2.497912000E+00 9.31305833E-02 + 9.82171371E-01 3.10989952E-01 2.501777940E+00 9.31912892E-02 + 9.82274649E-01 3.11051217E-01 2.505651800E+00 9.32521009E-02 + 9.82377927E-01 3.11112508E-01 2.509533590E+00 9.33130186E-02 + 9.82481204E-01 3.11173826E-01 2.513423340E+00 9.33740425E-02 + 9.82584482E-01 3.11235169E-01 2.517321060E+00 9.34351730E-02 + 9.82687760E-01 3.11296540E-01 2.521226780E+00 9.34964101E-02 + 9.82791038E-01 3.11357936E-01 2.525140520E+00 9.35577543E-02 + 9.82894315E-01 3.11419358E-01 2.529062300E+00 9.36192055E-02 + 9.82997593E-01 3.11480807E-01 2.532992140E+00 9.36807643E-02 + 9.83100871E-01 3.11542283E-01 2.536930070E+00 9.37424306E-02 + 9.83204149E-01 3.11603784E-01 2.540876090E+00 9.38042048E-02 + 9.83307426E-01 3.11665312E-01 2.544830250E+00 9.38660872E-02 + 9.83410704E-01 3.11726866E-01 2.548792550E+00 9.39280779E-02 + 9.83513982E-01 3.11788447E-01 2.552763010E+00 9.39901771E-02 + 9.83617260E-01 3.11850054E-01 2.556741670E+00 9.40523852E-02 + 9.83720537E-01 3.11911687E-01 2.560728540E+00 9.41147024E-02 + 9.83823815E-01 3.11973347E-01 2.564723650E+00 9.41771288E-02 + 9.83927093E-01 3.12035033E-01 2.568727010E+00 9.42396648E-02 + 9.84030371E-01 3.12096746E-01 2.572738640E+00 9.43023105E-02 + 9.84133648E-01 3.12158485E-01 2.576758580E+00 9.43650662E-02 + 9.84236926E-01 3.12220250E-01 2.580786830E+00 9.44279322E-02 + 9.84340204E-01 3.12282042E-01 2.584823430E+00 9.44909087E-02 + 9.84443482E-01 3.12343860E-01 2.588868400E+00 9.45539959E-02 + 9.84546759E-01 3.12405705E-01 2.592921750E+00 9.46171940E-02 + 9.84650037E-01 3.12467576E-01 2.596983520E+00 9.46805034E-02 + 9.84753315E-01 3.12529473E-01 2.601053710E+00 9.47439242E-02 + 9.84856593E-01 3.12591397E-01 2.605132360E+00 9.48074567E-02 + 9.84959870E-01 3.12653348E-01 2.609219490E+00 9.48711012E-02 + 9.85063148E-01 3.12715325E-01 2.613315120E+00 9.49348578E-02 + 9.85166426E-01 3.12777328E-01 2.617419270E+00 9.49987269E-02 + 9.85269704E-01 3.12839358E-01 2.621531970E+00 9.50627086E-02 + 9.85372981E-01 3.12901414E-01 2.625653240E+00 9.51268033E-02 + 9.85476259E-01 3.12963497E-01 2.629783100E+00 9.51910111E-02 + 9.85579537E-01 3.13025607E-01 2.633921570E+00 9.52553324E-02 + 9.85682815E-01 3.13087743E-01 2.638068680E+00 9.53197673E-02 + 9.85786092E-01 3.13149905E-01 2.642224450E+00 9.53843161E-02 + 9.85889370E-01 3.13212094E-01 2.646388900E+00 9.54489791E-02 + 9.85992648E-01 3.13274310E-01 2.650562060E+00 9.55137566E-02 + 9.86095926E-01 3.13336552E-01 2.654743960E+00 9.55786486E-02 + 9.86199203E-01 3.13398821E-01 2.658934600E+00 9.56436556E-02 + 9.86302481E-01 3.13461116E-01 2.663134030E+00 9.57087778E-02 + 9.86405759E-01 3.13523438E-01 2.667342250E+00 9.57740154E-02 + 9.86509037E-01 3.13585787E-01 2.671559300E+00 9.58393687E-02 + 9.86612314E-01 3.13648162E-01 2.675785200E+00 9.59048379E-02 + 9.86715592E-01 3.13710564E-01 2.680019970E+00 9.59704233E-02 + 9.86818870E-01 3.13772992E-01 2.684263630E+00 9.60361252E-02 + 9.86922148E-01 3.13835447E-01 2.688516220E+00 9.61019437E-02 + 9.87025425E-01 3.13897929E-01 2.692777750E+00 9.61678792E-02 + 9.87128703E-01 3.13960437E-01 2.697048250E+00 9.62339319E-02 + 9.87231981E-01 3.14022972E-01 2.701327740E+00 9.63001021E-02 + 9.87335259E-01 3.14085533E-01 2.705616250E+00 9.63663901E-02 + 9.87438536E-01 3.14148121E-01 2.709913800E+00 9.64327960E-02 + 9.87541814E-01 3.14210736E-01 2.714220420E+00 9.64993202E-02 + 9.87645092E-01 3.14273378E-01 2.718536120E+00 9.65659629E-02 + 9.87748370E-01 3.14336046E-01 2.722860940E+00 9.66327244E-02 + 9.87851647E-01 3.14398741E-01 2.727194900E+00 9.66996050E-02 + 9.87954925E-01 3.14461463E-01 2.731538030E+00 9.67666048E-02 + 9.88058203E-01 3.14524211E-01 2.735890340E+00 9.68337242E-02 + 9.88161481E-01 3.14586986E-01 2.740251870E+00 9.69009635E-02 + 9.88264758E-01 3.14649788E-01 2.744622630E+00 9.69683229E-02 + 9.88368036E-01 3.14712616E-01 2.749002660E+00 9.70358026E-02 + 9.88471314E-01 3.14775472E-01 2.753391980E+00 9.71034030E-02 + 9.88574591E-01 3.14838353E-01 2.757790620E+00 9.71711243E-02 + 9.88677869E-01 3.14901262E-01 2.762198590E+00 9.72389667E-02 + 9.88781147E-01 3.14964198E-01 2.766615930E+00 9.73069306E-02 + 9.88884425E-01 3.15027160E-01 2.771042660E+00 9.73750163E-02 + 9.88987702E-01 3.15090149E-01 2.775478810E+00 9.74432239E-02 + 9.89090980E-01 3.15153165E-01 2.779924400E+00 9.75115537E-02 + 9.89194258E-01 3.15216207E-01 2.784379460E+00 9.75800061E-02 + 9.89297536E-01 3.15279277E-01 2.788844010E+00 9.76485813E-02 + 9.89400813E-01 3.15342373E-01 2.793318080E+00 9.77172796E-02 + 9.89504091E-01 3.15405496E-01 2.797801700E+00 9.77861013E-02 + 9.89607369E-01 3.15468646E-01 2.802294890E+00 9.78550465E-02 + 9.89710647E-01 3.15531823E-01 2.806797670E+00 9.79241157E-02 + 9.89813924E-01 3.15595026E-01 2.811310080E+00 9.79933091E-02 + 9.89917202E-01 3.15658256E-01 2.815832140E+00 9.80626269E-02 + 9.90020480E-01 3.15721514E-01 2.820363880E+00 9.81320694E-02 + 9.90123758E-01 3.15784798E-01 2.824905320E+00 9.82016370E-02 + 9.90227035E-01 3.15848109E-01 2.829456500E+00 9.82713299E-02 + 9.90330313E-01 3.15911446E-01 2.834017420E+00 9.83411483E-02 + 9.90433591E-01 3.15974811E-01 2.838588140E+00 9.84110927E-02 + 9.90536869E-01 3.16038202E-01 2.843168660E+00 9.84811631E-02 + 9.90640146E-01 3.16101621E-01 2.847759020E+00 9.85513600E-02 + 9.90743424E-01 3.16165066E-01 2.852359250E+00 9.86216836E-02 + 9.90846702E-01 3.16228538E-01 2.856969360E+00 9.86921342E-02 + 9.90949980E-01 3.16292037E-01 2.861589400E+00 9.87627121E-02 + 9.91053257E-01 3.16355563E-01 2.866219380E+00 9.88334176E-02 + 9.91156535E-01 3.16419116E-01 2.870859340E+00 9.89042509E-02 + 9.91259813E-01 3.16482696E-01 2.875509300E+00 9.89752123E-02 + 9.91363091E-01 3.16546303E-01 2.880169280E+00 9.90463022E-02 + 9.91466368E-01 3.16609937E-01 2.884839330E+00 9.91175208E-02 + 9.91569646E-01 3.16673597E-01 2.889519460E+00 9.91888684E-02 + 9.91672924E-01 3.16737285E-01 2.894209700E+00 9.92603454E-02 + 9.91776202E-01 3.16801000E-01 2.898910080E+00 9.93319519E-02 + 9.91879479E-01 3.16864741E-01 2.903620620E+00 9.94036883E-02 + 9.91982757E-01 3.16928510E-01 2.908341370E+00 9.94755549E-02 + 9.92086035E-01 3.16992305E-01 2.913072340E+00 9.95475519E-02 + 9.92189313E-01 3.17056128E-01 2.917813560E+00 9.96196798E-02 + 9.92292590E-01 3.17119977E-01 2.922565070E+00 9.96919387E-02 + 9.92395868E-01 3.17183854E-01 2.927326880E+00 9.97643290E-02 + 9.92499146E-01 3.17247757E-01 2.932099040E+00 9.98368509E-02 + 9.92602424E-01 3.17311688E-01 2.936881560E+00 9.99095048E-02 + 9.92705701E-01 3.17375645E-01 2.941674480E+00 9.99822910E-02 + 9.92808979E-01 3.17439630E-01 2.946477820E+00 1.00055210E-01 + 9.92912257E-01 3.17503641E-01 2.951291620E+00 1.00128261E-01 + 9.93015535E-01 3.17567680E-01 2.956115900E+00 1.00201446E-01 + 9.93118812E-01 3.17631746E-01 2.960950690E+00 1.00274764E-01 + 9.93222090E-01 3.17695838E-01 2.965796020E+00 1.00348216E-01 + 9.93325368E-01 3.17759958E-01 2.970651930E+00 1.00421802E-01 + 9.93428646E-01 3.17824105E-01 2.975518440E+00 1.00495523E-01 + 9.93531923E-01 3.17888279E-01 2.980395570E+00 1.00569378E-01 + 9.93635201E-01 3.17952480E-01 2.985283370E+00 1.00643368E-01 + 9.93738479E-01 3.18016708E-01 2.990181860E+00 1.00717493E-01 + 9.93841757E-01 3.18080963E-01 2.995091070E+00 1.00791754E-01 + 9.93945034E-01 3.18145245E-01 3.000011020E+00 1.00866151E-01 + 9.94048312E-01 3.18209554E-01 3.004941760E+00 1.00940685E-01 + 9.94151590E-01 3.18273891E-01 3.009883310E+00 1.01015354E-01 + 9.94254868E-01 3.18338254E-01 3.014835700E+00 1.01090161E-01 + 9.94358145E-01 3.18402645E-01 3.019798960E+00 1.01165105E-01 + 9.94461423E-01 3.18467063E-01 3.024773120E+00 1.01240186E-01 + 9.94564701E-01 3.18531507E-01 3.029758210E+00 1.01315405E-01 + 9.94667979E-01 3.18595979E-01 3.034754260E+00 1.01390762E-01 + 9.94771256E-01 3.18660479E-01 3.039761310E+00 1.01466258E-01 + 9.94874534E-01 3.18725005E-01 3.044779390E+00 1.01541892E-01 + 9.94977812E-01 3.18789558E-01 3.049808520E+00 1.01617665E-01 + 9.95081090E-01 3.18854139E-01 3.054848730E+00 1.01693578E-01 + 9.95184367E-01 3.18918746E-01 3.059900070E+00 1.01769631E-01 + 9.95287645E-01 3.18983381E-01 3.064962550E+00 1.01845823E-01 + 9.95390923E-01 3.19048043E-01 3.070036220E+00 1.01922156E-01 + 9.95494201E-01 3.19112733E-01 3.075121090E+00 1.01998630E-01 + 9.95597478E-01 3.19177449E-01 3.080217210E+00 1.02075244E-01 + 9.95700756E-01 3.19242193E-01 3.085324610E+00 1.02152000E-01 + 9.95804034E-01 3.19306963E-01 3.090443320E+00 1.02228897E-01 + 9.95907312E-01 3.19371761E-01 3.095573360E+00 1.02305937E-01 + 9.96010589E-01 3.19436586E-01 3.100714780E+00 1.02383119E-01 + 9.96113867E-01 3.19501439E-01 3.105867600E+00 1.02460443E-01 + 9.96217145E-01 3.19566318E-01 3.111031850E+00 1.02537910E-01 + 9.96320422E-01 3.19631225E-01 3.116207580E+00 1.02615521E-01 + 9.96423700E-01 3.19696159E-01 3.121394810E+00 1.02693275E-01 + 9.96526978E-01 3.19761120E-01 3.126593570E+00 1.02771173E-01 + 9.96630256E-01 3.19826109E-01 3.131803900E+00 1.02849216E-01 + 9.96733533E-01 3.19891125E-01 3.137025830E+00 1.02927403E-01 + 9.96836811E-01 3.19956168E-01 3.142259390E+00 1.03005735E-01 + 9.96940089E-01 3.20021238E-01 3.147504610E+00 1.03084212E-01 + 9.97043367E-01 3.20086335E-01 3.152761540E+00 1.03162835E-01 + 9.97146644E-01 3.20151460E-01 3.158030200E+00 1.03241604E-01 + 9.97249922E-01 3.20216612E-01 3.163310620E+00 1.03320519E-01 + 9.97353200E-01 3.20281791E-01 3.168602840E+00 1.03399581E-01 + 9.97456478E-01 3.20346998E-01 3.173906900E+00 1.03478790E-01 + 9.97559755E-01 3.20412231E-01 3.179222820E+00 1.03558146E-01 + 9.97663033E-01 3.20477492E-01 3.184550650E+00 1.03637650E-01 + 9.97766311E-01 3.20542781E-01 3.189890410E+00 1.03717302E-01 + 9.97869589E-01 3.20608096E-01 3.195242140E+00 1.03797102E-01 + 9.97972866E-01 3.20673439E-01 3.200605870E+00 1.03877051E-01 + 9.98076144E-01 3.20738810E-01 3.205981640E+00 1.03957149E-01 + 9.98179422E-01 3.20804207E-01 3.211369480E+00 1.04037396E-01 + 9.98282700E-01 3.20869632E-01 3.216769430E+00 1.04117794E-01 + 9.98385977E-01 3.20935084E-01 3.222181520E+00 1.04198341E-01 + 9.98489255E-01 3.21000563E-01 3.227605780E+00 1.04279038E-01 + 9.98592533E-01 3.21066070E-01 3.233042260E+00 1.04359887E-01 + 9.98695811E-01 3.21131604E-01 3.238490990E+00 1.04440886E-01 + 9.98799088E-01 3.21197166E-01 3.243951990E+00 1.04522038E-01 + 9.98902366E-01 3.21262755E-01 3.249425320E+00 1.04603341E-01 + 9.99005644E-01 3.21328371E-01 3.254910990E+00 1.04684796E-01 + 9.99108922E-01 3.21394014E-01 3.260409050E+00 1.04766403E-01 + 9.99212199E-01 3.21459685E-01 3.265919540E+00 1.04848164E-01 + 9.99315477E-01 3.21525383E-01 3.271442490E+00 1.04930078E-01 + 9.99418755E-01 3.21591108E-01 3.276977930E+00 1.05012146E-01 + 9.99522033E-01 3.21656861E-01 3.282525910E+00 1.05094367E-01 + 9.99625310E-01 3.21722642E-01 3.288086450E+00 1.05176743E-01 + 9.99728588E-01 3.21788449E-01 3.293659590E+00 1.05259274E-01 + 9.99831866E-01 3.21854284E-01 3.299245380E+00 1.05341960E-01 + 9.99935144E-01 3.21920146E-01 3.304843850E+00 1.05424801E-01 + 1.00003842E+00 3.21986036E-01 3.310455020E+00 1.05507799E-01 + 1.00014170E+00 3.22051953E-01 3.316078950E+00 1.05590952E-01 + 1.00024498E+00 3.22117898E-01 3.321715670E+00 1.05674262E-01 + 1.00034825E+00 3.22183870E-01 3.327365210E+00 1.05757729E-01 + 1.00045153E+00 3.22249869E-01 3.333027620E+00 1.05841353E-01 + 1.00055481E+00 3.22315896E-01 3.338702920E+00 1.05925135E-01 + 1.00065809E+00 3.22381950E-01 3.344391160E+00 1.06009075E-01 + 1.00076137E+00 3.22448031E-01 3.350092380E+00 1.06093173E-01 + 1.00086464E+00 3.22514140E-01 3.355806600E+00 1.06177430E-01 + 1.00096792E+00 3.22580276E-01 3.361533880E+00 1.06261846E-01 + 1.00107120E+00 3.22646440E-01 3.367274250E+00 1.06346422E-01 + 1.00117448E+00 3.22712631E-01 3.373027740E+00 1.06431158E-01 + 1.00127775E+00 3.22778850E-01 3.378794400E+00 1.06516054E-01 + 1.00138103E+00 3.22845096E-01 3.384574260E+00 1.06601111E-01 + 1.00148431E+00 3.22911369E-01 3.390367360E+00 1.06686329E-01 + 1.00158759E+00 3.22977670E-01 3.396173740E+00 1.06771708E-01 + 1.00169087E+00 3.23043998E-01 3.401993440E+00 1.06857249E-01 + 1.00179414E+00 3.23110354E-01 3.407826500E+00 1.06942952E-01 + 1.00189742E+00 3.23176737E-01 3.413672960E+00 1.07028818E-01 + 1.00200070E+00 3.23243148E-01 3.419532850E+00 1.07114847E-01 + 1.00210398E+00 3.23309586E-01 3.425406220E+00 1.07201040E-01 + 1.00220725E+00 3.23376052E-01 3.431293110E+00 1.07287396E-01 + 1.00231053E+00 3.23442545E-01 3.437193550E+00 1.07373916E-01 + 1.00241381E+00 3.23509065E-01 3.443107580E+00 1.07460601E-01 + 1.00251709E+00 3.23575613E-01 3.449035250E+00 1.07547451E-01 + 1.00262037E+00 3.23642188E-01 3.454976600E+00 1.07634466E-01 + 1.00272364E+00 3.23708791E-01 3.460931660E+00 1.07721647E-01 + 1.00282692E+00 3.23775422E-01 3.466900470E+00 1.07808994E-01 + 1.00293020E+00 3.23842079E-01 3.472883080E+00 1.07896507E-01 + 1.00303348E+00 3.23908765E-01 3.478879530E+00 1.07984188E-01 + 1.00313675E+00 3.23975478E-01 3.484889850E+00 1.08072036E-01 + 1.00324003E+00 3.24042218E-01 3.490914090E+00 1.08160051E-01 + 1.00334331E+00 3.24108986E-01 3.496952290E+00 1.08248235E-01 + 1.00344659E+00 3.24175781E-01 3.503004500E+00 1.08336587E-01 + 1.00354986E+00 3.24242604E-01 3.509070740E+00 1.08425108E-01 + 1.00365314E+00 3.24309454E-01 3.515151070E+00 1.08513799E-01 + 1.00375642E+00 3.24376332E-01 3.521245520E+00 1.08602659E-01 + 1.00385970E+00 3.24443237E-01 3.527354140E+00 1.08691689E-01 + 1.00396298E+00 3.24510170E-01 3.533476970E+00 1.08780890E-01 + 1.00406625E+00 3.24577130E-01 3.539614050E+00 1.08870262E-01 + 1.00416953E+00 3.24644118E-01 3.545765420E+00 1.08959806E-01 + 1.00427281E+00 3.24711133E-01 3.551931130E+00 1.09049521E-01 + 1.00437609E+00 3.24778176E-01 3.558111210E+00 1.09139408E-01 + 1.00447936E+00 3.24845246E-01 3.564305720E+00 1.09229468E-01 + 1.00458264E+00 3.24912344E-01 3.570514690E+00 1.09319701E-01 + 1.00468592E+00 3.24979469E-01 3.576738170E+00 1.09410108E-01 + 1.00478920E+00 3.25046622E-01 3.582976200E+00 1.09500688E-01 + 1.00489248E+00 3.25113803E-01 3.589228820E+00 1.09591443E-01 + 1.00499575E+00 3.25181011E-01 3.595496070E+00 1.09682373E-01 + 1.00509903E+00 3.25248246E-01 3.601778010E+00 1.09773477E-01 + 1.00520231E+00 3.25315509E-01 3.608074670E+00 1.09864758E-01 + 1.00530559E+00 3.25382800E-01 3.614386100E+00 1.09956214E-01 + 1.00540886E+00 3.25450118E-01 3.620712340E+00 1.10047846E-01 + 1.00551214E+00 3.25517464E-01 3.627053440E+00 1.10139656E-01 + 1.00561542E+00 3.25584837E-01 3.633409440E+00 1.10231643E-01 + 1.00571870E+00 3.25652238E-01 3.639780380E+00 1.10323807E-01 + 1.00582198E+00 3.25719666E-01 3.646166320E+00 1.10416150E-01 + 1.00592525E+00 3.25787122E-01 3.652567290E+00 1.10508671E-01 + 1.00602853E+00 3.25854605E-01 3.658983340E+00 1.10601371E-01 + 1.00613181E+00 3.25922116E-01 3.665414510E+00 1.10694251E-01 + 1.00623509E+00 3.25989655E-01 3.671860860E+00 1.10787311E-01 + 1.00633836E+00 3.26057221E-01 3.678322420E+00 1.10880551E-01 + 1.00644164E+00 3.26124814E-01 3.684799240E+00 1.10973972E-01 + 1.00654492E+00 3.26192435E-01 3.691291370E+00 1.11067573E-01 + 1.00664820E+00 3.26260084E-01 3.697798860E+00 1.11161357E-01 + 1.00675147E+00 3.26327760E-01 3.704321750E+00 1.11255323E-01 + 1.00685475E+00 3.26395464E-01 3.710860080E+00 1.11349471E-01 + 1.00695803E+00 3.26463196E-01 3.717413900E+00 1.11443802E-01 + 1.00706131E+00 3.26530955E-01 3.723983270E+00 1.11538317E-01 + 1.00716459E+00 3.26598741E-01 3.730568220E+00 1.11633015E-01 + 1.00726786E+00 3.26666556E-01 3.737168800E+00 1.11727898E-01 + 1.00737114E+00 3.26734397E-01 3.743785070E+00 1.11822966E-01 + 1.00747442E+00 3.26802267E-01 3.750417060E+00 1.11918219E-01 + 1.00757770E+00 3.26870164E-01 3.757064830E+00 1.12013657E-01 + 1.00768097E+00 3.26938088E-01 3.763728430E+00 1.12109282E-01 + 1.00778425E+00 3.27006040E-01 3.770407890E+00 1.12205094E-01 + 1.00788753E+00 3.27074020E-01 3.777103280E+00 1.12301092E-01 + 1.00799081E+00 3.27142027E-01 3.783814630E+00 1.12397278E-01 + 1.00809409E+00 3.27210062E-01 3.790542000E+00 1.12493652E-01 + 1.00819736E+00 3.27278124E-01 3.797285430E+00 1.12590214E-01 + 1.00830064E+00 3.27346214E-01 3.804044980E+00 1.12686966E-01 + 1.00840392E+00 3.27414332E-01 3.810820690E+00 1.12783906E-01 + 1.00850720E+00 3.27482477E-01 3.817612610E+00 1.12881037E-01 + 1.00861047E+00 3.27550650E-01 3.824420800E+00 1.12978358E-01 + 1.00871375E+00 3.27618850E-01 3.831245290E+00 1.13075869E-01 + 1.00881703E+00 3.27687078E-01 3.838086150E+00 1.13173572E-01 + 1.00892031E+00 3.27755333E-01 3.844943410E+00 1.13271467E-01 + 1.00902359E+00 3.27823617E-01 3.851817130E+00 1.13369554E-01 + 1.00912686E+00 3.27891927E-01 3.858707370E+00 1.13467833E-01 + 1.00923014E+00 3.27960266E-01 3.865614160E+00 1.13566306E-01 + 1.00933342E+00 3.28028632E-01 3.872537570E+00 1.13664972E-01 + 1.00943670E+00 3.28097025E-01 3.879477640E+00 1.13763832E-01 + 1.00953997E+00 3.28165446E-01 3.886434420E+00 1.13862887E-01 + 1.00964325E+00 3.28233895E-01 3.893407970E+00 1.13962138E-01 + 1.00974653E+00 3.28302371E-01 3.900398330E+00 1.14061583E-01 + 1.00984981E+00 3.28370875E-01 3.907405560E+00 1.14161225E-01 + 1.00995309E+00 3.28439407E-01 3.914429710E+00 1.14261063E-01 + 1.01005636E+00 3.28507966E-01 3.921470830E+00 1.14361098E-01 + 1.01015964E+00 3.28576552E-01 3.928528980E+00 1.14461331E-01 + 1.01026292E+00 3.28645167E-01 3.935604200E+00 1.14561762E-01 + 1.01036620E+00 3.28713809E-01 3.942696540E+00 1.14662391E-01 + 1.01046947E+00 3.28782478E-01 3.949806070E+00 1.14763220E-01 + 1.01057275E+00 3.28851175E-01 3.956932830E+00 1.14864247E-01 + 1.01067603E+00 3.28919900E-01 3.964076880E+00 1.14965475E-01 + 1.01077931E+00 3.28988652E-01 3.971238260E+00 1.15066903E-01 + 1.01088258E+00 3.29057432E-01 3.978417040E+00 1.15168533E-01 + 1.01098586E+00 3.29126240E-01 3.985613270E+00 1.15270363E-01 + 1.01108914E+00 3.29195075E-01 3.992827000E+00 1.15372396E-01 + 1.01119242E+00 3.29263938E-01 4.000058280E+00 1.15474631E-01 + 1.01129570E+00 3.29332828E-01 4.007307170E+00 1.15577070E-01 + 1.01139897E+00 3.29401746E-01 4.014573720E+00 1.15679711E-01 + 1.01150225E+00 3.29470692E-01 4.021858000E+00 1.15782557E-01 + 1.01160553E+00 3.29539665E-01 4.029160040E+00 1.15885608E-01 + 1.01170881E+00 3.29608666E-01 4.036479920E+00 1.15988863E-01 + 1.01181208E+00 3.29677694E-01 4.043817670E+00 1.16092324E-01 + 1.01191536E+00 3.29746750E-01 4.051173370E+00 1.16195991E-01 + 1.01201864E+00 3.29815834E-01 4.058547060E+00 1.16299865E-01 + 1.01212192E+00 3.29884945E-01 4.065938800E+00 1.16403946E-01 + 1.01222520E+00 3.29954084E-01 4.073348650E+00 1.16508234E-01 + 1.01232847E+00 3.30023250E-01 4.080776660E+00 1.16612731E-01 + 1.01243175E+00 3.30092444E-01 4.088222890E+00 1.16717436E-01 + 1.01253503E+00 3.30161666E-01 4.095687400E+00 1.16822351E-01 + 1.01263831E+00 3.30230915E-01 4.103170240E+00 1.16927475E-01 + 1.01274158E+00 3.30300192E-01 4.110671470E+00 1.17032810E-01 + 1.01284486E+00 3.30369496E-01 4.118191140E+00 1.17138355E-01 + 1.01294814E+00 3.30438828E-01 4.125729330E+00 1.17244112E-01 + 1.01305142E+00 3.30508188E-01 4.133286070E+00 1.17350080E-01 + 1.01315470E+00 3.30577575E-01 4.140861440E+00 1.17456261E-01 + 1.01325797E+00 3.30646990E-01 4.148455490E+00 1.17562655E-01 + 1.01336125E+00 3.30716433E-01 4.156068270E+00 1.17669263E-01 + 1.01346453E+00 3.30785903E-01 4.163699850E+00 1.17776085E-01 + 1.01356781E+00 3.30855400E-01 4.171350290E+00 1.17883121E-01 + 1.01367108E+00 3.30924926E-01 4.179019640E+00 1.17990372E-01 + 1.01377436E+00 3.30994478E-01 4.186707960E+00 1.18097839E-01 + 1.01387764E+00 3.31064059E-01 4.194415320E+00 1.18205522E-01 + 1.01398092E+00 3.31133667E-01 4.202141770E+00 1.18313422E-01 + 1.01408419E+00 3.31203303E-01 4.209887370E+00 1.18421539E-01 + 1.01418747E+00 3.31272966E-01 4.217652190E+00 1.18529874E-01 + 1.01429075E+00 3.31342657E-01 4.225436280E+00 1.18638428E-01 + 1.01439403E+00 3.31412375E-01 4.233239710E+00 1.18747200E-01 + 1.01449731E+00 3.31482121E-01 4.241062530E+00 1.18856192E-01 + 1.01460058E+00 3.31551895E-01 4.248904810E+00 1.18965404E-01 + 1.01470386E+00 3.31621696E-01 4.256766600E+00 1.19074837E-01 + 1.01480714E+00 3.31691525E-01 4.264647980E+00 1.19184491E-01 + 1.01491042E+00 3.31761381E-01 4.272549000E+00 1.19294367E-01 + 1.01501369E+00 3.31831265E-01 4.280469720E+00 1.19404465E-01 + 1.01511697E+00 3.31901176E-01 4.288410200E+00 1.19514787E-01 + 1.01522025E+00 3.31971116E-01 4.296370520E+00 1.19625331E-01 + 1.01532353E+00 3.32041082E-01 4.304350720E+00 1.19736100E-01 + 1.01542681E+00 3.32111076E-01 4.312350890E+00 1.19847093E-01 + 1.01553008E+00 3.32181098E-01 4.320371060E+00 1.19958312E-01 + 1.01563336E+00 3.32251148E-01 4.328411320E+00 1.20069756E-01 + 1.01573664E+00 3.32321225E-01 4.336471730E+00 1.20181427E-01 + 1.01583992E+00 3.32391329E-01 4.344552340E+00 1.20293325E-01 + 1.01594319E+00 3.32461461E-01 4.352653230E+00 1.20405450E-01 + 1.01604647E+00 3.32531621E-01 4.360774450E+00 1.20517804E-01 + 1.01614975E+00 3.32601808E-01 4.368916080E+00 1.20630386E-01 + 1.01625303E+00 3.32672023E-01 4.377078170E+00 1.20743198E-01 + 1.01635631E+00 3.32742266E-01 4.385260800E+00 1.20856239E-01 + 1.01645958E+00 3.32812536E-01 4.393464020E+00 1.20969511E-01 + 1.01656286E+00 3.32882833E-01 4.401687910E+00 1.21083014E-01 + 1.01666614E+00 3.32953158E-01 4.409932530E+00 1.21196749E-01 + 1.01676942E+00 3.33023511E-01 4.418197940E+00 1.21310716E-01 + 1.01687269E+00 3.33093891E-01 4.426484220E+00 1.21424916E-01 + 1.01697597E+00 3.33164299E-01 4.434791420E+00 1.21539349E-01 + 1.01707925E+00 3.33234734E-01 4.443119620E+00 1.21654017E-01 + 1.01718253E+00 3.33305197E-01 4.451468890E+00 1.21768919E-01 + 1.01728581E+00 3.33375687E-01 4.459839280E+00 1.21884057E-01 + 1.01738908E+00 3.33446205E-01 4.468230870E+00 1.21999430E-01 + 1.01749236E+00 3.33516751E-01 4.476643740E+00 1.22115040E-01 + 1.01759564E+00 3.33587324E-01 4.485077930E+00 1.22230887E-01 + 1.01769892E+00 3.33657925E-01 4.493533530E+00 1.22346972E-01 + 1.01780219E+00 3.33728553E-01 4.502010600E+00 1.22463296E-01 + 1.01790547E+00 3.33799208E-01 4.510509210E+00 1.22579858E-01 + 1.01800875E+00 3.33869892E-01 4.519029440E+00 1.22696660E-01 + 1.01811203E+00 3.33940602E-01 4.527571340E+00 1.22813702E-01 + 1.01821530E+00 3.34011340E-01 4.536135000E+00 1.22930985E-01 + 1.01831858E+00 3.34082106E-01 4.544720470E+00 1.23048510E-01 + 1.01842186E+00 3.34152900E-01 4.553327840E+00 1.23166277E-01 + 1.01852514E+00 3.34223720E-01 4.561957160E+00 1.23284286E-01 + 1.01862842E+00 3.34294569E-01 4.570608520E+00 1.23402539E-01 + 1.01873169E+00 3.34365445E-01 4.579281990E+00 1.23521036E-01 + 1.01883497E+00 3.34436348E-01 4.587977630E+00 1.23639778E-01 + 1.01893825E+00 3.34507279E-01 4.596695510E+00 1.23758765E-01 + 1.01904153E+00 3.34578237E-01 4.605435720E+00 1.23877998E-01 + 1.01914480E+00 3.34649223E-01 4.614198320E+00 1.23997478E-01 + 1.01924808E+00 3.34720236E-01 4.622983380E+00 1.24117205E-01 + 1.01935136E+00 3.34791277E-01 4.631790970E+00 1.24237180E-01 + 1.01945464E+00 3.34862346E-01 4.640621180E+00 1.24357403E-01 + 1.01955792E+00 3.34933441E-01 4.649474080E+00 1.24477876E-01 + 1.01966119E+00 3.35004565E-01 4.658349730E+00 1.24598598E-01 + 1.01976447E+00 3.35075716E-01 4.667248210E+00 1.24719571E-01 + 1.01986775E+00 3.35146894E-01 4.676169590E+00 1.24840795E-01 + 1.01997103E+00 3.35218100E-01 4.685113960E+00 1.24962271E-01 + 1.02007430E+00 3.35289333E-01 4.694081390E+00 1.25084000E-01 + 1.02017758E+00 3.35360594E-01 4.703071940E+00 1.25205981E-01 + 1.02028086E+00 3.35431882E-01 4.712085700E+00 1.25328217E-01 + 1.02038414E+00 3.35503198E-01 4.721122740E+00 1.25450707E-01 + 1.02048742E+00 3.35574541E-01 4.730183150E+00 1.25573452E-01 + 1.02059069E+00 3.35645911E-01 4.739266980E+00 1.25696454E-01 + 1.02069397E+00 3.35717309E-01 4.748374330E+00 1.25819711E-01 + 1.02079725E+00 3.35788735E-01 4.757505270E+00 1.25943226E-01 + 1.02090053E+00 3.35860188E-01 4.766659870E+00 1.26066999E-01 + 1.02100380E+00 3.35931668E-01 4.775838210E+00 1.26191030E-01 + 1.02110708E+00 3.36003176E-01 4.785040380E+00 1.26315321E-01 + 1.02121036E+00 3.36074711E-01 4.794266440E+00 1.26439872E-01 + 1.02131364E+00 3.36146274E-01 4.803516490E+00 1.26564683E-01 + 1.02141691E+00 3.36217864E-01 4.812790590E+00 1.26689756E-01 + 1.02152019E+00 3.36289482E-01 4.822088820E+00 1.26815091E-01 + 1.02162347E+00 3.36361127E-01 4.831411280E+00 1.26940688E-01 + 1.02172675E+00 3.36432799E-01 4.840758020E+00 1.27066549E-01 + 1.02183003E+00 3.36504499E-01 4.850129150E+00 1.27192674E-01 + 1.02193330E+00 3.36576226E-01 4.859524730E+00 1.27319064E-01 + 1.02203658E+00 3.36647981E-01 4.868944840E+00 1.27445719E-01 + 1.02213986E+00 3.36719763E-01 4.878389570E+00 1.27572641E-01 + 1.02224314E+00 3.36791572E-01 4.887859010E+00 1.27699830E-01 + 1.02234641E+00 3.36863409E-01 4.897353220E+00 1.27827286E-01 + 1.02244969E+00 3.36935274E-01 4.906872290E+00 1.27955011E-01 + 1.02255297E+00 3.37007165E-01 4.916416310E+00 1.28083005E-01 + 1.02265625E+00 3.37079084E-01 4.925985360E+00 1.28211268E-01 + 1.02275953E+00 3.37151031E-01 4.935579520E+00 1.28339803E-01 + 1.02286280E+00 3.37223004E-01 4.945198870E+00 1.28468608E-01 + 1.02296608E+00 3.37295006E-01 4.954843500E+00 1.28597686E-01 + 1.02306936E+00 3.37367034E-01 4.964513490E+00 1.28727036E-01 + 1.02317264E+00 3.37439090E-01 4.974208930E+00 1.28856660E-01 + 1.02327591E+00 3.37511173E-01 4.983929900E+00 1.28986558E-01 + 1.02337919E+00 3.37583284E-01 4.993676480E+00 1.29116731E-01 + 1.02348247E+00 3.37655422E-01 5.003448770E+00 1.29247180E-01 + 1.02358575E+00 3.37727587E-01 5.013246840E+00 1.29377905E-01 + 1.02368903E+00 3.37799780E-01 5.023070790E+00 1.29508907E-01 + 1.02379230E+00 3.37872000E-01 5.032920690E+00 1.29640187E-01 + 1.02389558E+00 3.37944247E-01 5.042796640E+00 1.29771746E-01 + 1.02399886E+00 3.38016522E-01 5.052698720E+00 1.29903585E-01 + 1.02410214E+00 3.38088823E-01 5.062627020E+00 1.30035703E-01 + 1.02420541E+00 3.38161153E-01 5.072581630E+00 1.30168103E-01 + 1.02430869E+00 3.38233509E-01 5.082562640E+00 1.30300784E-01 + 1.02441197E+00 3.38305893E-01 5.092570130E+00 1.30433748E-01 + 1.02451525E+00 3.38378304E-01 5.102604190E+00 1.30566994E-01 + 1.02461853E+00 3.38450743E-01 5.112664920E+00 1.30700525E-01 + 1.02472180E+00 3.38523209E-01 5.122752400E+00 1.30834341E-01 + 1.02482508E+00 3.38595702E-01 5.132866720E+00 1.30968442E-01 + 1.02492836E+00 3.38668222E-01 5.143007970E+00 1.31102830E-01 + 1.02503164E+00 3.38740770E-01 5.153176250E+00 1.31237504E-01 + 1.02513491E+00 3.38813345E-01 5.163371640E+00 1.31372467E-01 + 1.02523819E+00 3.38885947E-01 5.173594230E+00 1.31507718E-01 + 1.02534147E+00 3.38958576E-01 5.183844130E+00 1.31643259E-01 + 1.02544475E+00 3.39031233E-01 5.194121410E+00 1.31779090E-01 + 1.02554802E+00 3.39103917E-01 5.204426170E+00 1.31915212E-01 + 1.02565130E+00 3.39176628E-01 5.214758500E+00 1.32051625E-01 + 1.02575458E+00 3.39249366E-01 5.225118510E+00 1.32188332E-01 + 1.02585786E+00 3.39322132E-01 5.235506270E+00 1.32325332E-01 + 1.02596114E+00 3.39394925E-01 5.245921890E+00 1.32462626E-01 + 1.02606441E+00 3.39467745E-01 5.256365460E+00 1.32600215E-01 + 1.02616769E+00 3.39540592E-01 5.266837080E+00 1.32738100E-01 + 1.02627097E+00 3.39613467E-01 5.277336830E+00 1.32876281E-01 + 1.02637425E+00 3.39686369E-01 5.287864820E+00 1.33014760E-01 + 1.02647752E+00 3.39759298E-01 5.298421130E+00 1.33153537E-01 + 1.02658080E+00 3.39832254E-01 5.309005880E+00 1.33292614E-01 + 1.02668408E+00 3.39905237E-01 5.319619150E+00 1.33431990E-01 + 1.02678736E+00 3.39978248E-01 5.330261030E+00 1.33571667E-01 + 1.02689064E+00 3.40051285E-01 5.340931640E+00 1.33711646E-01 + 1.02699391E+00 3.40124350E-01 5.351631060E+00 1.33851927E-01 + 1.02709719E+00 3.40197442E-01 5.362359400E+00 1.33992511E-01 + 1.02720047E+00 3.40270562E-01 5.373116750E+00 1.34133399E-01 + 1.02730375E+00 3.40343708E-01 5.383903210E+00 1.34274592E-01 + 1.02740702E+00 3.40416882E-01 5.394718880E+00 1.34416091E-01 + 1.02751030E+00 3.40490082E-01 5.405563870E+00 1.34557897E-01 + 1.02761358E+00 3.40563310E-01 5.416438260E+00 1.34700010E-01 + 1.02771686E+00 3.40636565E-01 5.427342170E+00 1.34842431E-01 + 1.02782014E+00 3.40709847E-01 5.438275690E+00 1.34985161E-01 + 1.02792341E+00 3.40783156E-01 5.449238930E+00 1.35128202E-01 + 1.02802669E+00 3.40856492E-01 5.460231980E+00 1.35271553E-01 + 1.02812997E+00 3.40929856E-01 5.471254950E+00 1.35415216E-01 + 1.02823325E+00 3.41003246E-01 5.482307950E+00 1.35559191E-01 + 1.02833652E+00 3.41076664E-01 5.493391060E+00 1.35703480E-01 + 1.02843980E+00 3.41150109E-01 5.504504410E+00 1.35848083E-01 + 1.02854308E+00 3.41223580E-01 5.515648090E+00 1.35993002E-01 + 1.02864636E+00 3.41297079E-01 5.526822210E+00 1.36138236E-01 + 1.02874963E+00 3.41370605E-01 5.538026870E+00 1.36283788E-01 + 1.02885291E+00 3.41444158E-01 5.549262170E+00 1.36429657E-01 + 1.02895619E+00 3.41517738E-01 5.560528230E+00 1.36575845E-01 + 1.02905947E+00 3.41591345E-01 5.571825150E+00 1.36722353E-01 + 1.02916275E+00 3.41664979E-01 5.583153040E+00 1.36869181E-01 + 1.02926602E+00 3.41738641E-01 5.594512000E+00 1.37016330E-01 + 1.02936930E+00 3.41812329E-01 5.605902140E+00 1.37163802E-01 + 1.02947258E+00 3.41886044E-01 5.617323560E+00 1.37311597E-01 + 1.02957586E+00 3.41959786E-01 5.628776390E+00 1.37459716E-01 + 1.02967913E+00 3.42033555E-01 5.640260720E+00 1.37608160E-01 + 1.02978241E+00 3.42107352E-01 5.651776660E+00 1.37756930E-01 + 1.02988569E+00 3.42181175E-01 5.663324340E+00 1.37906027E-01 + 1.02998897E+00 3.42255025E-01 5.674903840E+00 1.38055452E-01 + 1.03009225E+00 3.42328902E-01 5.686515300E+00 1.38205205E-01 + 1.03019552E+00 3.42402807E-01 5.698158810E+00 1.38355288E-01 + 1.03029880E+00 3.42476738E-01 5.709834480E+00 1.38505701E-01 + 1.03040208E+00 3.42550696E-01 5.721542440E+00 1.38656446E-01 + 1.03050536E+00 3.42624681E-01 5.733282800E+00 1.38807523E-01 + 1.03060863E+00 3.42698693E-01 5.745055660E+00 1.38958933E-01 + 1.03071191E+00 3.42772732E-01 5.756861140E+00 1.39110678E-01 + 1.03081519E+00 3.42846798E-01 5.768699350E+00 1.39262758E-01 + 1.03091847E+00 3.42920890E-01 5.780570410E+00 1.39415174E-01 + 1.03102175E+00 3.42995010E-01 5.792474440E+00 1.39567927E-01 + 1.03112502E+00 3.43069157E-01 5.804411540E+00 1.39721018E-01 + 1.03122830E+00 3.43143330E-01 5.816381840E+00 1.39874448E-01 + 1.03133158E+00 3.43217531E-01 5.828385450E+00 1.40028218E-01 + 1.03143486E+00 3.43291758E-01 5.840422490E+00 1.40182329E-01 + 1.03153813E+00 3.43366012E-01 5.852493070E+00 1.40336782E-01 + 1.03164141E+00 3.43440293E-01 5.864597320E+00 1.40491578E-01 + 1.03174469E+00 3.43514601E-01 5.876735350E+00 1.40646717E-01 + 1.03184797E+00 3.43588936E-01 5.888907270E+00 1.40802202E-01 + 1.03195125E+00 3.43663297E-01 5.901113220E+00 1.40958032E-01 + 1.03205452E+00 3.43737686E-01 5.913353310E+00 1.41114209E-01 + 1.03215780E+00 3.43812101E-01 5.925627660E+00 1.41270733E-01 + 1.03226108E+00 3.43886543E-01 5.937936380E+00 1.41427607E-01 + 1.03236436E+00 3.43961012E-01 5.950279610E+00 1.41584830E-01 + 1.03246763E+00 3.44035508E-01 5.962657470E+00 1.41742404E-01 + 1.03257091E+00 3.44110030E-01 5.975070070E+00 1.41900329E-01 + 1.03267419E+00 3.44184580E-01 5.987517540E+00 1.42058607E-01 + 1.03277747E+00 3.44259156E-01 6.000000000E+00 1.42217240E-01 diff --git a/sedov_io_2048p_32b_3d_weak.par b/sedov_io_2048p_32b_3d_weak.par new file mode 100644 index 0000000..ff92aac --- /dev/null +++ b/sedov_io_2048p_32b_3d_weak.par @@ -0,0 +1,129 @@ +# Runtime parameters for the Sedov explosion problem. +# +# ---------------------------------------------------------------------- +# This parameter file is designed to be used for weak scaling I/O +# benchmarks and not science. It is based upon test_paramesh_3d.par. +# It will cause FLASH to run 4 time steps and output +# a checkpoint file and plot file each and every time step. +# +# Setup lines: +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_pnet +# --with-unit=IO/IOMain/pnetcdf/PM_argonne +# -parfile=sedov_io_2048p_32b_3d_weak.par +# +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_hdf5 +# --with-unit=IO/IOMain/hdf5/parallel/PM_argonne +# -parfile=sedov_io_2048p_32b_3d_weak.par +# +# +# Tunable I/O parameters: +# +# Parameter name Library Valid values +# fileFormatVersion HDF5 & Pnetcdf 9, 10 +# useCollectiveHDF5 HDF5 .true., .false. +# packMeshPlotWriteHDF5 HDF5 .true., .false. +# packMeshChkWriteHDF5 HDF5 .true., .false. +# packMeshChkReadHDF5 HDF5 .true., .false. +# asyncMeshPlotWritePnet Pnetcdf .true., .false. +# asyncMeshChkWritePnet Pnetcdf .true., .false. +# asyncMeshChkReadPnet Pnetcdf .true., .false. +# +# fileFormat version 9 indicates standard FLASH I/O format where each +# mesh variable (e.g. dens, pres) is written to a separate dataset in +# the output file. fileFormat version 10 indicates all mesh variables +# are written to the same dataset in the output file. +# +# useCollectiveHDF5 is a switch for independent or collective HDF5. +# +# packMeshPlotWriteHDF5, packMeshChkWriteHDF5, packMeshChkReadHDF5 are +# used to pack mesh data into a new buffer using the mesh MPI datatypes +# with the MPI_Pack and MPI_Unpack functions. It is a useful option +# for plotfiles where a type conversion (double precision in memory to +# single precision in file) prevents HDF5 collective I/O optimizations. +# I would expect that the only useful parameter is packMeshPlotWriteHDF5, +# the other parameters, packMeshChkWriteHDF5 and packMeshChkReadHDF5 +# are only provided for completeness. +# +# asyncMeshPlotWritePnet, asyncMeshChkWritePnet, asyncMeshChkReadPnet +# are used to replace ncmpi_put_vara_all, ncmpi_get_vara_all library +# calls with ncmpi_iput_vara, ncmpi_iget_vara. I would expect it is +# most useful when used in conjunction with fileFormatVersion = 9 as +# here the N mesh variables (and so N library calls) are transferred +# asynchronously. +# + +fileFormatVersion = 9 + +useCollectiveHDF5 = .true. +packMeshPlotWriteHDF5 = .false. +packMeshChkWriteHDF5 = .false. +packMeshChkReadHDF5 = .false. + +asyncMeshPlotWritePnet = .false. +asyncMeshChkWritePnet = .false. +asyncMeshChkReadPnet = .false. +eachProcWritesSummary = .false. + +# ---------------------------------------------------------------------- + + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_min = 5 +lrefine_max = 5 +nblockx = 2 +nblocky = 2 +nblockz = 4 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" +nend = 4 +tmax = 0.05 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 diff --git a/sedov_io_512p_32b_3d_weak.par b/sedov_io_512p_32b_3d_weak.par new file mode 100644 index 0000000..8106b24 --- /dev/null +++ b/sedov_io_512p_32b_3d_weak.par @@ -0,0 +1,129 @@ +# Runtime parameters for the Sedov explosion problem. +# +# ---------------------------------------------------------------------- +# This parameter file is designed to be used for weak scaling I/O +# benchmarks and not science. It is based upon test_paramesh_3d.par. +# It will cause FLASH to run 4 time steps and output +# a checkpoint file and plot file each and every time step. +# +# Setup lines: +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_pnet +# --with-unit=IO/IOMain/pnetcdf/PM_argonne +# -parfile=sedov_io_512p_32b_3d_weak.par +# +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_hdf5 +# --with-unit=IO/IOMain/hdf5/parallel/PM_argonne +# -parfile=sedov_io_512p_32b_3d_weak.par +# +# +# Tunable I/O parameters: +# +# Parameter name Library Valid values +# fileFormatVersion HDF5 & Pnetcdf 9, 10 +# useCollectiveHDF5 HDF5 .true., .false. +# packMeshPlotWriteHDF5 HDF5 .true., .false. +# packMeshChkWriteHDF5 HDF5 .true., .false. +# packMeshChkReadHDF5 HDF5 .true., .false. +# asyncMeshPlotWritePnet Pnetcdf .true., .false. +# asyncMeshChkWritePnet Pnetcdf .true., .false. +# asyncMeshChkReadPnet Pnetcdf .true., .false. +# +# fileFormat version 9 indicates standard FLASH I/O format where each +# mesh variable (e.g. dens, pres) is written to a separate dataset in +# the output file. fileFormat version 10 indicates all mesh variables +# are written to the same dataset in the output file. +# +# useCollectiveHDF5 is a switch for independent or collective HDF5. +# +# packMeshPlotWriteHDF5, packMeshChkWriteHDF5, packMeshChkReadHDF5 are +# used to pack mesh data into a new buffer using the mesh MPI datatypes +# with the MPI_Pack and MPI_Unpack functions. It is a useful option +# for plotfiles where a type conversion (double precision in memory to +# single precision in file) prevents HDF5 collective I/O optimizations. +# I would expect that the only useful parameter is packMeshPlotWriteHDF5, +# the other parameters, packMeshChkWriteHDF5 and packMeshChkReadHDF5 +# are only provided for completeness. +# +# asyncMeshPlotWritePnet, asyncMeshChkWritePnet, asyncMeshChkReadPnet +# are used to replace ncmpi_put_vara_all, ncmpi_get_vara_all library +# calls with ncmpi_iput_vara, ncmpi_iget_vara. I would expect it is +# most useful when used in conjunction with fileFormatVersion = 9 as +# here the N mesh variables (and so N library calls) are transferred +# asynchronously. +# + +fileFormatVersion = 9 + +useCollectiveHDF5 = .true. +packMeshPlotWriteHDF5 = .false. +packMeshChkWriteHDF5 = .false. +packMeshChkReadHDF5 = .false. + +asyncMeshPlotWritePnet = .false. +asyncMeshChkWritePnet = .false. +asyncMeshChkReadPnet = .false. +eachProcWritesSummary = .false. + +# ---------------------------------------------------------------------- + + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_min = 5 +lrefine_max = 5 +nblockx = 1 +nblocky = 2 +nblockz = 2 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" +nend = 4 +tmax = 0.05 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 diff --git a/sedov_io_69b_2d.par b/sedov_io_69b_2d.par new file mode 100644 index 0000000..2dfb37f --- /dev/null +++ b/sedov_io_69b_2d.par @@ -0,0 +1,127 @@ +# Runtime parameters for the Sedov explosion problem. +# +# ---------------------------------------------------------------------- +# This parameter file is designed to be used for I/O +# benchmarks and not science. It is based upon test_paramesh_2d.par. +# It will cause FLASH to run 4 time steps and output +# a checkpoint file and plot file each and every time step. +# +# Setup lines: +# ./setup Sedov -auto +pm4dev -maxblocks=200 -2d -nxb=16 -nyb=16 +# --with-unit=IO/IOMain/pnetcdf/PM_argonne -parfile=sedov_io_69b_2d.par +# -objdir=flash_pnet +# +# ./setup Sedov -auto +pm4dev -maxblocks=200 -2d -nxb=16 -nyb=16 +# --with-unit=IO/IOMain/hdf5/parallel/PM_argonne -parfile=sedov_io_69b_2d.par +# -objdir=flash_hdf5 +# +# Tunable I/O parameters: +# +# Parameter name Library Valid values +# fileFormatVersion HDF5 & Pnetcdf 9, 10 +# useCollectiveHDF5 HDF5 .true., .false. +# packMeshPlotWriteHDF5 HDF5 .true., .false. +# packMeshChkWriteHDF5 HDF5 .true., .false. +# packMeshChkReadHDF5 HDF5 .true., .false. +# asyncMeshPlotWritePnet Pnetcdf .true., .false. +# asyncMeshChkWritePnet Pnetcdf .true., .false. +# asyncMeshChkReadPnet Pnetcdf .true., .false. +# +# fileFormat version 9 indicates standard FLASH I/O format where each +# mesh variable (e.g. dens, pres) is written to a separate dataset in +# the output file. fileFormat version 10 indicates all mesh variables +# are written to the same dataset in the output file. +# +# useCollectiveHDF5 is a switch for independent or collective HDF5. +# +# packMeshPlotWriteHDF5, packMeshChkWriteHDF5, packMeshChkReadHDF5 are +# used to pack mesh data into a new buffer using the mesh MPI datatypes +# with the MPI_Pack and MPI_Unpack functions. It is a useful option +# for plotfiles where a type conversion (double precision in memory to +# single precision in file) prevents HDF5 collective I/O optimizations. +# I would expect that the only useful parameter is packMeshPlotWriteHDF5, +# the other parameters, packMeshChkWriteHDF5 and packMeshChkReadHDF5 +# are only provided for completeness. +# +# asyncMeshPlotWritePnet, asyncMeshChkWritePnet, asyncMeshChkReadPnet +# are used to replace ncmpi_put_vara_all, ncmpi_get_vara_all library +# calls with ncmpi_iput_vara, ncmpi_iget_vara. I would expect it is +# most useful when used in conjunction with fileFormatVersion = 9 as +# here the N mesh variables (and so N library calls) are transferred +# asynchronously. +# + +fileFormatVersion = 9 + +useCollectiveHDF5 = .true. +packMeshPlotWriteHDF5 = .false. +packMeshChkWriteHDF5 = .false. +packMeshChkReadHDF5 = .false. + +asyncMeshPlotWritePnet = .false. +asyncMeshChkWritePnet = .false. +asyncMeshChkReadPnet = .false. +eachProcWritesSummary = .false. + +# ---------------------------------------------------------------------- + + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_2d_6lev_" +restart = .false. +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" +nend = 4 +tmax = 0.05 + +dtmin = 2.5D-5 +dtmax = 2.5D-5 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_2d_6lev.log" +eintSwitch = 1.e-4 diff --git a/sedov_io_8192p_32b_3d_weak.par b/sedov_io_8192p_32b_3d_weak.par new file mode 100644 index 0000000..272febf --- /dev/null +++ b/sedov_io_8192p_32b_3d_weak.par @@ -0,0 +1,129 @@ +# Runtime parameters for the Sedov explosion problem. +# +# ---------------------------------------------------------------------- +# This parameter file is designed to be used for weak scaling I/O +# benchmarks and not science. It is based upon test_paramesh_3d.par. +# It will cause FLASH to run 4 time steps and output +# a checkpoint file and plot file each and every time step. +# +# Setup lines: +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_pnet +# --with-unit=IO/IOMain/pnetcdf/PM_argonne +# -parfile=sedov_io_8192p_32b_3d_weak.par +# +# ./setup Sedov -auto +pm4dev -maxblocks=90 -3d +cube16 -objdir=flash_hdf5 +# --with-unit=IO/IOMain/hdf5/parallel/PM_argonne +# -parfile=sedov_io_8192p_32b_3d_weak.par +# +# +# Tunable I/O parameters: +# +# Parameter name Library Valid values +# fileFormatVersion HDF5 & Pnetcdf 9, 10 +# useCollectiveHDF5 HDF5 .true., .false. +# packMeshPlotWriteHDF5 HDF5 .true., .false. +# packMeshChkWriteHDF5 HDF5 .true., .false. +# packMeshChkReadHDF5 HDF5 .true., .false. +# asyncMeshPlotWritePnet Pnetcdf .true., .false. +# asyncMeshChkWritePnet Pnetcdf .true., .false. +# asyncMeshChkReadPnet Pnetcdf .true., .false. +# +# fileFormat version 9 indicates standard FLASH I/O format where each +# mesh variable (e.g. dens, pres) is written to a separate dataset in +# the output file. fileFormat version 10 indicates all mesh variables +# are written to the same dataset in the output file. +# +# useCollectiveHDF5 is a switch for independent or collective HDF5. +# +# packMeshPlotWriteHDF5, packMeshChkWriteHDF5, packMeshChkReadHDF5 are +# used to pack mesh data into a new buffer using the mesh MPI datatypes +# with the MPI_Pack and MPI_Unpack functions. It is a useful option +# for plotfiles where a type conversion (double precision in memory to +# single precision in file) prevents HDF5 collective I/O optimizations. +# I would expect that the only useful parameter is packMeshPlotWriteHDF5, +# the other parameters, packMeshChkWriteHDF5 and packMeshChkReadHDF5 +# are only provided for completeness. +# +# asyncMeshPlotWritePnet, asyncMeshChkWritePnet, asyncMeshChkReadPnet +# are used to replace ncmpi_put_vara_all, ncmpi_get_vara_all library +# calls with ncmpi_iput_vara, ncmpi_iget_vara. I would expect it is +# most useful when used in conjunction with fileFormatVersion = 9 as +# here the N mesh variables (and so N library calls) are transferred +# asynchronously. +# + +fileFormatVersion = 9 + +useCollectiveHDF5 = .true. +packMeshPlotWriteHDF5 = .false. +packMeshChkWriteHDF5 = .false. +packMeshChkReadHDF5 = .false. + +asyncMeshPlotWritePnet = .false. +asyncMeshChkWritePnet = .false. +asyncMeshChkReadPnet = .false. +eachProcWritesSummary = .false. + +# ---------------------------------------------------------------------- + + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_min = 5 +lrefine_max = 5 +nblockx = 4 +nblocky = 4 +nblockz = 4 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalStep = 1 +plotFileIntervalStep = 1 +particleFileIntervalStep = 1 +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" +nend = 4 +tmax = 0.05 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 diff --git a/sim_readProfile.F90 b/sim_readProfile.F90 new file mode 100644 index 0000000..401b316 --- /dev/null +++ b/sim_readProfile.F90 @@ -0,0 +1,33 @@ +subroutine sim_readProfile + use Simulation_data, ONLY : sim_nProfile, & + sim_profFileName, & + sim_profileInitial, & + sim_rProf, sim_vProf, sim_rhoProf, sim_pProf + use Timers_interface, ONLY : Timers_start, Timers_stop + implicit none + + integer :: i, j + real :: errIgnored + + call Timers_start("readProfile") + ! Read in the solution file to use for interpolation + open(unit=10, file=sim_profFileName, status="OLD", action="READ") + do i=1, 17 + read(10,*) + end do + do i=1,sim_nProfile + read(10,*) (sim_profileInitial(j,i+1),j=1,4) + end do + close(10) + + + ! We have left one space for an initiial extra point. Now fill it it. + sim_profileInitial(1,1) = 0.0 ! add a first point at r=0.0 + sim_profileInitial(2,1) = 0.0 ! velocity is zero at 0.0 + call ut_polint(sim_profileInitial(1,2:3),sim_profileInitial(3,2:3), 2, 0.0, & + sim_profileInitial(3,1), errIgnored) ! density + call ut_polint(sim_profileInitial(1,2:3),sim_profileInitial(4,2:3), 2, 0.0, & + sim_profileInitial(4,1), errIgnored) ! pressure + call Timers_stop("readProfile") + +end subroutine sim_readProfile diff --git a/sim_scaleProfile.F90 b/sim_scaleProfile.F90 new file mode 100644 index 0000000..478af8d --- /dev/null +++ b/sim_scaleProfile.F90 @@ -0,0 +1,61 @@ +!!****if* source/Simulation/SimulationMain/Sedov/sim_scaleProfile +!! +!! NAME +!! +!! sim_scaleProfile +!! +!! SYNOPSIS +!! +!! call sim_scaleProfile(real(in) :: tcurr) +!! +!! DESCRIPTION +!! +!! +!! ARGUMENTS +!! +!! tcurr : +!! +!! AUTOGENROBODOC +!! +!! +!!*** + +subroutine sim_scaleProfile(tcurr) + use Simulation_data, ONLY : sim_nProfile, & + sim_useProfileFromFile, & + sim_profileIsScaled,sim_profileScaledTime, & + sim_rhoAmbient, sim_expEnergy, & + sim_profileInitial, & + sim_rProf, sim_vProf, sim_rhoProf, sim_pProf + use Timers_interface, ONLY : Timers_start, Timers_stop + implicit none + + real,intent(in) :: tcurr + + real :: S, St !scaling for analytical solution from file + integer :: i + + ! Scale data from the solution file to the current time + + if (sim_useProfileFromFile) then + if (.NOT. sim_profileIsScaled .OR. (sim_profileScaledTime .NE. tcurr)) then + call Timers_start("scaleProfile") + S = ( sim_rhoAmbient / (sim_expEnergy*tcurr*tcurr) ) ** 0.2 + St = S * tcurr + + do i=1,sim_nProfile+1 + sim_rProf (i) = sim_profileInitial(1,i) / S + sim_vProf (i) = sim_profileInitial(2,i) / St + sim_rhoProf(i) = sim_profileInitial(3,i) * sim_rhoAmbient + sim_pProf (i) = sim_profileInitial(4,i) * sim_rhoAmbient / (St*St) +!!$ print*,i,sim_rProf (i),sim_vProf (i),sim_rhoProf(i),sim_pProf (i) +!!$ if (.NOT. written) write(53,*)sim_rProf (i),sim_vProf (i),sim_rhoProf(i),sim_pProf (i) + end do + call Timers_stop("scaleProfile") + end if + end if + + sim_profileIsScaled = .TRUE. + sim_profileScaledTime = tcurr + +end subroutine sim_scaleProfile diff --git a/test_UG_1d.par b/test_UG_1d.par new file mode 100644 index 0000000..2db46e9 --- /dev/null +++ b/test_UG_1d.par @@ -0,0 +1,51 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 1 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. + +# Boundary conditions +# +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_1d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "1D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_1d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_2d.par b/test_UG_2d.par new file mode 100644 index 0000000..50b3b06 --- /dev/null +++ b/test_UG_2d.par @@ -0,0 +1,56 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 1 +jprocs = 1 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_2d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_2d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_3d.par b/test_UG_3d.par new file mode 100644 index 0000000..c0a3e5b --- /dev/null +++ b/test_UG_3d.par @@ -0,0 +1,61 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 2 +jprocs = 4 +kprocs = 1 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_3d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_3d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_4p_2d.par b/test_UG_4p_2d.par new file mode 100644 index 0000000..e0a389d --- /dev/null +++ b/test_UG_4p_2d.par @@ -0,0 +1,56 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 2 +jprocs = 2 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_2d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_2d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_8p_1d.par b/test_UG_8p_1d.par new file mode 100644 index 0000000..18dc99e --- /dev/null +++ b/test_UG_8p_1d.par @@ -0,0 +1,51 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 8 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. + +# Boundary conditions +# +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_1d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "1D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_1d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_nofbs_1d.par b/test_UG_nofbs_1d.par new file mode 100644 index 0000000..94419e6 --- /dev/null +++ b/test_UG_nofbs_1d.par @@ -0,0 +1,52 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 1 +igridsize = 64 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. + +# Boundary conditions +# +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_1d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "1D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_1d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_nofbs_2d.par b/test_UG_nofbs_2d.par new file mode 100644 index 0000000..064a3e3 --- /dev/null +++ b/test_UG_nofbs_2d.par @@ -0,0 +1,58 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 1 +jprocs = 1 +igridsize = 64 +jgridsize = 64 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_2d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_2d.log" +eintSwitch = 1.e-4 diff --git a/test_UG_nofbs_3d.par b/test_UG_nofbs_3d.par new file mode 100644 index 0000000..2b5a5ad --- /dev/null +++ b/test_UG_nofbs_3d.par @@ -0,0 +1,64 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 1 +jprocs = 1 +kprocs = 1 +igridsize = 64 +jgridsize = 64 +kgridsize = 64 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_ug_3d_1p_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_3d.log" +eintSwitch = 1.e-4 diff --git a/test_chombo_amr_2d.par b/test_chombo_amr_2d.par new file mode 100644 index 0000000..11d0c43 --- /dev/null +++ b/test_chombo_amr_2d.par @@ -0,0 +1,78 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_2d_6lev_" +restart = .false. +checkpointFileIntervalTime = 0.002 +nend = 10000 + +#CD: Using tmax = 0.01 so regression tests are faster. +tmax = 0.01 #0.05 +dtmin = 2.5D-5 +dtmax = 2.5D-5 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_2d_6lev.log" +eintSwitch = 0.0 + + +#Parameters for Chombo AMR +#Creates a simulation similar to test_paramesh_2d.par with nxb=nyb=8 +#----------------------------------------------------------------------- +#Temporarily set to False because it is not handled yet. +flux_correct = .false. + +#[i,j,k]gridsize are the number of cells on the coarsest level. +igridsize = 8 +jgridsize = 8 +kgridsize = 1 + +#Maximum block size. +maxBlockSize = 8 + + +#NOTE: igridsize=jgridsize=maxblocksize=16, lrefine_max=6, tmax=0.05 gives +#a very interesting refinement pattern. It appears to develop two highly +#refined spherical regions; the first region tracks the expanding blast wave, +#and the second also moves with the expansion but is behind the blast wave. diff --git a/test_chombo_ug_2d.par b/test_chombo_ug_2d.par new file mode 100644 index 0000000..a06d8c9 --- /dev/null +++ b/test_chombo_ug_2d.par @@ -0,0 +1,58 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +# Grid information + +iprocs = 2 +jprocs = 2 +igridsize = 256 +jgridsize = 256 + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +basenm = "sedov_2d_ug_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_ug_2d.log" +eintSwitch = 0.0 diff --git a/test_paramesh_2d.par b/test_paramesh_2d.par new file mode 100644 index 0000000..184690c --- /dev/null +++ b/test_paramesh_2d.par @@ -0,0 +1,55 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_2d_6lev_" +restart = .false. +checkpointFileIntervalTime = 0.01 +nend = 10000 +tmax = 0.05 +dtmin = 2.5D-5 +dtmax = 2.5D-5 + +run_comment = "2D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_2d_6lev.log" +eintSwitch = 1.e-4 diff --git a/test_paramesh_3d.par b/test_paramesh_3d.par new file mode 100644 index 0000000..58d7257 --- /dev/null +++ b/test_paramesh_3d.par @@ -0,0 +1,53 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalTime = 0.02 +nend = 1000 +tmax = 0.02 + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 diff --git a/test_paramesh_particles_2d.debug.par b/test_paramesh_particles_2d.debug.par new file mode 100644 index 0000000..e118b33 --- /dev/null +++ b/test_paramesh_particles_2d.debug.par @@ -0,0 +1,122 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + +pt_numX = 10 +pt_numY = 10 + +pt_initialXmin = 0.45 +pt_initialXmax = 0.55 +pt_initialYmin = 0.45 +pt_initialYmax = 0.55 + +pt_maxPerProc = 100 + +useParticles = .true. + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_2d_6lev_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 2 # = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +convertToConsvdInMeshInterp = .true. + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + diff --git a/test_paramesh_particles_2d.par b/test_paramesh_particles_2d.par new file mode 100644 index 0000000..45aa73f --- /dev/null +++ b/test_paramesh_particles_2d.par @@ -0,0 +1,143 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.013671875 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +sim_profFileName = "/dev/null" + +# Gas ratio of specific heats + +gamma = 1.4 + +# Computational volume parameters + +# Grid dimensionality and geometry + +geometry = "cartesian" + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" + +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" + +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + + + +pt_numX = 10 +pt_numY = 10 + +pt_initialXmin = 0.45 +pt_initialXmax = 0.55 +pt_initialYmin = 0.45 +pt_initialYmax = 0.55 + +pt_maxPerProc = 100 + +useParticles = .true. + + + +# Simulation time, I/O parameters + +cfl = 0.8 +basenm = "sedov_2d_6lev_" +restart = .false. + + +# checkpoint file output parameters +checkpointFileIntervalTime = 0.01 +checkpointFileIntervalStep = 0 +checkpointFileNumber = 0 + +# plotfile output parameters +plotfileIntervalTime = 0. +plotfileIntervalStep = 0 +plotfileNumber = 0 + +nend = 10000 +tmax = 0.05 + +run_comment = "Sedov explosion" +log_file = "sedov.log" +eintSwitch = 1.e-4 + +plot_var_1 = "dens" +plot_var_2 = "pres" +plot_var_3 = "temp" + +# Adaptvie Grid refinement parameters + +lrefine_max = 6 +refine_var_1 = "dens" +refine_var_2 = "pres" +convertToConsvdInMeshInterp = .true. + +# Uniform Grid specific parameters +# see note below for more explanation + +#iGridSize = 8 #global number of gridpoints along x, excluding gcells +#jGridSize = 8 #global number of gridpoints along y, excluding gcells +#kGridSize = 1 +iProcs = 1 #num procs in i direction +jProcs = 1 #num procs in j direction +kProcs = 1 + + +# When using UG, iProcs, jProcs and kProcs must be specified. +# These are the processors along each of the dimensions +#FIXEDBLOCKSIZE mode :: +# When using fixed blocksize, iGridSize etc are redundant in +# runtime parameters. These quantities are calculated as +# iGridSize = NXB*iprocs +# jGridSize = NYB*jprocs +# kGridSize = NZB*kprocs +#NONFIXEDBLOCKSIZE mode :: +# iGridSize etc must be specified. They constitute the global +# number of grid points in the physical domain without taking +# the guard cell into account. The local blocksize is calculated +# as iGridSize/iprocs etc. + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "Roe" # Roe, HLL, HLLC, LF +shockInstabilityFix = .true. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## + + diff --git a/test_paramesh_particles_3d.debug.par b/test_paramesh_particles_3d.debug.par new file mode 100644 index 0000000..409218e --- /dev/null +++ b/test_paramesh_particles_3d.debug.par @@ -0,0 +1,69 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +pt_numX = 10 +pt_numY = 10 +pt_numX = 10 + +pt_initialXmin = 0.45 +pt_initialXmax = 0.55 +pt_initialYmin = 0.45 +pt_initialYmax = 0.55 +pt_initialZmin = 0.45 +pt_initialZmax = 0.55 + + +pt_maxPerProc = 2000 + +useParticles = .true. + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalTime = 0.02 +nend = 2 # = 1000 +tmax = 0.02 +convertToConsvdInMeshInterp = .true. + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 diff --git a/test_paramesh_particles_3d.par b/test_paramesh_particles_3d.par new file mode 100644 index 0000000..0d34b75 --- /dev/null +++ b/test_paramesh_particles_3d.par @@ -0,0 +1,88 @@ +# Runtime parameters for the Sedov explosion problem. + +# Parameters for initial model + +# Ambient pressure and density, explosion energy, initial +# radius of perturbation, and location of explosion center + +sim_pAmbient = 1.E-5 +sim_rhoAmbient = 1. +sim_expEnergy = 1. +sim_rInit = 0.109375 +sim_xctr = 0.5 +sim_yctr = 0.5 +sim_zctr = 0.5 + +# Gas ratio of specific heats + +gamma = 1.4 + +pt_numX = 10 +pt_numY = 10 +pt_numZ = 10 + +pt_initialXmin = 0.45 +pt_initialXmax = 0.55 +pt_initialYmin = 0.45 +pt_initialYmax = 0.55 +pt_initialZmin = 0.45 +pt_initialZmax = 0.55 + + +pt_maxPerProc = 2000 + +useParticles = .true. + +# Size of computational volume + +xmin = 0. +xmax = 1. +ymin = 0. +ymax = 1. +zmin = 0. +zmax = 1. + +# Boundary conditions + +xl_boundary_type = "outflow" +xr_boundary_type = "outflow" +yl_boundary_type = "outflow" +yr_boundary_type = "outflow" +zl_boundary_type = "outflow" +zr_boundary_type = "outflow" + +# Simulation (grid, time, I/O) parameters + +cfl = 0.8 +lrefine_max = 3 +refine_var_1 = "dens" +refine_var_2 = "pres" +basenm = "sedov_3d_3lev_" +restart = .false. +checkpointFileIntervalTime = 0.02 +nend = 1000 +tmax = 0.02 +convertToConsvdInMeshInterp = .true. + +run_comment = "3D Sedov explosion, from t=0 with sim_rInit = 3.5dx_min" +log_file = "sedov_3d_3lev.log" +eintSwitch = 1.e-4 + +## -------------------------------------------------------------## +## SWITCHES SPECIFIC TO THE UNSPLIT HYDRO SOLVER ## +# I. INTERPOLATION SCHEME: +order = 2 # Interpolation order (First/Second order) +slopeLimiter = "mc" # Slope limiters (minmod, mc, vanLeer, hybrid, limited) +LimitedSlopeBeta= 1. # Slope parameter for the "limited" slope by Toro +charLimiting = .true. # Characteristic limiting vs. Primitive limiting + + +# II. RIEMANN SOLVERS: +RiemannSolver = "hllc" # Roe, HLL, HLLC, LF +shockInstabilityFix = .false. # Carbuncle instability fix for the Roe solver + + +# III. STRONG SHOCK HANDELING SCHEME: +shockDetect = .false. # Shock Detect for numerical stability +## -------------------------------------------------------------## +