diff --git a/src/Makefile.am b/src/Makefile.am index d7ae0072..05cc4264 100755 --- a/src/Makefile.am +++ b/src/Makefile.am @@ -41,7 +41,6 @@ io/io_input.f90\ io/io_read_craterlist.f90\ io/io_read_prod.f90\ io/io_read_regotrack.f90\ -io/io_read_porotrack.f90\ io/io_read_vdist.f90\ io/io_read_surf.f90\ io/io_ejecta_table.f90\ @@ -50,11 +49,13 @@ io/io_write_tally.f90\ io/io_write_surf.f90\ io/io_write_const.f90\ io/io_write_regotrack.f90\ -io/io_write_porotrack.f90\ io/io_crater_profile.f90\ io/io_updatePbar.f90\ io/io_resetPbar.f90\ io/io_splash.f90\ +io/io_write_age.f90\ +io/io_write_pindex_map.f90\ +io/io_write_age_depth.f90\ ejecta/ejecta_emplace.f90\ ejecta/ejecta_ray_pattern.f90\ ejecta/ejecta_blanket.f90\ @@ -73,20 +74,21 @@ crater/crater_averages.f90\ crater/crater_emplace.f90\ crater/crater_form_interior.f90\ crater/crater_form_exterior.f90\ +crater/crater_form_exterior_func.f90\ +crater/crater_form_exterior_rootfind.f90\ crater/crater_record.f90\ crater/crater_tally_true.f90\ crater/crater_tally_observed.f90\ crater/crater_slope_collapse.f90\ crater/crater_soften.f90\ -crater/crater_soften_accumulate.f90\ crater/crater_subpixel_diffusion.f90\ crater/crater_make_list.f90\ crater/crater_critical_slope.f90\ +crater/crater_superdomain.f90\ init/init_domain.f90\ init/init_dist.f90\ init/init_surf.f90\ init/init_regolith_stack.f90\ -init/init_porosity_stack.f90\ seismic/seismic_shake.f90\ seismic/seismic_distance.f90\ seismic/seismic_kdiff_func.f90\ @@ -106,6 +108,12 @@ regolith/regolith_subpixel_streamtube.f90\ regolith/regolith_transport.f90\ regolith/regolith_traverse_streamtube.f90\ regolith/regolith_subcrater_mix.f90\ +regolith/regolith_melt_glass.f90\ +regolith/regolith_superdomain.f90\ +regolith/regolith_melt_zone_superdomain.f90\ +regolith/regolith_streamtube_volume_func.f90\ +regolith/regolith_shock_damage_zone.f90\ +regolith/regolith_shock_damage.f90\ porosity/porosity_form_interior.f90\ main/CTEM.f90 CLEANFILES = *.mod diff --git a/src/crater/crater_emplace.f90 b/src/crater/crater_emplace.f90 index 79b91a44..6e58bce2 100644 --- a/src/crater/crater_emplace.f90 +++ b/src/crater/crater_emplace.f90 @@ -64,7 +64,7 @@ subroutine crater_emplace(user,surf,crater,domain,deltaMtot) real(DP),intent(out) :: deltaMtot ! Internal variables - real(DP) :: lradsq,newelev, x_relative, y_relative + real(DP) :: lradsq,newelev integer(I4B) :: xpi,ypi,i,j,inc,incsq,iradsq real(DP) :: xp,yp,fradsq,deltaMi,rimheight logical :: lastloop @@ -94,13 +94,10 @@ subroutine crater_emplace(user,surf,crater,domain,deltaMtot) ! periodic boundary conditions call util_periodic(xpi,ypi,user%gridsize) - x_relative = (crater%xl - xp) - y_relative = (crater%yl - yp) - - lradsq = x_relative**2 + y_relative**2 + lradsq = (crater%xl - xp)**2 + (crater%yl - yp)**2 if (lradsq > crater%frad**2) cycle - call crater_form_interior(user,surf(xpi,ypi),crater,x_relative, y_relative,newelev,deltaMi) + call crater_form_interior(user,surf(xpi,ypi),crater,lradsq,newelev,deltaMi) deltaMtot = deltaMtot + deltaMi ! do porosity computation if (user%doporosity) diff --git a/src/crater/crater_form_interior.f90 b/src/crater/crater_form_interior.f90 index 52f73875..941e3cff 100644 --- a/src/crater/crater_form_interior.f90 +++ b/src/crater/crater_form_interior.f90 @@ -18,7 +18,7 @@ ! Notes : ! !********************************************************************************************************************************** -subroutine crater_form_interior(user,surfi,crater,x_relative, y_relative ,newelev,deltaMi) +subroutine crater_form_interior(user,surfi,crater,lradsq,newelev,deltaMi) use module_globals use module_util use module_crater, EXCEPT_THIS_ONE => crater_form_interior @@ -28,7 +28,7 @@ subroutine crater_form_interior(user,surfi,crater,x_relative, y_relative ,newele type(usertype),intent(in) :: user type(surftype),intent(inout) :: surfi type(cratertype),intent(in) :: crater - real(DP),intent(in) :: x_relative, y_relative + real(DP),intent(in) :: lradsq real(DP),intent(in) :: newelev real(DP),intent(out) :: deltaMi @@ -42,7 +42,7 @@ subroutine crater_form_interior(user,surfi,crater,x_relative, y_relative ,newele ! Executable code !change digital elevation map - r = sqrt(x_relative**2+y_relative**2) / crater%frad + r = sqrt(lradsq) / crater%frad ! Use empirical crater form from Fassett et al. 2014 if (r < 0.2_DP) then cform = -0.181_DP * crater%fcrat diff --git a/src/crater/crater_populate.f90 b/src/crater/crater_populate.f90 index 59c3f89f..b71f9f30 100644 --- a/src/crater/crater_populate.f90 +++ b/src/crater/crater_populate.f90 @@ -76,15 +76,22 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt real(DP) :: ejbmass logical :: makecrater real(DP),dimension(user%gridsize,user%gridsize) :: kdiff + TARGET :: surf integer(I4B) :: oldpbarpos ! ejecta blanket array type(ejbtype),dimension(EJBTABSIZE) :: ejb ! Ejecta blanket lookup table integer(I4B) :: ejtble - ! doregotrack - real(DP) :: melt, clock!, volume, r1, r2, h + ! subpixel utilities real(DP),dimension(2,domain%pnum) :: p - integer(I4B) :: craters_since_subpixel_mix, icrater_last_subpixel_mix + integer(I4B) :: craters_since_subpixel_mix, icrater_last_subpixel_mix + + ! doregotrack & age simulation test + real(DP) :: melt, age, thick + real(SP),dimension(user%gridsize, user%gridsize) :: agetop + real(SP),dimension(60) :: agetot + type(regolisttype),pointer :: current => null() + real(DP) :: age_resolution if (user%testflag) then write(*,*) "Generating a test crater" @@ -123,20 +130,21 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt ! begin cratering loop if (.not.user%testflag) then pbarival = floor(real(ntrue)/real(PBARRES)) - call io_resetPbar() + !call io_resetPbar() end if icrater_last_tally = 0 icrater_last_subpixel = 0 icrater = 0 - clock = 0.0_DP + ! Reset age + finterval = 1.0_DP / real(ntotcrat,kind=DP) + age = user%interval + age_resolution = age / real(MAXAGEBINS) + ! Reset coverage map domain%tallycoverage = 0 domain%subpixelcoverage = 0 kdiff = 0.0_DP - pbarpos = 0 - call io_updatePbar("") - oldpbarpos = 0 do while (icrater < ntotcrat) makecrater = .true. timestamp_old = real(curyear + real(icrater,kind=DP) / real(ntotcrat,kind=DP) * user%interval,kind=SP) @@ -218,7 +226,6 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt truelist(4,ntrue) = crater%yl truelist(5,ntrue) = crater%impvel truelist(6,ntrue) = crater%sinimpang - truelist(7,ntrue) = crater%timestamp mass = mass + crater%impmass crater%maxinc = 0 @@ -253,7 +260,7 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt call ejecta_table_define(user,crater,domain,ejb,ejtble) call ejecta_interpolate(crater,domain,crater%frad,ejb(1:ejtble),ejtble,crater%ejrim) end if - call ejecta_emplace(user,surf,crater,domain,ejb(1:ejtble),ejtble,ejbmass) + call ejecta_emplace(user,surf,crater,domain,ejb(1:ejtble),ejtble,ejbmass,age,age_resolution) else ejtble = 0 end if @@ -266,12 +273,7 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt call util_sort_layer(user,surf,crater) vistrue = vistrue + 1 nsincetally = nsincetally + 1 - if (.not.user%testflag) then - if (pbarpos /= oldpbarpos) then - call io_updatePbar("") - oldpbarpos = pbarpos - end if - end if + !if (.not.user%testflag) call io_updatePbar("") !if (user%docrustal_thinning) call crust_thin(user,surf,crater,domain,mdepth) @@ -301,41 +303,45 @@ subroutine crater_populate(user,surf,crater,domain,prod,production_list,vdist,nt end if ! Do sub-pixel craters vertical mixing + ! Do superdomain ray deposits + finterval = 1.0_DP / real(ntotcrat,kind=DP) if (user%doregotrack) then - finterval = 1.0_DP / real(ntotcrat,kind=DP) + call crater_superdomain(user,surf,age,age_resolution,prod,nflux,domain,finterval) call regolith_depth_model(user,domain,finterval,nflux,p) call regolith_subcrater_mix(user,surf,domain,nflux,finterval,p) end if ! Do periodic subpixel processes on the whole grid - if (.not.user%testflag) then - if ((domain%subpixelcoverage / real(user%gridsize**2,kind=DP) > SUBPIXELCOVERAGE).or.(icrater == ntotcrat)) then - domain%subpixelcoverage = 0 - write(message,*) "Subpixel" - call io_updatePbar(message) - craters_since_subpixel = icrater - icrater_last_subpixel - finterval = craters_since_subpixel / real(ntotcrat,kind=DP) - call crater_subpixel_diffusion(user,surf,prod,nflux,domain,finterval,kdiff) - icrater_last_subpixel = icrater - end if - ! Intermediate tally step - if (domain%tallycoverage / real(user%gridsize**2,kind=DP) > TALLYCOVERAGE) then - domain%tallycoverage = 0 - write(message,*) "Tally" - call io_updatePbar(message) - craters_since_tally = icrater - icrater_last_tally - finterval = craters_since_tally / real(ntotcrat,kind=DP) - icrater_last_tally = icrater - call crater_tally_observed(user,surf,domain,nkilled,onum) - write(message,*) "Tally killed ",nkilled - call io_updatePbar(message) - ntotkilled = ntotkilled + nkilled - nsincetally = 0 + if (.not.user%doregotrack) then ! Disable whole grid subpixel if doregotrack flag is on + if (.not.user%testflag) then + if ((domain%subpixelcoverage / real(user%gridsize**2,kind=DP) > SUBPIXELCOVERAGE).or.(icrater == ntotcrat)) then + domain%subpixelcoverage = 0 + write(message,*) "Subpixel" + call io_updatePbar(message) + craters_since_subpixel = icrater - icrater_last_subpixel + finterval = craters_since_subpixel / real(ntotcrat,kind=DP) + call crater_subpixel_diffusion(user,surf,prod,nflux,domain,finterval,kdiff) + icrater_last_subpixel = icrater + end if + ! Intermediate tally step + if (domain%tallycoverage / real(user%gridsize**2,kind=DP) > TALLYCOVERAGE) then + domain%tallycoverage = 0 + write(message,*) "Tally" + call io_updatePbar(message) + craters_since_tally = icrater - icrater_last_tally + finterval = craters_since_tally / real(ntotcrat,kind=DP) + icrater_last_tally = icrater + call crater_tally_observed(user,surf,domain,nkilled,onum) + write(message,*) "Tally killed ",nkilled + call io_updatePbar(message) + ntotkilled = ntotkilled + nkilled + nsincetally = 0 + end if end if - end if + end do ! end crater production loop - + ! Resize the true crater size array to the actual number of craters produced ! Display stats ddmax = rmax / cmax diff --git a/src/crater/crater_soften.f90 b/src/crater/crater_soften.f90 index e20d4f1a..d6943b76 100644 --- a/src/crater/crater_soften.f90 +++ b/src/crater/crater_soften.f90 @@ -31,46 +31,42 @@ subroutine crater_soften(user,surf,crater,domain) type(domaintype),intent(in) :: domain ! Internal variables - real(DP),dimension(:,:),allocatable :: cumulative_elchange,kdiff + real(DP),dimension(:,:),allocatable :: cumulative_elchange,kappat integer(I4B),dimension(:,:,:),allocatable :: indarray - real(DP),dimension(0:user%gridsize+1,0:user%gridsize+1) :: big_cel,big_kdiff - integer(I4B),dimension(2,0:user%gridsize+1,0:user%gridsize+1) :: big_indarray integer(I4B) :: maxhits - integer(I4B) :: inc,incsq,N,xpi,ypi,iradsq,i,j,ss,ioerr,bigi,bigj - real(DP) :: xp,yp,fradsq,xbar,ybar,areafrac,kdiffmax,sf + integer(I4B) :: inc,incsq,N,xpi,ypi,iradsq,i,j,ss,ioerr + real(DP) :: xp,yp,fradsq,xbar,ybar,areafrac,kappatmax,sf - kdiffmax = user%Kd1 * crater%frad**user%psi - inc = int(min(user%fe * crater%frad / user%pix,SQRT2 * user%gridsize)) + 3 + !kappatmax = user%soften_factor * crater%frad**user%soften_slope + open(unit=22,file='soften.dat',status='old',iostat=ioerr) + if (ioerr /= 0) return + read(22,*) sf + close(22) + !inc = max(min(int(crater%fradpx + 2),PBCLIM * user%gridsize),2) + inc = crater%fradpx + 2 maxhits = (1 + (inc / (user%gridsize / 2)))**2 crater%maxinc = max(crater%maxinc,inc) - incsq = (inc - 2)**2 + incsq = inc**2 + kappatmax = (sf / PI) * crater%frad**2 - allocate(kdiff(-inc:inc,-inc:inc)) + allocate(kappat(-inc:inc,-inc:inc)) allocate(indarray(2,-inc:inc,-inc:inc)) allocate(cumulative_elchange(-inc:inc,-inc:inc)) - cumulative_elchange = 0.0_DP + cumulative_elchange = 0._DP indarray = inc - kdiff = 0.0_DP + kappat = 0.0_DP ! Loop over affected matrix area do j=-inc,inc ! Do the loop in pixel space do i=-inc,inc - ! find elevation and grid point - xpi = crater%xlpx + i - ypi = crater%ylpx + j - - ! periodic boundary conditions - call util_periodic(xpi,ypi,user%gridsize) - - indarray(1,i,j) = xpi - indarray(2,i,j) = ypi - ! find distance from crater center iradsq = i*i + j*j + if (iradsq <= incsq) then + ! find elevation and grid point + xpi = crater%xlpx + i + ypi = crater%ylpx + j - ! We set the diffusion constant to be proportional to the fraction of pixel area covered by the interior of the crater - !if (iradsq <= incsq) then ! Find distance from crater center to current pixel center in real space xp = xpi * user%pix yp = ypi * user%pix @@ -78,68 +74,31 @@ subroutine crater_soften(user,surf,crater,domain) xbar = xp - crater%xl ybar = yp - crater%yl - areafrac = util_area_intersection(user%fe * crater%frad,xbar,ybar,user%pix) - - kdiff(i,j) = kdiffmax * areafrac ! Apply user-defined diffusive degradation to degradation region - !end if - end do - end do !end area loopover - !write(*,*) 'crater_soften: ',crater%frad,maxval(kdiff) - - if (2 * inc + 1 < user%gridsize) then - write(*,*) 'crater inc = ',inc - write(*,*) 'crater kdiff ' - write(*,*) maxval(kdiff) - call util_diffusion_solver(user,surf,2 * inc + 1,indarray,kdiff,cumulative_elchange,maxhits) - write(16,*) crater%frad - do j = -inc,inc - do i = -inc,inc - xpi = indarray(1,i,j) - ypi = indarray(2,i,j) - write(16,*) i,j,xpi,ypi,kdiff(i,j),surf(xpi,ypi)%dem,cumulative_elchange(i,j) - !surf(xpi,ypi)%dem = surf(xpi,ypi)%dem + cumulative_elchange(i,j) - !surf(xpi,ypi)%ejcov = max(surf(xpi,ypi)%ejcov + cumulative_elchange(i,j),0.0_DP) - end do - end do - else - maxhits = 1 - big_kdiff = 0.0_DP - big_cel = 0.0_DP - do bigj = 0,user%gridsize + 1 - do bigi = 0,user%gridsize + 1 - xpi = bigi - ypi = bigj + ! periodic boundary conditions call util_periodic(xpi,ypi,user%gridsize) - big_indarray(1,bigi,bigj) = xpi - big_indarray(2,bigi,bigj) = ypi - end do - end do + + indarray(1,i,j) = xpi + indarray(2,i,j) = ypi - do j = -inc,inc - do i = -inc,inc - xpi = indarray(1,i,j) - ypi = indarray(2,i,j) - big_kdiff(xpi,ypi) = big_kdiff(xpi,ypi) + kdiff(i,j) - end do + ! We set the diffusion constant to be proportional to the fraction of pixel area covered by the interior of the crater + areafrac = util_area_intersection(crater%frad*0.98_DP,xbar,ybar,user%pix) + + kappat(i,j) = kappatmax * areafrac ! This is the extra per-crater diffusion required to match equilibrium + end if end do + end do !end area loopover - big_kdiff(0,0) = big_kdiff(user%gridsize,user%gridsize) - big_kdiff(user%gridsize + 1,user%gridsize + 1) = big_kdiff(1,1) - big_kdiff(0,:) = big_kdiff(user%gridsize,:) - big_kdiff(:,0) = big_kdiff(:,user%gridsize) - big_kdiff(user%gridsize + 1,:) = big_kdiff(1,:) - big_kdiff(:,user%gridsize + 1) = big_kdiff(:,1) - call util_diffusion_solver(user,surf,user%gridsize + 2,big_indarray,big_kdiff,big_cel,maxhits) - do j = 1,user%gridsize - do i = 1,user%gridsize - surf(i,j)%dem = surf(i,j)%dem + big_cel(i,j) - surf(i,j)%ejcov = max(surf(i,j)%ejcov + big_cel(i,j),0.0_DP) - end do + call util_diffusion_solver(user,surf,2 * inc + 1,indarray,kappat,cumulative_elchange,maxhits) + do j = -inc,inc + do i = -inc,inc + xpi = indarray(1,i,j) + ypi = indarray(2,i,j) + surf(xpi,ypi)%dem = surf(xpi,ypi)%dem + cumulative_elchange(i,j) + surf(xpi,ypi)%ejcov = max(surf(xpi,ypi)%ejcov + cumulative_elchange(i,j),0.0_DP) end do - end if - - deallocate(kdiff,indarray,cumulative_elchange) + end do + deallocate(kappat,indarray,cumulative_elchange) return end subroutine crater_soften diff --git a/src/crater/crater_subpixel_diffusion.f90 b/src/crater/crater_subpixel_diffusion.f90 index 7f8c27a3..86b53973 100644 --- a/src/crater/crater_subpixel_diffusion.f90 +++ b/src/crater/crater_subpixel_diffusion.f90 @@ -37,18 +37,15 @@ subroutine crater_subpixel_diffusion(user,surf,prod,nflux,domain,finterval,kdiff ! Internal variables real(DP),dimension(0:user%gridsize + 1,0:user%gridsize + 1) :: cumulative_elchange,kdiff integer(I4B),dimension(2,0:user%gridsize + 1,0:user%gridsize + 1) :: indarray - integer(I4B) :: i,j,l,xpi,ypi,k,ktot,kk,ioerr,inc,incsq,iradsq,xi,xf,yi,yf,crat,imin,imax,jmin,jmax - integer(I8B) :: m,N + integer(I4B) :: i,j,k,l,m,xpi,ypi,n,ntot,ioerr,inc,xi,xf,yi,yf integer(I4B) :: maxhits = 1 - real(DP) :: dburial,lambda,dKdN,diam,radius,Area,avgejc - real(DP) :: dN,diam_regolith,diam_bedrock,RR - real(DP),dimension(3) :: rn - real(DP) :: superlen,rayfrac,cutout,fe,fd + real(DP) :: lamleft,dburial,lambda,Kbar,diam,radius,Area,avgejc,sf + real(DP),dimension(domain%pnum) :: dN,lambda_regolith,Kbar_regolith,lambda_bedrock,Kbar_bedrock + real(DP),dimension(2) :: rn + real(DP) :: superlen,rayfrac type(cratertype) :: crater - real(DP),dimension(:,:),allocatable :: diffdistribution,ejdistribution + real(DP),dimension(:,:),allocatable :: ejdistribution integer(I4B),dimension(:,:),allocatable :: ejisray - real(DP) :: xbar,ybar,dD,xp,yp,areafrac,krad,supersize,lrad - integer(I8B),dimension(user%gridsize,user%gridsize) :: Ngrid ! Create box for soften calculation (will be no bigger than the grid itself) @@ -63,158 +60,165 @@ subroutine crater_subpixel_diffusion(user,surf,prod,nflux,domain,finterval,kdiff end do end do - avgejc = sum(surf%ejcov) / domain%parea + ntot = 1 + ! calculate the subpixel diffusion probability function + Area = user%pix**2 - fe = FEPROX - fd = user%ejecta_truncation - if (user%dosoftening) fe = user%fe + do i = 1,domain%pnum + if ((nflux(1,i) > domain%smallest_crater).and.(nflux(2,i) > domain%smallest_crater)) exit + ntot = i + dN(i) = nflux(3,i) * user%interval * finterval - ! Generate both the subpixel and superdomain diffusive degradation - do k = 1,domain%pnum - 1 - dN = nflux(3,k) * user%interval * finterval + lambda_bedrock(i) = dN(i) * Area + lambda_regolith(i) = dN(i) * Area - diam_bedrock = nflux(1,k) - diam_regolith = nflux(2,k) - - dburial = 0.5_DP * EXFAC * max(diam_bedrock,diam_regolith) - if (dburial > avgejc) then - diam = diam_bedrock - else - diam = diam_regolith + Kbar_bedrock(i) = 0.84_DP * (0.5_DP * nflux(1,i))**4 ! Intrinsic degradation function + Kbar_regolith(i) = 0.84_DP * (0.5_DP * nflux(2,i))**4 + + if (user%dosoftening) then + Kbar_bedrock(i) = Kbar_bedrock(i) + user%soften_factor * (0.5_DP * nflux(1,i))**(user%soften_slope) + Kbar_regolith(i) = Kbar_regolith(i) + user%soften_factor * (0.5_DP * nflux(2,i))**(user%soften_slope) end if - radius = 0.5_DP * diam - - if ((fd * diam < user%pix) .or. (dN * PI * (fe * radius)**2 > 0.1_DP)) then - !Do the average degradation per pixel for the subpixel component - if (user%dosoftening) then - ! User-defined degradation function - dKdN = user%Kd1 * PI * user%fe**2 * (radius)**(2.0_DP + user%psi) / domain%parea - else - !Empirically-derived "intrinsic" degradation function from proximal ejecta redistribution - dKdN = KD1PROX * PI * FEPROX**2 * (radius)**(2.0_DP + PSIPROX) / domain%parea - end if - lambda = dN * domain%parea + end do - ! Don't parallelize the random - do j = 1,user%gridsize - do i = 1,user%gridsize - Ngrid(i,j) = util_poisson(lambda) - end do + do j = 1,user%gridsize + do i = 1,user%gridsize + do n = 1,ntot + dburial = EXFAC * 0.5_DP * nflux(1,n) + if (surf(i,j)%ejcov > dburial) then + lambda = lambda_regolith(n) + Kbar = Kbar_regolith(n) + diam = nflux(2,n) + else + lambda = lambda_bedrock(n) + Kbar = Kbar_bedrock(n) + diam = nflux(1,n) + end if + if (diam > domain%smallest_crater) exit + k = util_poisson(lambda) + kdiff(i,j) = kdiff(i,j) + k * Kbar / Area end do - - !$OMP PARALLEL DO DEFAULT(PRIVATE) & - !$OMP SHARED(user) & - !$OMP SHARED(Ngrid,dKdN,kdiff,dN,lambda) - do j = 1,user%gridsize - do i = 1,user%gridsize - if ((Ngrid(i,j)) == 0) cycle - if ((Ngrid(i,j) > 0).and.(Ngrid(i,j) == Ngrid(i,j))) then - kdiff(i,j) = kdiff(i,j) + dKdN * Ngrid(i,j) - else ! In case of integer overflow - kdiff(i,j) = kdiff(i,j) + dKdN * lambda - end if - end do + end do + end do + kdiff(0,0) = kdiff(user%gridsize,user%gridsize) + kdiff(user%gridsize + 1,user%gridsize + 1) = kdiff(1,1) + kdiff(0,:) = kdiff(user%gridsize,:) + kdiff(:,0) = kdiff(:,user%gridsize) + kdiff(user%gridsize + 1,:) = kdiff(1,:) + kdiff(:,user%gridsize + 1) = kdiff(:,1) + + ! Now add the superdomain contribution to crater degradation + if (user%dosoftening) then + crater%ejdis = user%gridsize * user%pix * 0.5_DP + crater%continuous = crater%ejdis / DISEJB + radius = (crater%continuous / 2.348_DP)**(1.0_DP / 1.006_DP) + crater%frad = radius + crater%rad = radius + inc = nint(min(crater%ejdis / user%pix, crater%frad * user%ejecta_truncation / user%pix)) + 1 + crater%xl = user%gridsize * user%pix * 0.5_DP + crater%yl = user%gridsize * user%pix * 0.5_DP + crater%xlpx = nint(crater%xl / user%pix) + crater%ylpx = nint(crater%yl / user%pix) + allocate(ejdistribution(-inc:inc,-inc:inc)) + allocate(ejisray(-inc:inc,-inc:inc)) + call ejecta_ray_pattern(user,surf,crater,inc,-inc,inc,-inc,inc,ejdistribution) + do j = -inc,inc + do i = -inc,inc + if (ejdistribution(i,j) > 0.0001_DP) then + ejisray(i,j) = 1 + else + ejisray(i,j) = 0 + end if end do - !$OMP END PARALLEL DO - - else if (user%dosoftening) then - ! Do the degradation as individual circles - - superlen = fd * diam + domain%side - cutout = 0.0_DP - crater%continuous = RCONT * radius**(EXPCONT) - if (diam > domain%smallest_crater) then - if (.not.user%superdomain) exit - ! Superdomain craters - cutout = domain%side + crater%continuous + end do + rayfrac = PI * inc**2 / (1.0_DP * count(ejisray == 1)) + deallocate(ejisray,ejdistribution) + + avgejc = sum(surf%ejcov) / user%gridsize**2 + do l = 1,domain%pnum + if ((PI * (user%soften_size * nflux(1,l) * 0.5_DP)**2 <= (user%gridsize)**2 ).and.& + (PI * (user%soften_size * nflux(2,l) * 0.5_DP)**2 <= (user%gridsize)**2 )) cycle + + dburial = EXFAC * 0.5_DP * nflux(1,n) + if (avgejc > dburial) then + radius = nflux(2,l) * 0.5_DP + else + radius = nflux(1,l) * 0.5_DP end if - Area = superlen**2 - if (diam < domain%biggest_crater) Area = Area - cutout**2 - lambda = dN * Area - dD = nflux(2,k+1) - nflux(2,k) - - N = util_poisson(lambda) - do m = 1, N + dN(l) = nflux(3,l) * user%interval * finterval + Area = min(PI * (user%soften_size * radius)**2 , 4 * PI * user%trad**2) + Area = max(Area - (user%pix * user%gridsize)**2,0.0_DP) + if (Area == 0.0_DP) cycle + superlen = 0.5_DP * (sqrt(Area) - user%pix * user%gridsize) + + lambda = dN(l) * Area + if (lambda == 0.0_DP) cycle + k = util_poisson(lambda) + do m = 1, k + + ! generate random crater on the superdomain + ! Set up size of crater and ejecta blanket + crater%frad = radius + crater%rad = radius + crater%continuous = 2.348_DP * crater%frad**(1.006_DP) + crater%ejdis = DISEJB * crater%continuous + inc = nint(min(crater%ejdis / user%pix, crater%frad * user%ejecta_truncation / user%pix)) + 1 + + ! find the x and y position of the crater call random_number(rn) + crater%xl = real(superlen * (2 * rn(1) - 1.0_DP), kind=SP) + crater%yl = real(superlen * (2 * rn(2) - 1.0_DP), kind=SP) - if (diam < domain%smallest_crater) then - ! Subpixel craters with large degradation region - crater%xl = real(superlen * (rn(1) - 0.5_DP) + 0.5_DP * domain%side, kind=SP) - crater%yl = real(superlen * (rn(2) - 0.5_DP) + 0.5_DP * domain%side, kind=SP) - else if (.not.user%superdomain) then - cycle + if (crater%xl > 0.0_SP) then + crater%xl = crater%xl + user%pix * user%gridsize + else + crater%xl = crater%xl - user%pix * user%gridsize + end if + if (crater%yl > 0.0_SP) then + crater%yl = crater%yl + user%pix * user%gridsize else - ! Superdomain craters - crater%xl = real((superlen - cutout) * (rn(1) - 0.5_DP), kind=SP) - if (crater%xl > 0.0_DP) crater%xl = crater%xl + cutout - crater%yl = real((superlen - cutout) * (rn(2) - 0.5_DP), kind=SP) - if (crater%yl > 0.0_DP) crater%yl = crater%yl + cutout + crater%yl = crater%yl - user%pix * user%gridsize end if crater%xlpx = nint(crater%xl / user%pix) crater%ylpx = nint(crater%yl / user%pix) - crater%frad = 0.5_DP * (diam + dD * rn(3)) - crater%continuous = RCONT * crater%frad**(EXPCONT) - krad = fd * crater%frad - - dKdN = user%Kd1 * crater%frad**(user%psi) - inc = int(krad / user%pix) + 2 - incsq = inc**2 - - xpi = max(crater%xlpx - inc,1) - imin = xpi - crater%xlpx - xpi = min(crater%xlpx + inc,user%gridsize) - imax = xpi - crater%xlpx - ypi = max(crater%ylpx - inc,1) - jmin = ypi - crater%ylpx - ypi = min(crater%ylpx + inc,user%gridsize) - jmax = ypi - crater%ylpx - - - allocate(diffdistribution(imin:imax,jmin:jmax)) - allocate(ejdistribution(imin:imax,jmin:jmax)) - call ejecta_ray_pattern(user,surf,crater,inc,imin,imax,jmin,jmax,diffdistribution,ejdistribution) - ! Loop over affected matrix area - !$OMP PARALLEL DO DEFAULT(PRIVATE) IF(inc > INCPAR) & - !$OMP SHARED(jmin,jmax,imin,imax,kdiff,dKdN,krad,diffdistribution,ejdistribution) & - !$OMP SHARED(crater,user,surf) - do j = jmin,jmax - do i = imin,imax - xpi = crater%xlpx + i - ypi = crater%ylpx + j - kdiff(xpi,ypi) = kdiff(xpi,ypi) + dKdN * diffdistribution(i,j) - !TEMP - xp = xpi * user%pix - yp = ypi * user%pix - lrad = sqrt((xp - crater%xl)**2 + (yp - crater%yl)**2) - surf(xpi,ypi)%ejcov = surf(xpi,ypi)%ejcov + ejdistribution(i,j) & - * 0.14_DP * crater%frad**(0.74_DP) * (lrad / crater%frad)**(-3.0_DP) + xi = 1 - crater%xlpx + xf = user%gridsize - crater%xlpx + yi = 1 - crater%ylpx + yf = user%gridsize - crater%ylpx + + allocate(ejdistribution(xi:xf,yi:yf)) + allocate(ejisray(xi:xf,yi:yf)) + ! Now generate ray pattern + call ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,ejdistribution) + do j = yi,yf + do i = xi,xf + if (ejdistribution(i,j) > 0.0001_DP) then + ejisray(i,j) = 1 + else + ejisray(i,j) = 0 + end if end do end do - !$OMP END PARALLEL DO - deallocate(diffdistribution,ejdistribution) - end do - end if - - end do - - kdiff(0,0) = kdiff(user%gridsize,user%gridsize) - kdiff(user%gridsize + 1,user%gridsize + 1) = kdiff(1,1) - kdiff(0,:) = kdiff(user%gridsize,:) - kdiff(:,0) = kdiff(:,user%gridsize) - kdiff(user%gridsize + 1,:) = kdiff(1,:) - kdiff(:,user%gridsize + 1) = kdiff(:,1) - - write(*,*) - write(*,*) 'avgkdiff = ',sum(kdiff) / (user%gridsize + 2)**2 / finterval - write(*,*) - open(unit=55,file='avgkdiff.dat',status='unknown',position='append') - write(55,*) sum(kdiff) / (user%gridsize + 2)**2 / finterval - close(55) + do j = 1, user%gridsize + do i = 1, user%gridsize + xpi = i - crater%xlpx + ypi = j - crater%ylpx + if ((abs(xpi) > inc) .or. (abs(ypi) > inc)) cycle + if (ejisray(xpi,ypi) == 0) cycle + kdiff(i,j) = kdiff(i,j) + & + rayfrac * user%soften_factor / (PI * user%soften_size**2) * crater%frad**(user%soften_slope - 2.0_DP) + end do + end do + deallocate(ejdistribution,ejisray) + end do + end do + end if + call util_diffusion_solver(user,surf,user%gridsize + 2,indarray,kdiff,cumulative_elchange,maxhits) do j = 1,user%gridsize diff --git a/src/crater/crater_superdomain.f90 b/src/crater/crater_superdomain.f90 new file mode 100644 index 00000000..838046ab --- /dev/null +++ b/src/crater/crater_superdomain.f90 @@ -0,0 +1,203 @@ +!********************************************************************************************************************************** +! +! Unit Name : crater_superdomain +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Softens the terrain under the ejecta using a box filter model where the size of the box is proportional to the +! thickness of the ejecta +! +! +! Input +! Arguments : +! +! Output +! Arguments : +! +! +! Notes : +! +!********************************************************************************************************************************** +subroutine crater_superdomain(user,surf,age,age_resolution,prod,nflux,domain,finterval,kdiff) + use module_globals + use module_util + use module_ejecta + use module_regolith + use module_crater, EXCEPT_THIS_ONE => crater_superdomain + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(inout) :: surf + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),dimension(:,:),intent(in) :: prod,nflux + type(domaintype),intent(in) :: domain + real(DP),intent(in) :: finterval + real(DP),dimension(:,:),intent(inout),optional :: kdiff + + ! Internal variables + integer(I4B),dimension(2,0:user%gridsize + 1,0:user%gridsize + 1) :: indarray + integer(I4B) :: i,j,k,l,m,xpi,ypi,n,ntot,ioerr,inc,xi,xf,yi,yf + real(DP) :: lamleft,dburial,lambda,diam,radius,Area,avgejc,sf + real(DP),dimension(domain%pnum) :: dN + real(DP),dimension(2) :: rn + real(DP) :: superlen,rayfrac + type(cratertype) :: crater + real(DP),dimension(:,:),allocatable :: ejdistribution + integer(I4B),dimension(:,:),allocatable :: ejisray + + ! Melt or glassy ray test + real(DP) :: xp, yp, lradsq, lrad, erad + real(DP),dimension(4) :: lradif + real(DP) :: rm, depthb, maxgcrat, maxgcratkm + real(SP) :: gglass, glrad + + ! Create box for soften calculation (will be no bigger than the grid itself) + do j = 0,user%gridsize + 1 + do i = 0,user%gridsize + 1 + xpi = i + ypi = j + call util_periodic(xpi,ypi,user%gridsize) + indarray(1,i,j) = xpi + indarray(2,i,j) = ypi + end do + end do + + ! calculate the smallest crater size for a crater forming in regolith + do i = 1,domain%pnum + if ((nflux(1,i) > domain%smallest_crater).and.(nflux(2,i) > domain%smallest_crater)) exit + ntot = i + end do + n = ntot + avgejc = sum(surf%ejcov) / user%gridsize**2 + maxgcrat = 0.0_DP + do l = 1,domain%pnum + if ((PI * (user%soften_size * nflux(1,l) * 0.5_DP)**2 <= (user%gridsize)**2 ).and.& + (PI * (user%soften_size * nflux(2,l) * 0.5_DP)**2 <= (user%gridsize)**2 )) cycle + + dburial = EXFAC * 0.5_DP * nflux(1,n) + if (avgejc > dburial) then + radius = nflux(2,l) * 0.5_DP + else + radius = nflux(1,l) * 0.5_DP + end if + + dN(l) = nflux(3,l) * user%interval * finterval + Area = min(PI * (user%soften_size * radius)**2 , 4 * PI * user%trad**2) + Area = max(Area - (user%pix * user%gridsize)**2,0.0_DP) + if (Area == 0.0_DP) cycle + ! Center at the local domain, and calculate the maximum distance from the super + ! domain crater to the local domain. + superlen = 0.5_DP * (sqrt(Area) - user%pix * user%gridsize) + if (superlen < 0.0_DP) cycle + + lambda = dN(l) * Area + if (lambda == 0.0_DP) cycle + k = util_poisson(lambda) + maxgcratkm = 0.0 + do m = 1, k + + ! generate random crater on the superdomain + ! Set up size of crater and ejecta blanket + crater%frad = radius + crater%rad = radius + crater%continuous = 2.348_DP * crater%frad**(1.006_DP) + crater%ejdis = DISEJB * crater%continuous + inc = nint(min(crater%ejdis / user%pix, crater%frad * DISEJB / user%pix)) + 1 + + ! find the x and y position of the crater + ! When a superdomain crater's center is at the edge of a space that + ! superlen defines, it has least ejecta delivering to the local domain. + ! Soften_size should be the maximum ray extennt (beyond visible rays) + ! to account for cold and hot ejecta. + ! Note for age data: new stream lines overlapped with melts needs to + ! calculate here, and one can check out regolith_streamtube: lines 251 - 292. + call random_number(rn) + crater%xl = real(superlen * (2 * rn(1) - 1.0_DP), kind=SP) + crater%yl = real(superlen * (2 * rn(2) - 1.0_DP), kind=SP) + + ! Superdoamin crater can be from any of four quardants that is space defined by + ! superlen. + if (crater%xl > 0.0_SP) then + crater%xl = crater%xl + user%pix * user%gridsize + else + crater%xl = crater%xl - user%pix * user%gridsize + end if + if (crater%yl > 0.0_SP) then + crater%yl = crater%yl + user%pix * user%gridsize + else + crater%yl = crater%yl - user%pix * user%gridsize + end if + + crater%xlpx = nint(crater%xl / user%pix) + crater%ylpx = nint(crater%yl / user%pix) + + ! Define the pixel space in the local domain coordinate. + xi = 1 - crater%xlpx + xf = user%gridsize - crater%xlpx + yi = 1 - crater%ylpx + yf = user%gridsize - crater%ylpx + + lradif(1) = sqrt( (xi * user%pix) **2 + (yi * user%pix)**2 ) + lradif(2) = sqrt( (xi * user%pix) **2 + (yf * user%pix)**2 ) + lradif(3) = sqrt( (xf * user%pix) **2 + (yi * user%pix)**2 ) + lradif(4) = sqrt( (xf * user%pix) **2 + (yf * user%pix)**2 ) + lrad = minval(lradif) + if (lrad > crater%ejdis) cycle + + allocate(ejdistribution(xi:xf,yi:yf)) + allocate(ejisray(xi:xf,yi:yf)) + ! Now generate ray pattern + call ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,ejdistribution) + ! Now if doregotrack is on, do melt zone calculation + if (user%doregotrack) call regolith_melt_zone_superdomain(user,crater,domain,rm,depthb) + + do j = yi,yf + do i = xi,xf + ! Ejecta ray distribution + if (ejdistribution(i,j) > 0.0001_DP) then + ejisray(i,j) = 1 + else + ejisray(i,j) = 0 + end if + end do + end do + + if (user%doregotrack) then + do j = 1, user%gridsize + do i = 1, user%gridsize + xpi = i - crater%xlpx + ypi = j - crater%ylpx + if ((abs(xpi) > inc) .or. (abs(ypi) > inc)) cycle + if (ejisray(xpi,ypi) == 0) cycle + call regolith_superdomain(user,crater,domain,surf(i,j)%regolayer,ejdistribution(xpi,ypi),& + i,j,age,age_resolution,rm,depthb) + end do + end do + + end if + + if (user%dosoftening .and. present(kdiff)) then + do j = 1, user%gridsize + do i = 1, user%gridsize + xpi = i - crater%xlpx + ypi = j - crater%ylpx + if ((abs(xpi) > inc) .or. (abs(ypi) > inc)) cycle + if (ejisray(xpi,ypi) == 0) cycle + kdiff(i,j) = kdiff(i,j) + rayfrac * user%soften_factor / (PI * & + user%soften_size**2) * crater%frad**(user%soften_slope - 2.0_DP) + end do + end do + end if + + deallocate(ejdistribution,ejisray) + + end do + + end do + + return +end subroutine crater_superdomain + diff --git a/src/crater/crater_tally_observed.f90 b/src/crater/crater_tally_observed.f90 index af8211eb..97acd465 100644 --- a/src/crater/crater_tally_observed.f90 +++ b/src/crater/crater_tally_observed.f90 @@ -88,7 +88,7 @@ subroutine crater_tally_observed(user,surf,domain,nkilled,onum,obsdist,obslist,o allocate(mlist(max(mnum,1))) - allocate(mposlist(3,max(mnum,1))) + allocate(mposlist(2,max(mnum,1))) allocate(mpxlist(2,max(mnum,1))) allocate(mlayerlist(max(mnum,1))) allocate(ind(max(mnum,1))) @@ -111,7 +111,6 @@ subroutine crater_tally_observed(user,surf,domain,nkilled,onum,obsdist,obslist,o ! Save the crater center coordinates mposlist(1,imnum) = surf(m,n)%xl(layer) mposlist(2,imnum) = surf(m,n)%yl(layer) - mposlist(3,imnum) = surf(m,n)%timestamp(layer) ! Save the pixel index location mpxlist(1,imnum) = m mpxlist(2,imnum) = n @@ -144,7 +143,7 @@ subroutine crater_tally_observed(user,surf,domain,nkilled,onum,obsdist,obslist,o iend(tnum) = mnum allocate(totpix(tnum)) - allocate(poslist(3,tnum)) + allocate(poslist(2,tnum)) allocate(tlist(tnum)) allocate(tmp_depthdiam(tnum)) allocate(countable(tnum)) @@ -201,14 +200,11 @@ subroutine crater_tally_observed(user,surf,domain,nkilled,onum,obsdist,obslist,o bowl = bowl / nbowl outer = outer / nouter tmp_depthdiam(craternum) = (rim - bowl) / crater%fcrat - - !if (crater%fcrat < 20e3_DP) then - ! dd = DDCUTOFF - !else - ! dd = DDCUTOFF - (crater%fcrat - 20e3_DP) * 2e-7 - !end if - dd = min(DDCUTOFF, 24.897 * crater%fcrat ** (-0.632545)) - + if (crater%fcrat < 20e3_DP) then + dd = DDCUTOFF + else + dd = DDCUTOFF - (crater%fcrat - 20e3_DP) * 2e-7 + end if if (((tmp_depthdiam(craternum) > dd).and.((outer - rim) / crater%fcrat < OCUTOFF)).and.& (nrim /= 0).and.(nbowl /= 0).and.(nouter /= 0)) then countable(craternum) = .true. @@ -243,7 +239,7 @@ subroutine crater_tally_observed(user,surf,domain,nkilled,onum,obsdist,obslist,o if (present(obsdist)) then allocate(depthdiam(onum)) allocate(obslist(onum)) - allocate(oposlist(3,onum)) + allocate(oposlist(2,onum)) ! Reset all the distribution bins do i=1,domain%distl obsdist(1,i) = 1e3_DP*SQRT2**(domain%plo+(i-1)) diff --git a/src/crater/module_crater.f90 b/src/crater/module_crater.f90 index 4408fa5e..fa221ebe 100644 --- a/src/crater/module_crater.f90 +++ b/src/crater/module_crater.f90 @@ -110,13 +110,13 @@ end subroutine crater_emplace end interface interface - subroutine crater_form_interior(user,surfi,crater,x_relative, y_relative, newelev,deltaMi) + subroutine crater_form_interior(user,surfi,crater,lradsq,newelev,deltaMi) use module_globals implicit none type(usertype),intent(in) :: user type(surftype),intent(inout) :: surfi type(cratertype),intent(in) :: crater - real(DP),intent(in) :: x_relative, y_relative + real(DP),intent(in) :: lradsq real(DP),intent(in) :: newelev real(DP),intent(out) :: deltaMi end subroutine crater_form_interior @@ -264,4 +264,18 @@ function crater_critical_slope(user,crater,lrad) result(critical) end function crater_critical_slope end interface + interface + subroutine crater_superdomain(user,surf,age,age_resolution,prod,nflux,domain,finterval,kdiff) + use module_globals + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(inout) :: surf + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),dimension(:,:),intent(in) :: prod,nflux + type(domaintype),intent(in) :: domain + real(DP),intent(in) :: finterval + real(DP),dimension(:,:),intent(inout),optional :: kdiff + end subroutine crater_superdomain + end interface + end module diff --git a/src/ejecta/ejecta_blanket.f90 b/src/ejecta/ejecta_blanket.f90 index 8776fc1d..232e1ebc 100644 --- a/src/ejecta/ejecta_blanket.f90 +++ b/src/ejecta/ejecta_blanket.f90 @@ -76,10 +76,10 @@ subroutine ejecta_blanket(user,crater,domain,erad,lrad,vejsq,ejang,firstrun) vej1sq = max(ce1sq * abs(user%gaccel * crater%grad) * (crater%grad / erad)**p,0._DP) gterm = ce1sq * (user%gaccel * erad) vejsq = max(vej1sq - gterm - yterm,0._DP) - !if (vejsq >= domain%vescsq) then - ! lrad = VBIG - ! return - !end if + if (vejsq >= domain%vescsq) then + lrad = VBIG + return + end if ! Ejection angle ejang=DEG2RAD * (55._DP - 20 * (erad / crater%grad)) @@ -93,7 +93,7 @@ subroutine ejecta_blanket(user,crater,domain,erad,lrad,vejsq,ejang,firstrun) ! lrad = erad + Psi * user%trad ! flat plane landing distance calculation - lrad = erad + vejsq * sin(2 * ejang) / user%gaccel + lrad = erad + vejsq*sin(2*ejang)/user%gaccel return end subroutine ejecta_blanket diff --git a/src/ejecta/ejecta_distance_estimate.f90 b/src/ejecta/ejecta_distance_estimate.f90 index 6df703d1..5e2794bf 100644 --- a/src/ejecta/ejecta_distance_estimate.f90 +++ b/src/ejecta/ejecta_distance_estimate.f90 @@ -61,7 +61,9 @@ subroutine ejecta_distance_estimate(user,crater,domain,ejdis_estimate) ! Extrapolate in logspace out to the minimum thickness slope = log(lrad2 / lrad1) / log(thick2 / thick1) ejdis_estimate = exp(slope * log(domain%small / thick1) + log(lrad1)) - ejdis_estimate = min(ejdis_estimate, crater%frad * user%ejecta_truncation) + if (.not.user%discontinuous) then + ejdis_estimate = min(ejdis_estimate, 2.3_DP * crater%frad**(1.006_DP)) + end if return end subroutine ejecta_distance_estimate diff --git a/src/ejecta/ejecta_emplace.f90 b/src/ejecta/ejecta_emplace.f90 index 16c4a9c1..7e0c63a6 100644 --- a/src/ejecta/ejecta_emplace.f90 +++ b/src/ejecta/ejecta_emplace.f90 @@ -75,7 +75,7 @@ ! The cutoff of ejecta thickness is still buggy. ! !********************************************************************************************************************************** -subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) +subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,ejbmass,age,age_resolution) use module_globals use module_util use module_io @@ -91,36 +91,62 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) type(domaintype),intent(in) :: domain integer(I4B),intent(in) :: ejtble type(ejbtype),dimension(ejtble),intent(in) :: ejb - real(DP),intent(in) :: deltaMtot + real(DP),intent(out) :: ejbmass + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution ! Internal variables - real(DP) :: lrad,lradsq,cdepth - integer(I4B),parameter :: MAXLOOP = 100 ! Maximum number of times to loop the ejecta angle correction calculation - integer(I4B) :: xpi,ypi,i,j,k,n,inc,incsq,iradsq,idistorted,jdistorted - real(DP) :: xp,yp,fradsq,fradpxsq,radsq,ebh,ejdissq,ejbmass,fmasscons,areafrac,xbar,ybar,krad,kdiffmax - real(DP),dimension(:,:),allocatable :: cumulative_elchange,big_cumulative_elchange,kdiff,big_kdiff,cel,big_cel + real(DP) :: lrad,lrad0,lradsq,cdepth,distance,erad,craterslope,baseline,inneredge,outeredge + integer(I4B),parameter :: MAXLOOP = 10 ! Maximum number of times to loop the ejecta angle correction calculation + integer(I4B) :: xpi,ypi,i,j,k,n,inc,incsq,iradsq + real(DP) :: xp,yp,fradsq,radsq,ebh,ejdissq,continuous + real(DP),dimension(:,:),allocatable :: cumulative_elchange,big_cumulative_elchange integer(I4B),dimension(:,:,:),allocatable :: indarray,big_indarray - real(DP),dimension(:,:),allocatable :: ejdistribution,diffdistribution - integer(I4B) :: bigi,bigj,maxhits,nin,nnot,dradsq + integer(I4B) :: bigi,bigj character(len=MESSAGESIZE) :: message ! message for the progress bar - - - ! Ray mixing model variables - real(DP) :: dsc + !Ray model parameters and variables by Gielis superformula + integer(I4B) :: nrays + real(DP),dimension(15) :: rn + real(DP) :: theta, lradp + real(DP), parameter :: n1 = 4.0_DP + real(DP) :: n2, mag + ! Ray Mass conservation + real(DP), parameter :: a = 16.8799 !a = 11.8126 ! Fitting parameters for a relation between ray length and radius of crater + real(DP), parameter :: b = 0.120621 !0.143 ! based on Jake's crater rays mapping studies! + real(DP) :: mvrld ! median value of ray length distribution + real(DP) :: mvrldsc ! median value of ray length distribution scaled by continuous ejecta extent + + ! Enhanced factor test + real(DP) :: xef, yef, thetamax + integer(I4B) :: xefpi, yefpi, nef, ray_pix + integer(I4B), dimension(:), allocatable :: sf, tot + real(DP), dimension(:), allocatable :: ef + + ! Flowery ray variables + integer(I4B) :: nfrays + real(DP) :: n1f, n2f, magf, lradf, rayf + ! Ray mixing model parameters: + real(DP) :: h_raymix ! Ray mixing depth: l = 0.5755 * (D_sc)^-0.3136 * R_p^1.25, D_sc = 8 * h + ! h = 0.021 * l^-3.188 * R_p^3.985 in unit of kilometers + real(DP) :: h_raymixratio ! Ray mixing ratio: h / L = h / (0.1 R_p^0.74 * (l/R_p)^-4.37 + ! h/L = 0.2137 * R_p^0.052 * (l/R_p)^1.182 + real(DP), parameter :: k_raymixratio = 0.171726_DP !1.7172_DP + real(DP), parameter :: b_lrad1 = -3.188_DP !1.181_DP + real(DP), parameter :: b_frad1 = 0.79719_DP !0.057_DP + real(DP), parameter :: SCD = 0.125_DP + real(DP) :: vsq, ejtheta, melt, vol_sc, dsc, dsc1, gterm, yterm ! Melt zone's radius - real(DP) :: rm, dm, melt, eradc - - ! Ejecta pattern distortion parameters - real(DP) :: distance,erad,craterslope,landslope,baseline,lrange,frac,ejheight,ebh0,maxdistance - real(DP) :: maxslp - real(DP) :: vsq, ejtheta - integer(I4B) :: ind,klo + real(DP) :: rm, dm + ! Age + real(SP) :: age_mean + + call regolith_melt_zone(user,crater,crater%imp,crater%impvel,rm,dm) + !write(*,*) age, crater%imp, crater%frad, rm + ! Executable code - !call regolith_melt_zone(user,crater,crater%imp,crater%impvel,rm,dm) - cdepth = DDRATIO * crater%fcrat crater%vdepth = crater%ejrim + cdepth crater%vrim = crater%ejrim + crater%rheight @@ -128,62 +154,121 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) if (crater%ejdis <= crater%rad) return ! determine area to effect - inc = max(min(nint(min(PI * user%trad / user%pix, min(crater%ejdis, crater%frad * user%ejecta_truncation / user%pix))) + 1, & - user%gridsize - nint(crater%continuous / user%pix)),1) - maxdistance = inc * user%pix - - ! Increase the box a bit to take into account possible ejecta pattern distortion due to topography - inc = ceiling(inc * 1.5_DP) - - if (user%dosoftening) then - krad = user%ejecta_truncation * crater%frad - kdiffmax = user%Kd1 * crater%frad**(user%psi) - dradsq = int(krad / user%pix) + 3 - inc = max(inc,dradsq) - dradsq = dradsq**2 - end if - + inc = max(min(crater%ejdispx + 1,PBCLIM*user%gridsize),1) crater%maxinc = max(crater%maxinc,inc) radsq = crater%rad**2 - fradsq = crater%frad**2 - fradpxsq = crater%fradpx**2 - ejdissq = crater%ejdis**2 - incsq = inc**2 + ejdissq = crater%ejdis**2 if (inc >= user%gridsize / 2) then - if (user%testflag) then - write(*,*) 'Big ejecta: fcrat =',crater%fcrat, ' Ej/S =',(crater%ejdispx*user%pix)/domain%side, ' Ejrim =', crater%ejrim - else - write(message,'("Ejb: Dc=",ES9.2," Ej/S=",F0.3)') crater%fcrat,(crater%ejdispx*user%pix)/domain%side - call io_updatePbar(message) - end if + !if (user%testflag) then + ! write(*,*) 'Big ejecta: fcrat =',crater%fcrat, ' Ej/S =',(crater%ejdispx*user%pix)/domain%side, ' Ejrim =', crater%ejrim + ! else + ! write(message,'("Ejb: Dc=",ES9.2," Ej/S=",F0.3)') crater%fcrat,(crater%ejdispx*user%pix)/domain%side + ! call io_updatePbar(message) + ! end if endif allocate(cumulative_elchange(-inc:inc,-inc:inc)) - allocate(cel(-inc:inc,-inc:inc)) - allocate(kdiff(-inc:inc,-inc:inc)) allocate(indarray(2,-inc:inc,-inc:inc)) - allocate(ejdistribution(-inc:inc,-inc:inc)) - allocate(diffdistribution(-inc:inc,-inc:inc)) - cumulative_elchange = 0.0_DP - kdiff = 0.0_DP - indarray = inc - 1 ! initialize this array to point to a corner (this should have 0 elevation change since we're only doing work + call random_number(rn) + cumulative_elchange = 0._DP + indarray = inc ! initialize this array to point to a corner (this should have 0 elevation change since we're only doing work ! within a circle of radius irad ! *************************** Continuous Ejecta Formula *****************************! - call ejecta_ray_pattern(user,surf,crater,inc,-inc,inc,-inc,inc,diffdistribution,ejdistribution) + continuous = 2.3_DP * crater%frad**(1.006_DP) + + ! *************************** Superformula Ray Model ************************************! + ! *************************** Part I. Spoke and Skinny Ray Model ************************************! + ! From fitting Jake Elliot's ray mapping data, it is a linear function that describes the relationship between the median value of ray length + ! distribution and the radius of rayed craters (in unit of kilometers) + ! Also, we need to scale it with the continuous ejecta's extent for ray model +!# mvrld = a * (crater%frad/1000.0)**(b) +!# mvrldsc = mvrld / (continuous/crater%frad) + ! It appears that no strong correlation between the number of rays and size of craters. + ! The average number of rays is about 10. The minimum and maximum number is 6 and 14 respectively. + + ! Determine parameters of Ray model based on Gielis's superformula + ! There are three parameters regarding to our desired ray shape: n1, n2, m + ! m: the repeating part of formula, and it controls the number of rays (arms). + ! n1: the default value is set as 4.0 in our rays case + ! n2: n2 and n1 combining together is to control the slenderness of a ray, in general, n1/n2 is always smaller than 1 in our cases. + ! The smaller the ratio, the skinnier a ray. + + nrays = nint(8 * rn(15)) + 6 + mvrld = crater%ejdis + mvrldsc = mvrld / continuous + n2 = 8.0_DP * ( log10(mvrldsc) / log10(2.0_DP) ) + 2.0_DP + + ! *************************** Part II. Flowery Ray Model ************************************! + nfrays = 20 + n1f = 1.0_DP + n2f = 0.5_DP + rayf = 5.0_DP + + ! Enhanced factor test: Build a enhanced factor quick lookup table + ! Use a circular sector with an angle containing a half ray, which is pi/nrays. First, we determine the looping area for + ! this sector, then the look-up table will be built while looping over each pixel and then making it to go to the right bin. + ! The size of bin is one pixel. + xef = mvrld + thetamax = PI/dble(nrays) + yef = mvrld * sin(thetamax) + xefpi = nint(xef / user%pix) + yefpi = nint(yef / user%pix) + nef = ceiling( mvrld / user%pix) + allocate(sf(nef)) + allocate(tot(nef)) + allocate(ef(nef)) + tot = 0 + sf = 0 + + do j = yefpi, 0, -1 + do i = xefpi, 0, -1 + xp = (i + crater%xlpx) * user%pix + yp = (j + crater%ylpx) * user%pix + lradsq = (xp - crater%xl)**2 + (yp - crater%yl)**2 + lrad = sqrt(lradsq) + ! inside or outside a ray? + theta = atan2(j * 1._DP,i * 1._DP) + mag = ( (abs(cos(nrays * theta / 4.0_DP)))**n2 + (abs(sin(nrays * theta / 4.0_DP)))**n2 )**(-1.0_DP/n1) !& + + magf = rayf * ( (abs(cos(nfrays * theta / 4.0_DP)))**n2f + (abs(sin(nfrays * theta / 4.0_DP)))**n2f )**(-1.0_DP/n1f) + lradp = crater%frad * mag + lradf = crater%frad * magf + lradp = max(lradp, lradf) + if (lrad >= crater%rad .and. lrad < mvrld .and. theta < thetamax .and. theta>0._DP) then + ray_pix = ceiling( (lrad - crater%rad) / user%pix) + tot(ray_pix) = tot(ray_pix) + 1 + if (lrad < lradp) sf(ray_pix) = sf(ray_pix) + 1 + end if + end do + end do - ejbmass = 0.0_DP - nin = 0 - nnot = 0 + ! Smooth out the enhanced factor lookup table + do i=1,nef + ef(i) = max( dble(tot(i)) / dble(sf(i)), 1.0_DP) + end do - !!$OMP PARALLEL DO DEFAULT(PRIVATE) IF(inc > INCPAR) & - !!$OMP SHARED(user,domain,crater,surf,ejb,ejtble) & - !!$OMP SHARED(inc,incsq) & - !!$OMP SHARED(cumulative_elchange,kdiff,kdiffmax,indarray,ejdistribution,diffdistribution) + do i=1,nef + if (ef(i) /= ef(i) .or. ef(i) > VBIG) then + ef(i) = dble(tot(i)) / 1.0 + end if + end do + + deallocate(sf) + deallocate(tot) + outeredge = crater%frad + domain%ejbres * (EJBTABSIZE - 0.5_DP) + inneredge = crater%frad + 0.5_DP * domain%ejbres + + ejbmass = 0.0_DP +! !$OMP PARALLEL DO DEFAULT(PRIVATE) IF(inc > INCPAR) & +! !$OMP SHARED(user,domain,crater,surf,ejb,ejtble,mvrld,mvrldsc,nrays,n2,nef,ef,n2f,n1f,nfrays,rayf) & +! !$OMP SHARED(inc,incsq,ejdissq,fradsq,radsq,indarray,cumulative_elchange,rn,continuous) +! !$OMP REDUCTION(+:massray,massej,massrayef) do j = -inc,inc do i = -inc,inc + ! find distance from crater center iradsq = i*i + j*j xpi = crater%xlpx + i @@ -192,121 +277,63 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) ! Find distance from crater center to current pixel center in real space xp = xpi * user%pix yp = ypi * user%pix - + ! periodic boundary conditions call util_periodic(xpi,ypi,user%gridsize) indarray(1,i,j) = xpi indarray(2,i,j) = ypi - lradsq = (crater%xl - xp)**2 + (crater%yl - yp)**2 - lrad = sqrt(lradsq) - - ! Estimate ejecta pattern distortion due to target surface angle and topography - ! This must be done iteratively because the ejection distance and ejection angle vary - distance = lrad - maxslp = -huge(maxslp) - klo = int((log(lrad) - log(crater%rad)) / domain%ejbres) + ! Find angle-corrected landing distance + distance = sqrt((crater%xl - xp)**2 + (crater%yl - yp)**2) + baseline = crater%melev + ((i * crater%xslp) + (j * crater%yslp)) * user%pix - surf(xpi,ypi)%dem + craterslope = atan(baseline / distance) + lrad = distance + lrad0 = lrad do n = 1,MAXLOOP - call ejecta_interpolate(crater,domain,distance,ejb,ejtble,ebh,vsq=vsq,theta=ejtheta,erad=erad,melt=melt) - if ((n > 1).and.((abs(ebh0 - ebh) / ebh0) < domain%small)) exit - ebh0 = ebh + k = max(min(1 + int((lrad - inneredge) / (outeredge - inneredge) * (EJBTABSIZE - 1.0_DP)),ejtble),1) + call ejecta_interpolate(crater,domain,lrad,ejb,ejtble,ebh,vsq=vsq,theta=ejtheta,erad=erad) + lrad = distance * (erad + sqrt(vsq) * sin(2*ejtheta)) / (erad + sqrt(vsq) * (sin(2 * (ejtheta + craterslope)))) + if (abs(lrad - lrad0) < domain%small) exit + lrad0 = lrad + end do + lradsq = lrad**2 + + + if ((lradsq <= ejdissq) .and. (lradsq >= radsq) .and. (lrad > 0.0_DP)) then + theta = atan2(j * 1._DP,i * 1._DP) + 2.0_DP * PI + mag = ( ( (abs(cos(nrays * theta / 4.0_DP)))**n2 + & + (abs(sin(nrays * theta / 4.0_DP)))**n2 )**(-1.0_DP/n1) ) + magf = rayf * ( ( (abs(cos(nfrays * theta / 4.0_DP)))**n2f + & + (abs(sin(nfrays * theta / 4.0_DP)))**n2f )**(-1.0_DP/n1f)) + lradp = crater%frad * mag + lradf = crater%frad * magf + lradp = max(lradp, lradf) - erad = exp(erad) - lrange = lrad - erad - - baseline = ((i * crater%xslp) + (j * crater%yslp)) * user%pix - craterslope = atan(baseline / lrad) - if (craterslope > maxslp) maxslp = craterslope - - ejheight = erad * sin(craterslope) + crater%melev - - landslope = atan((surf(xpi,ypi)%dem - ejheight) / lrange) - - ! Calculate corrected landing velocity for this location - vsq = (lrange * user%gaccel * cos(craterslope)) / & - (sin(2 * ejtheta + 2 * craterslope - landslope) - sin(landslope)) - if (vsq < 0.0_DP) exit - - ! Find out where in the table this new velocity corresponds to - ind = 1 - call util_search(ejb%vesq,ind,ejtble,vsq,klo) - klo = min(max(klo,1),ejtble-1) - ! Interpolate on the table to find the flat plane equivalent landing distance for this velocity - frac = (vsq - ejb(klo)%vesq) / (ejb(klo+1)%vesq - ejb(klo)%vesq) - distance = exp(ejb(klo)%lrad) + frac * (exp(ejb(klo+1)%lrad) - exp(ejb(klo)%lrad)) - end do - - if (vsq < 0.0_DP) cycle - if (distance /= distance) cycle - idistorted = int(i * distance / lrad) - if (abs(idistorted) > inc) cycle - jdistorted = int(j * distance / lrad) - if (abs(jdistorted) > inc) cycle - - iradsq = idistorted**2 + jdistorted**2 - if ((iradsq > incsq).or.(distance <= crater%rad)) cycle - - ! we need to cut a hole out from the inside of the crater - xbar = xpi * user%pix - crater%xl - ybar = ypi * user%pix - crater%yl - - areafrac = (1.0_DP - util_area_intersection(crater%rad,xbar,ybar,user%pix)) - - ebh = areafrac * ejdistribution(idistorted,jdistorted) * ebh - cumulative_elchange(i,j) = areafrac * cumulative_elchange(i,j) + ebh - - if (user%dosoftening) then - ! Do extra diffusive degradation over ejecta region - areafrac = (1.0_DP - util_area_intersection(crater%frad,xbar,ybar,user%pix)) - kdiff(i,j) = areafrac * diffdistribution(idistorted,jdistorted) * kdiffmax - end if - - !if (user%doregotrack .and. ebh>1.0e-8_DP) then - ! call regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,rm) - !end if - - + if (lrad < lradp) then + call ejecta_interpolate(crater,domain,lrad,ejb,ejtble,ebh,vsq=vsq,theta=ejtheta,melt=melt) + ray_pix = ceiling((lrad - crater%rad) / user%pix) + ebh = ebh * ef(ray_pix) + if (user%doregotrack .and. ebh>1.0e-8) then + call regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,rm,vsq,age,age_resolution) + end if + else + ebh = 0._DP + end if + + cumulative_elchange(i,j) = cumulative_elchange(i,j) + ebh + ejbmass = ejbmass + ebh + end if + end do end do - !!$OMP END PARALLEL DO - ejbmass = sum(cumulative_elchange) - - ! Create buffer to prevent infinite hole bug - kdiff(-inc,:) = 0.0_DP - kdiff(inc,:) = 0.0_DP - kdiff(:,-inc) = 0.0_DP - kdiff(:,inc) = 0.0_DP - - cumulative_elchange(-inc,:) = 0.0_DP - cumulative_elchange(inc,:) = 0.0_DP - cumulative_elchange(:,-inc) = 0.0_DP - cumulative_elchange(:,inc) = 0.0_DP - - ! Do mass conservation by adjusting ejecta thickness - fmasscons = (-deltaMtot)/ ejbmass - cumulative_elchange = cumulative_elchange * fmasscons - maxhits = 1 +! !$OMP END PARALLEL DO + deallocate(ef) + ! Create box for soften calculation (will be no bigger than the grid itself) if (2 * inc + 1 < user%gridsize) then - - ! extra soften calculation - if (user%dosoftening) then - cel = 0.0_DP - call util_diffusion_solver(user,surf,2 * inc + 1,indarray,kdiff,cel,maxhits) - do j = -inc,inc - do i = -inc,inc - xpi = indarray(1,i,j) - ypi = indarray(2,i,j) - surf(xpi,ypi)%dem = surf(xpi,ypi)%dem + cel(i,j) - surf(xpi,ypi)%ejcov = max(surf(xpi,ypi)%ejcov + cel(i,j),0.0_DP) - end do - end do - end if - call ejecta_soften(user,surf,2 * inc + 1,indarray,cumulative_elchange) - ! Add the ejecta back to the DEM do j = -inc,inc do i = -inc,inc @@ -316,15 +343,10 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) surf(xpi,ypi)%ejcov = max(surf(xpi,ypi)%ejcov + cumulative_elchange(i,j), 0.0_DP) end do end do - - else ! Ejecta wraps around the grid. ! We will therefore send in the whole grid with the total ejecta thickness added to each pixel allocate(big_cumulative_elchange(0:user%gridsize+1,0:user%gridsize+1)) - allocate(big_cel(0:user%gridsize+1,0:user%gridsize+1)) allocate(big_indarray(2,0:user%gridsize+1,0:user%gridsize+1)) - allocate(big_kdiff(0:user%gridsize+1,0:user%gridsize+1)) - do bigj = 0,user%gridsize + 1 do bigi = 0,user%gridsize + 1 xpi = bigi @@ -336,44 +358,26 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) end do end do - big_kdiff = 0.0_DP - do j = -inc,inc do i = -inc,inc xpi = indarray(1,i,j) ypi = indarray(2,i,j) big_cumulative_elchange(xpi,ypi) = big_cumulative_elchange(xpi,ypi) + cumulative_elchange(i,j) - big_kdiff(xpi,ypi) = big_kdiff(xpi,ypi) + kdiff(i,j) end do end do - - if (user%dosoftening) then - big_cel = 0.0_DP - call util_diffusion_solver(user,surf,user%gridsize + 2,big_indarray,big_kdiff,big_cel,maxhits) - - do j = 1,user%gridsize - do i = 1,user%gridsize - surf(i,j)%dem = surf(i,j)%dem + big_cel(i,j) - surf(i,j)%ejcov = max(surf(i,j)%ejcov + big_cel(i,j),0.0_DP) - end do - end do - end if - call ejecta_soften(user,surf,user%gridsize + 2,big_indarray,big_cumulative_elchange) - do i = 1,user%gridsize do j = 1,user%gridsize surf(i,j)%dem = surf(i,j)%dem + big_cumulative_elchange(i,j) surf(i,j)%ejcov = max(surf(i,j)%ejcov + big_cumulative_elchange(i,j),0.0_DP) end do end do - - deallocate(big_cumulative_elchange,big_indarray,big_kdiff,big_cel) + deallocate(big_cumulative_elchange,big_indarray) end if !if (user%doregotrack) call regolith_rays(user,crater,domain,ejtble,ejb) - deallocate(cumulative_elchange,indarray,diffdistribution,ejdistribution,kdiff,cel) + deallocate(cumulative_elchange,indarray) return end subroutine ejecta_emplace diff --git a/src/ejecta/ejecta_interpolate.f90 b/src/ejecta/ejecta_interpolate.f90 index a8ba7931..79c15e86 100644 --- a/src/ejecta/ejecta_interpolate.f90 +++ b/src/ejecta/ejecta_interpolate.f90 @@ -39,9 +39,9 @@ subroutine ejecta_interpolate(crater,domain,lrad,ejb,ejtble,ebh,vsq,theta,erad,m ! Executable code ! Locate ourselves in the table - inneredge = crater%rad - outeredge = crater%rad * exp(domain%ejbres * EJBTABSIZE) - k = max(min(1 + int((log(lrad) - log(inneredge)) / (log(outeredge) - log(inneredge)) * (EJBTABSIZE - 1.0_DP)),ejtble),1) + outeredge = crater%frad + domain%ejbres * (EJBTABSIZE - 0.5_DP) + inneredge = crater%frad + 0.5_DP * domain%ejbres + k = max(min(1 + int((lrad - inneredge) / (outeredge - inneredge) * (EJBTABSIZE - 1.0_DP)),ejtble),1) loglrad = log(lrad) logtablerad = ejb(k)%lrad diff --git a/src/ejecta/ejecta_ray_pattern.f90 b/src/ejecta/ejecta_ray_pattern.f90 old mode 100644 new mode 100755 index 32982add..03dfaa39 --- a/src/ejecta/ejecta_ray_pattern.f90 +++ b/src/ejecta/ejecta_ray_pattern.f90 @@ -1,375 +1,208 @@ -!****f* ejecta/ejecta_ray_pattern -! Name -! ejecta_ray_pattern -- Calculate ejecta ray pattern -! SYNOPSIS -! This uses -! * module_globals -! * module_util -! * module_io -! * module_crater -! * module_regolith -! * module_ejecta -! -! call ejecta_ray_pattern(user,surf,crater,inc,ejdistribution) -! -! DESCRIPTION -! -! Models the discontinuous ray pattern based on the Superformula. -! Citation: Gielis, J. "A Generic Geometric Transformation that Unifies a Wide Range of Natural -! and Abstract Shapes." Amer. J. Botany 90, 333-338, 2003. -! -! ARGUMENTS -! Input -! * user -- User input parameters -! * surf -- Surface ggrid -! * crater -- Crater dimension container -! * domain -- Simulation domain variable container -! -! Output -! * ejdist -- logical array containing the pixels that contain ejecta -! -!*** - -!********************************************************************************************************************************** -subroutine ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,diffdistribution,ejdistribution) - use module_globals - use module_util - use module_io - use module_crater - use module_regolith - use module_ejecta, EXCEPT_THIS_ONE => ejecta_ray_pattern - implicit none - - ! Arguments - type(usertype),intent(in) :: user - type(surftype),dimension(:,:),intent(in) :: surf - type(cratertype),intent(inout) :: crater - integer(I4B),intent(in) :: inc,xi,xf,yi,yf - real(DP),dimension(xi:xf,yi:yf),intent(out) :: diffdistribution - real(DP),dimension(xi:xf,yi:yf),intent(out) :: ejdistribution - - ! Internal variables - integer(I4B) :: nrays,i,j,k,n,nef,incsq,iradsq,xpi,ypi,ejpxsq - real(DP) :: frac,mef,lrad,lradsq,xp,yp,binres,areafrac,xbar,ybar - real(DP) :: rn - real(DP) :: theta, lradp, maxdistance - real(DP), parameter :: n1 = 4.0_DP - real(DP) :: n2, mag - real(DP),dimension(xi:xf,yi:yf) :: isray - real(DP),dimension(:),allocatable :: numinray,totnum - real(DP),dimension(:),allocatable :: mefarray - - - real(DP) :: C1,C2,p ! Fits to fe vs fd equation for the new ray pattern - real(DP) :: rmin,rmax,r - - ! Flowery ray variables - integer(I4B) :: nfrays - real(DP) :: n1f, n2f, magf, lradf, rayf,rayavg - real(DP), parameter :: a = 16.8799 !a = 11.8126 ! Fitting parameters for a relation between ray length and radius of crater - real(DP), parameter :: b = 0.120621 !0.143 ! based on Jake's crater rays mapping studies! - real(DP) :: mvrld ! median value of ray length distribution - real(DP) :: mvrldsc ! median value of ray length distribution scaled by continuous ejecta ext/allent - logical :: ej - real(DP),dimension(Nraymax) :: thetari - - !TEMPORARY - - if (user%dorays) then - do i = 1,Nraymax - thetari(i) = 2 * pi * i / Nraymax - end do - call shuffle(thetari) ! randomize the ray pattern - - call random_number(rn) ! randomize the ray orientation - rmax = user%ejecta_truncation - rmin = crater%continuous / crater%frad - crater%fe = 10.0_DP ! Estimate the equivalent degradation radius - !ejdistribution = 0.0_DP - !diffdistribution = 0.0_DP - !!$OMP PARALLEL DO DEFAULT(PRIVATE) & - !!$OMP SHARED(user,crater) & - !!$OMP SHARED(xi,xf,yi,yf,rn,diffdistribution,ejdistribution,thetari,rmin) - do j = yi,yf - do i = xi,xf - xpi = crater%xlpx + i - ypi = crater%ylpx + j - - ! Find distance from crater center to current pixel center in real space - xp = xpi * user%pix - yp = ypi * user%pix - - xbar = xp - crater%xl - ybar = yp - crater%yl - - areafrac = util_area_intersection(user%ejecta_truncation * crater%frad,xbar,ybar,user%pix) - r = sqrt(xbar**2 + ybar**2) / crater%frad - theta = mod(atan2(ybar,xbar) + pi + rn * 2 * pi,2 * pi) - diffdistribution(i,j) = areafrac * pattern(theta,r,rmin,rmax,thetari,.false.) - ejdistribution(i,j) = areafrac * pattern(theta,r,rmin,rmax,thetari,.true.) - end do - end do - !!$OMP END PARALLEL DO - - - else - !Do simple circular region - incsq = inc**2 - ejdistribution = 0.0_DP - diffdistribution = 0.0_DP - !$OMP PARALLEL DO DEFAULT(PRIVATE) & - !$OMP SHARED(user,crater) & - !$OMP SHARED(inc,incsq,xi,xf,yi,yf,diffdistribution,ejdistribution) - do j = yi,yf - do i = xi,xf - iradsq = i*i + j*j - - if (iradsq < incsq) then - - xpi = crater%xlpx + i - ypi = crater%ylpx + j - - ! Find distance from crater center to current pixel center in real space - xp = xpi * user%pix - yp = ypi * user%pix - - xbar = xp - crater%xl - ybar = yp - crater%yl - areafrac = util_area_intersection(user%ejecta_truncation * crater%frad,xbar,ybar,user%pix) ! uniform circular - diffdistribution(i,j) = areafrac - ejdistribution(i,j) = areafrac - end if - end do - end do - !$OMP END PARALLEL DO - - end if - return - contains - - pure function ray(theta,thetar,r,n,w) result(ans) - implicit none - real(DP) :: ans - real(DP),intent(in) :: theta,thetar,r,w - integer(I4B),intent(in) :: n - real(DP) :: thetap,thetapp,a,b,c,dtheta - - c = w / r - b = thetar - dtheta = min(2*pi - abs(theta - b),abs(theta - b)) - a = sqrt(2 * pi) / (n * c * erf(pi / (2 *sqrt(2._DP) * c))) - ans = a * exp(-dtheta**2 / (2 * c**2)) - - return - end function ray - - pure function pattern(theta,r,rmin,rmax,thetari,ej) result(ans) - implicit none - real(DP) :: ans - real(DP),intent(in) :: r,rmin,rmax,theta - real(DP),dimension(:),intent(in) :: thetari - logical,intent(in) :: ej - real(DP) :: a,c - real(DP) :: thetar,rw,rw0,rw1 - real(DP) :: f,rtrans,length,rpeak,minray,FF - integer(I4B) :: n,i - - - minray = rmin * 3 - - if (r > rmax) then - ans = 0._DP - else if (r < 1.0_DP) then - if (ej) then - ans = 1.0_DP - else - ans = 0.0_DP - end if - else - rw0 = rmin * pi / Nraymax / 2 - rw1 = 2 * pi / Nraymax - rw = rw0 * (1._DP - (1.0_DP - rw1 / rw0) * exp(1._DP - (r / rmin)**2)) - n = max(min(floor((Nraymax**rayp - (Nraymax**rayp - 1) * log(r/minray) / log(rray/minray))**(1._DP/rayp)),Nraymax),1) ! Exponential decay of ray number with distance - ans = 0._DP - rtrans = r - 1.0_DP - c = rw / r - a = sqrt(2 * pi) / (n * c * erf(pi / (2 *sqrt(2._DP) * c))) - do i = 1,Nraymax - length = minray * exp(log(rray/minray) * ((Nraymax - i + 1)**rayp - 1_DP) / ((Nraymax**rayp - 1))) - rpeak = (length - 1_DP) * 0.5_DP - if (ej) then - FF = 1.0_DP - if (r > length) then - f = 0.0_DP - else - f = a - end if - else - FF = rayfmult * (20 / rmax)**(0.5_DP) * 0.25_DP - f = FF * fpeak * (rtrans / rpeak)**rayq * exp(1._DP / rayq * (1.0_DP - (rtrans / rpeak)**rayq)) - end if - ans = ans + ray(theta,thetari(i),r,n,rw) * f / a - end do - end if - - - end function pattern - - subroutine shuffle(a) - real(DP), intent(inout) :: a(:) - integer :: i, randpos - real(DP) :: r,temp - - do i = size(a), 2, -1 - call random_number(r) - randpos = int(r * i) + 1 - temp = a(randpos) - a(randpos) = a(i) - a(i) = temp - end do - - end subroutine shuffle - - !^^^^^^^^^^^^^^^^^^^^^^^^ - - ! *************************** Superformula Ray Model ************************************! - ! *************************** Part I. Spoke and Skinny Ray Model ************************************! - ! From fitting Jake Elliot's ray mapping data, it is a linear function that describes the relationship between the median value of ray length - ! distribution and the radius of rayed craters (in unit of kilometers) - ! Also, we need to scale it with the continuous ejecta's extent for ray model -!# mvrld = a * (crater%frad/1000.0)**(b) -!# mvrldsc = mvrld / (continuous/crater%frad) - ! It appears that no strong correlation between the number of rays and size of craters. - ! The average number of rays is about 10. The minimum and maximum number is 6 and 14 respectively. - - ! Determine parameters of Ray model based on Gielis's superformula -! ! There are three parameters regarding to our desired ray shape: n1, n2, m - ! m: the repeating part of formula, and it controls the number of rays (arms). - ! n1: the default value is set as 4.0 in our rays case -! ! n2: n2 and n1 combining together is to control the slenderness of a ray, in general, n1/n2 is always smaller than 1 in our cases. -!! ! The smaller the ratio, the skinnier a ray. - -! nrays = nint(8 * rn(1)) + 6 -! mvrld = crater%ejdis -! mvrldsc = mvrld / crater%continuous -! n2 = 8.0_DP * ( log10(mvrldsc/1.5_DP) / log10(2.0_DP) ) + 2.0_DP -! ! *************************** Part II. Flowery Ray Model ************************************! -! nfrays = 20 -! n1f = 1.0_DP -! n2f = 0.5_DP -! rayf = 4.0 !7.5_DP -! -! isray = 0.0_DP -! incsq = inc**2 -! maxdistance = inc * user%pix - - ! Mass enhancement factor array -! ! Don't let the bin resolution get too small for small craters. -! binres = min(10.0_DP,crater%ejdis / 10) * user%pix -! nef = ceiling(crater%ejdis / binres) ! bin size for enhancement factor calculation -! allocate(numinray(nef),totnum(nef),mefarray(nef)) - -! totnum = 0 -! numinray = 0 -! do j = yi,yf -! do i = xi,xf -! iradsq = i*i + j*j - -! xpi = crater%xlpx + i -! ypi = crater%ylpx + j - -! ! Find distance from crater center to current pixel center in real space -! xp = xpi * user%pix -! yp = ypi * user%pix -! -! lradsq = (crater%xl - xp)**2 + (crater%yl - yp)**2 -! lrad = sqrt(lradsq) - -! if ((iradsq > incsq).or.(lrad <= crater%rad)) cycle -! -! ! Sum up the number of pixels in this bin for the mass enhancement calculation -! k = ceiling(lrad / binres) -! totnum(k) = totnum(k) + 1.0_DP - -! ! Ray pattern setup -! ! Take average of five points in the pixel to "feather" the edges of the ray -! rayavg = 0.0_DP -! do n = 1, 5 -! select case(n) -! case(1) -! theta = atan2(j * 1._DP,i * 1._DP) + 2.0_DP * PI -! case(2) -! theta = atan2(j * 1._DP - 0.5_DP,i * 1._DP - 0.5_DP) + 2.0_DP * PI -! lradsq = (crater%xl - xp - 0.5_DP * user%pix)**2 + (crater%yl - yp - 0.5_DP * user%pix)**2 -! lrad = sqrt(lradsq) -! case(3) -! theta = atan2(j * 1._DP - 0.5_DP,i * 1._DP + 0.5_DP) + 2.0_DP * PI -! lradsq = (crater%xl - xp - 0.5_DP * user%pix)**2 + (crater%yl - yp + 0.5_DP * user%pix)**2 -! lrad = sqrt(lradsq) -! case(4) -! theta = atan2(j * 1._DP + 0.5_DP,i * 1._DP + 0.5_DP) + 2.0_DP * PI -! lradsq = (crater%xl - xp + 0.5_DP * user%pix)**2 + (crater%yl - yp + 0.5_DP * user%pix)**2 -! lrad = sqrt(lradsq) -! case(5) -! theta = atan2(j * 1._DP + 0.5_DP,i * 1._DP - 0.5_DP) + 2.0_DP * PI -! lradsq = (crater%xl - xp + 0.5_DP * user%pix)**2 + (crater%yl - yp - 0.5_DP * user%pix)**2 -! lrad = sqrt(lradsq) -! end select -! -! mag = ( ( (abs(cos(nrays * theta / 4.0_DP)))**n2 + & -! (abs(sin(nrays * theta / 4.0_DP)))**n2 )**(-1.0_DP/n1) ) -! magf = rayf * ( ( (abs(cos(nfrays * theta / 4.0_DP)))**n2f + & -! (abs(sin(nfrays * theta / 4.0_DP)))**n2f )**(-1.0_DP/n1f)) -! lradp = crater%frad * mag -! lradf = crater%frad * magf -! lradp = lradp + lradf !max(lradp, lradf) -! -! if ((lrad < maxdistance) .and. (lrad < lradp)) then -! rayavg = rayavg + 1.0_DP -! end if -! end do -! rayavg = rayavg / 5 -! isray(i,j) = rayavg -! numinray(k) = numinray(k) + rayavg -! end do -! end do -! if ((xi /= -inc).or.(xf /= inc).or.(yi /= -inc).or.(yf /= inc)) then -! ejdistribution(xi:xf,yi:yf) = isray(xi:xf,yi:yf) -! else -! do k = 1,nef -! if (numinray(k) == 0) then -! mefarray(k) = 1.0_DP -! else -! mefarray(k) = totnum(k) / numinray(k) -! end if -! end do -! ejdistribution = 1.0_DP - - ! Now calculate the ejecta distribution with mass enhancement factor -! do j = yi,yf -! do i = xi,xf -! ejdistribution(i,j) = 0.0_DP -! iradsq = i*i + j*j -! lrad = sqrt(lradsq) -! if (lrad < crater%continuous) then -! ejdistribution(i,j) = 1.0_DP -! else -! frac = lrad / binres -! k = ceiling(frac) -! ! Interpolate the mass enhancement factor between array points -! if (k > 1) then -! mef = mefarray(k) + (frac - k * 1.0_DP) * (mefarray(k) - mefarray(k - 1)) -! else -! mef = mefarray(k) + (frac - k * 1.0_DP) * (mefarray(k + 1) - mefarray(k)) -! end if -! - ! ejdistribution(i,j) = mef * isray(i,j) - ! end if - ! end do - ! end do - !end if - - !deallocate(numinray,totnum,mefarray) - -end subroutine ejecta_ray_pattern - +!****f* ejecta/ejecta_ray_pattern +! Name +! ejecta_ray_pattern -- Calculate ejecta ray pattern +! SYNOPSIS +! This uses +! * module_globals +! * module_util +! * module_io +! * module_crater +! * module_regolith +! * module_ejecta +! +! call ejecta_ray_pattern(user,surf,crater,inc,ejdistribution) +! +! DESCRIPTION +! +! Models the discontinuous ray pattern based on the Superformula. +! Citation: Gielis, J. "A Generic Geometric Transformation that Unifies a Wide Range of Natural +! and Abstract Shapes." Amer. J. Botany 90, 333-338, 2003. +! +! ARGUMENTS +! Input +! * user -- User input parameters +! * surf -- Surface ggrid +! * crater -- Crater dimension container +! * domain -- Simulation domain variable container +! +! Output +! * ejdist -- logical array containing the pixels that contain ejecta +! +!*** + +!********************************************************************************************************************************** +subroutine ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,ejdistribution) + use module_globals + use module_util + use module_io + use module_crater + use module_regolith + use module_ejecta, EXCEPT_THIS_ONE => ejecta_ray_pattern + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + type(cratertype),intent(in) :: crater + integer(I4B),intent(in) :: inc,xi,xf,yi,yf + real(DP),dimension(xi:xf,yi:yf),intent(out) :: ejdistribution + + ! Internal variables + integer(I4B) :: nrays,i,j,k,n,nef,incsq,iradsq,xpi,ypi + real(DP) :: frac,mef,lrad,lradsq,xp,yp,binres + real(DP),dimension(1) :: rn + real(DP) :: theta, lradp, maxdistance + real(DP), parameter :: n1 = 4.0_DP + real(DP) :: n2, mag + real(DP),dimension(xi:xf,yi:yf) :: isray + real(DP),dimension(:),allocatable :: numinray,totnum + real(DP),dimension(:),allocatable :: mefarray + + ! Flowery ray variables + integer(I4B) :: nfrays + real(DP) :: n1f, n2f, magf, lradf, rayf,rayavg + real(DP), parameter :: a = 16.8799 !a = 11.8126 ! Fitting parameters for a relation between ray length and radius of crater + real(DP), parameter :: b = 0.120621 !0.143 ! based on Jake's crater rays mapping studies! + real(DP) :: mvrld ! median value of ray length distribution + real(DP) :: mvrldsc ! median value of ray length distribution scaled by continuous ejecta ext/allent + + call random_number(rn) + + !^^^^^^^^^^^^^^^^^^^^^^^^ + + ! *************************** Superformula Ray Model ************************************! + ! *************************** Part I. Spoke and Skinny Ray Model ************************************! + ! From fitting Jake Elliot's ray mapping data, it is a linear function that describes the relationship between the median value of ray length + ! distribution and the radius of rayed craters (in unit of kilometers) + ! Also, we need to scale it with the continuous ejecta's extent for ray model +!# mvrld = a * (crater%frad/1000.0)**(b) +!# mvrldsc = mvrld / (continuous/crater%frad) + ! It appears that no strong correlation between the number of rays and size of craters. + ! The average number of rays is about 10. The minimum and maximum number is 6 and 14 respectively. + + ! Determine parameters of Ray model based on Gielis's superformula + ! There are three parameters regarding to our desired ray shape: n1, n2, m + ! m: the repeating part of formula, and it controls the number of rays (arms). + ! n1: the default value is set as 4.0 in our rays case + ! n2: n2 and n1 combining together is to control the slenderness of a ray, in general, n1/n2 is always smaller than 1 in our cases. + ! The smaller the ratio, the skinnier a ray. + + nrays = nint(8 * rn(1)) + 6 + mvrld = crater%ejdis + mvrldsc = mvrld / crater%continuous + n2 = 8.0_DP * ( log10(mvrldsc/1.5_DP) / log10(2.0_DP) ) + 2.0_DP + ! *************************** Part II. Flowery Ray Model ************************************! + nfrays = 20 + n1f = 1.0_DP + n2f = 0.5_DP + rayf = 4.0 !7.5_DP + + isray = 0.0_DP + incsq = inc**2 + maxdistance = inc * user%pix + + ! Mass enhancement factor array + ! Don't let the bin resolution get too small for small craters. + binres = min(10.0_DP,crater%ejdis / 10) * user%pix + nef = ceiling(crater%ejdis / binres) ! bin size for enhancement factor calculation + allocate(numinray(nef),totnum(nef),mefarray(nef)) + + totnum = 0 + numinray = 0 + do j = yi,yf + do i = xi,xf + iradsq = i*i + j*j + + xpi = crater%xlpx + i + ypi = crater%ylpx + j + + ! Find distance from crater center to current pixel center in real space + xp = xpi * user%pix + yp = ypi * user%pix + + lradsq = (crater%xl - xp)**2 + (crater%yl - yp)**2 + lrad = sqrt(lradsq) + + if ((iradsq > incsq).or.(lrad <= crater%rad)) cycle + + ! Sum up the number of pixels in this bin for the mass enhancement calculation + k = ceiling(lrad / binres) + totnum(k) = totnum(k) + 1.0_DP + + ! Ray pattern setup + ! Take average of five points in the pixel to "feather" the edges of the ray + rayavg = 0.0_DP + do n = 1, 5 + select case(n) + case(1) + theta = atan2(j * 1._DP,i * 1._DP) + 2.0_DP * PI + case(2) + theta = atan2(j * 1._DP - 0.5_DP,i * 1._DP - 0.5_DP) + 2.0_DP * PI + lradsq = (crater%xl - xp - 0.5_DP * user%pix)**2 + (crater%yl - yp - 0.5_DP * user%pix)**2 + lrad = sqrt(lradsq) + case(3) + theta = atan2(j * 1._DP - 0.5_DP,i * 1._DP + 0.5_DP) + 2.0_DP * PI + lradsq = (crater%xl - xp - 0.5_DP * user%pix)**2 + (crater%yl - yp + 0.5_DP * user%pix)**2 + lrad = sqrt(lradsq) + case(4) + theta = atan2(j * 1._DP + 0.5_DP,i * 1._DP + 0.5_DP) + 2.0_DP * PI + lradsq = (crater%xl - xp + 0.5_DP * user%pix)**2 + (crater%yl - yp + 0.5_DP * user%pix)**2 + lrad = sqrt(lradsq) + case(5) + theta = atan2(j * 1._DP + 0.5_DP,i * 1._DP - 0.5_DP) + 2.0_DP * PI + lradsq = (crater%xl - xp + 0.5_DP * user%pix)**2 + (crater%yl - yp - 0.5_DP * user%pix)**2 + lrad = sqrt(lradsq) + end select + + mag = ( ( (abs(cos(nrays * theta / 4.0_DP)))**n2 + & + (abs(sin(nrays * theta / 4.0_DP)))**n2 )**(-1.0_DP/n1) ) + magf = rayf * ( ( (abs(cos(nfrays * theta / 4.0_DP)))**n2f + & + (abs(sin(nfrays * theta / 4.0_DP)))**n2f )**(-1.0_DP/n1f)) + lradp = crater%frad * mag + lradf = crater%frad * magf + lradp = lradp + lradf !max(lradp, lradf) + + if ((lrad < maxdistance) .and. (lrad < lradp)) then + rayavg = rayavg + 1.0_DP + end if + end do + rayavg = rayavg / 5 + isray(i,j) = rayavg + numinray(k) = numinray(k) + rayavg + end do + end do + if ((xi /= -inc).or.(xf /= inc).or.(yi /= -inc).or.(yf /= inc)) then + ejdistribution(xi:xf,yi:yf) = isray(xi:xf,yi:yf) + else + do k = 1,nef + if (numinray(k) == 0) then + mefarray(k) = 1.0_DP + else + mefarray(k) = totnum(k) / numinray(k) + end if + end do + ejdistribution = 1.0_DP + + ! Now calculate the ejecta distribution with mass enhancement factor + do j = yi,yf + do i = xi,xf + ejdistribution(i,j) = 0.0_DP + iradsq = i*i + j*j + lrad = sqrt(lradsq) + if (lrad < crater%continuous) then + ejdistribution(i,j) = 1.0_DP + else + frac = lrad / binres + k = ceiling(frac) + ! Interpolate the mass enhancement factor between array points + mef = mefarray(k) + (frac - k * 1.0_DP) * (mefarray(k) - mefarray(k - 1)) + ejdistribution(i,j) = mef * isray(i,j) + end if + end do + end do + end if + + deallocate(numinray,totnum,mefarray) + +end subroutine ejecta_ray_pattern + diff --git a/src/ejecta/ejecta_rootfind.f90 b/src/ejecta/ejecta_rootfind.f90 index 716da6cf..9e7f952b 100644 --- a/src/ejecta/ejecta_rootfind.f90 +++ b/src/ejecta/ejecta_rootfind.f90 @@ -153,7 +153,7 @@ subroutine ejecta_rootfind(user,crater,domain,erad,lrad,vejsq,ejang,firstrun) end if niter = i erad = resultat - if ((erad <= crater%rad).and.(lrad >= crater%rad).and.(erad >= 0._DP)) exit + if ((erad <= crater%frad).and.(lrad >= crater%frad).and.(erad >= 0._DP)) exit factor = 0.5_DP * (factor + 1.0_DP) ! Failed. Try again with a new factor end do everything diff --git a/src/ejecta/ejecta_table_define.f90 b/src/ejecta/ejecta_table_define.f90 index bbb732e3..06f54905 100644 --- a/src/ejecta/ejecta_table_define.f90 +++ b/src/ejecta/ejecta_table_define.f90 @@ -42,12 +42,15 @@ subroutine ejecta_table_define(user,crater,domain,ejb,ejtble,melt) ! Executable code ! Get estimate of size of ejb table - crater%continuous = RCONT * crater%frad**(EXPCONT) ! Continuous ejecta distance From Moore (1974) eq. 1 - crater%ejdis = DISEJB * crater%continuous + if (.not.user%discontinuous) then + crater%ejdis = 2 * 2.3_DP * crater%frad**(1.006_DP) ! Continuous ejecta distance From Melosh (1989) eq. 6.3.1 + else + crater%ejdis = DISEJB * 2.3_DP * crater%frad**(1.006_DP) ! Continuous ejecta distance From Melosh (1989) eq. 6.3.1 + end if ! We go out a factor of 3 to get the discontinuous ejecta thickness - domain%ejbres = (log(crater%ejdis) - log(crater%rad)) / EJBTABSIZE - lrad = crater%rad !exp(log(crater%rad) !+ domain%ejbres) - erad = crater%rad + domain%ejbres = (crater%ejdis - crater%rad) / EJBTABSIZE + lrad = crater%frad + erad = crater%rad ejtble = EJBTABSIZE firstrun = .true. thick = 0._DP @@ -71,18 +74,21 @@ subroutine ejecta_table_define(user,crater,domain,ejb,ejtble,melt) do k = 0,EJBTABSIZE call ejecta_rootfind(user,crater,domain,erad,lrad,vejsq,ejang,firstrun) if (k >= 1) then - !call ejecta_thickness(user,crater,eradold,erad,lrad - domain%ejbres,lrad,thick) - ejb(k)%lrad = log(lrad) - ! Use McGetchin et al. 1973 for ejecta thickness + !if (crater%frad >= 240.0) then + ! call ejecta_thickness(user,crater,eradold,erad,lrad - domain%ejbres,lrad,thick) + !else if (lrad >= crater%frad) then - thick = 0.14_DP * crater%frad**(0.74_DP) * (lrad / crater%frad)**(-3.0_DP) + thick = 0.14_DP * crater%frad**(0.74_DP) * (lrad /crater%frad)**(-3.0_DP) else - thick = 0.14_DP * crater%frad**(0.74_DP) / (crater%frad - crater%rad) * (lrad - crater%rad) + thick = 0.14_DP * crater%frad**(0.74_DP) / (crater%frad - crater%rad) * (lrad - crater%rad) end if + !end if + !call ejecta_thickness(user,crater,eradold,erad,lrad - domain%ejbres,lrad,thick) + ejb(k)%lrad = log(lrad - 0.5_DP * domain%ejbres) ejb(k)%thick = log(thick) ejb(k)%vesq = vejsq ejb(k)%angle = ejang - ejb(k)%erad = log(erad) + ejb(k)%erad = erad if (present(melt)) then call regolith_melt_fraction(dimp,depthb,erad,eradold,rmelt,melt) ejb(k)%meltfrac = melt @@ -94,7 +100,7 @@ subroutine ejecta_table_define(user,crater,domain,ejb,ejtble,melt) exit end if end if - lrad = exp(log(lrad) + domain%ejbres) + lrad = lrad + domain%ejbres eradold = erad end do !write(*,*) 'A MELT ZONE of ',crater%frad,' meter-sized crater: ',rmelt,'at a rim',ejb(1)%meltfrac diff --git a/src/ejecta/module_ejecta.f90 b/src/ejecta/module_ejecta.f90 index 669ea8a2..46f69a2b 100644 --- a/src/ejecta/module_ejecta.f90 +++ b/src/ejecta/module_ejecta.f90 @@ -25,7 +25,7 @@ module module_ejecta save interface - subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) + subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,ejbmass,age,age_resolution) use module_globals implicit none type(usertype),intent(in) :: user @@ -34,21 +34,20 @@ subroutine ejecta_emplace(user,surf,crater,domain,ejb,ejtble,deltaMtot) type(domaintype),intent(in) :: domain integer(I4B),intent(in) :: ejtble type(ejbtype),dimension(ejtble),intent(in) :: ejb - real(DP),intent(in) :: deltaMtot + real(DP),intent(out) :: ejbmass + real(DP),intent(in) :: age, age_resolution end subroutine ejecta_emplace end interface - interface - subroutine ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,diffdistribution,ejdistribution) - use module_globals - implicit none - type(usertype),intent(in) :: user - type(surftype),dimension(:,:),intent(in) :: surf - type(cratertype),intent(inout) :: crater - integer(I4B),intent(in) :: inc,xi,xf,yi,yf - real(DP),dimension(xi:xf,yi:yf),intent(out) :: diffdistribution - real(DP),dimension(xi:xf,yi:yf),intent(out) :: ejdistribution - end subroutine ejecta_ray_pattern + interface + subroutine ejecta_ray_pattern(user,surf,crater,inc,xi,xf,yi,yf,ejdistribution) + use module_globals + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + type(cratertype),intent(in) :: crater + integer(I4B),intent(in) :: inc,xi,xf,yi,yf + real(DP),dimension(xi:xf,yi:yf),intent(out) :: ejdistribution + end subroutine ejecta_ray_pattern end interface interface diff --git a/src/globals/module_globals.f90 b/src/globals/module_globals.f90 index 686f6e47..a8b1b60c 100644 --- a/src/globals/module_globals.f90 +++ b/src/globals/module_globals.f90 @@ -14,7 +14,7 @@ module module_globals implicit none public -character(len=*),parameter :: CTEMVER = "1.4 DEVELOPMENT" +character(len=*),parameter :: CTEMVER = "1.3 DEVELOPMENT" ! Symbolic names for kind types of 4-, 2-, and 1-byte integers: integer, parameter :: I8B = selected_int_kind(17) @@ -48,20 +48,21 @@ module module_globals real(DP),parameter :: VSMALL = tiny(1._DP) ! Very small number real(DP),parameter :: LOGVSMALL = log(VSMALL) ! log of a very small number real(DP),parameter :: VBIG = huge(1._DP) ! Very big number -real(DP),parameter :: SMALLFAC = 1e-5_DP ! Smallest unit of measurement proportional to pixel size +real(DP),parameter :: SMALLFAC = 1e-5_DP ! Smallest unit of measurement proportional to pixel size integer(I4B),parameter :: MAXLAYER=20 ! Maximum number of layers (you need roughly 1-2 layers per order of magnitude of ! resolution -real(DP),parameter :: TALLYCOVERAGE = 0.01_DP ! The total area coverage to reach before a tally step is executed +integer(I2B),parameter :: MAXAGEBINS=60 ! Maximum number of bins in age distribution reset by impact melting +real(DP),parameter :: TALLYCOVERAGE = 0.01_DP ! The total area coverage to reach before a tally step is executed real(DP),parameter :: SUBPIXELCOVERAGE = 0.025_DP ! The total area coverage to reach before a subpixel evaluate step is executed: 0.05_DP real(DP),parameter :: COOKIESIZE = 3.0_DP ! Relative size of old crater to new crater that cookie cutting is applied ! Only craters smaller than COOKIESIZE times the new crater are cookie cut real(DP),parameter :: ALPHA = 0.125_DP -real(DP),parameter :: DISEJB = 100.0_DP ! The extent of discontinuous ejecta in the unit of crater radii. It is used in ejecta_table_define.f90 -real(DP),parameter :: RCONT = 2.25267_DP ! Coefficient of continuous ejecta size power law from Moore et al. (1974) - scaled from km to m -real(DP),parameter :: EXPCONT = 1.006_DP ! Exponentt of continuous ejecta size power law from Moore et al. (1974) - +real(DP),parameter :: DISEJB = 100.0_DP ! The extent of discontinuous ejecta in the unit of crater radii. It is used in ejecta_table_define.f90 +real(DP),parameter :: PF = 5.0e9 ! The shock pressure exceeding the hungoit elastic limit of common geological materials in Pa. (5 GPa) +real(DP),parameter :: RAD_GP = 20.0_DP ! The maximum radial position of producing impact glass spherules within a transient crater (unit of crater radii, crater%rad) type regodatatype + real(SP),dimension(MAXAGEBINS) :: age ! Record impact glass spherule ages in an array (or histogram defined by MAXAGEBINS) real(DP) :: thickness real(DP) :: meltfrac real(DP) :: comp @@ -77,9 +78,8 @@ module module_globals ! Derived data type for simulated surface type surftype - real(DP),dimension(MAXLAYER) :: diam ! Crater diameter + real(DP),dimension(MAXLAYER) :: diam real(SP),dimension(MAXLAYER) :: xl,yl ! Crater center - real(SP),dimension(MAXLAYER) :: timestamp ! Crater formation time real(DP) :: ejcov ! Ejecta coverage real(DP) :: dem ! Digital elevation model real(DP) :: mantle ! Height of mantle (should be smaller than dem) @@ -92,7 +92,6 @@ module module_globals real(DP) :: imp,imprad,impvel,sinimpang,impmass ! Impactor properties ! Real domain properties real(SP) :: xl,yl ! Crater center in simulated surface size units - real(SP) :: timestamp ! The formation time of the crater real(DP) :: rad ! Transient radius real(DP) :: grad ! Strengthless material transient crater radius real(DP) :: frad ! Final crater radius @@ -105,7 +104,6 @@ module module_globals real(DP) :: cxexp,cxtran ! simple to complex scaling parameters real(DP) :: kdiffterm, saccelterm ! seismic diffusion and accelleration terms real(DP) :: continuous ! Size of the continuous ejecta blanket - real(DP) :: fe ! Equivalent degradation radius ! Pixel domain properties integer(I4B) :: xlpx,ylpx ! Crater center in pixels integer(I4B) :: fcratpx,fradpx,rimdispx,ejdispx @@ -143,6 +141,7 @@ module module_globals integer(I4B) :: vhi ! Index of highest valid velocity in the velocity distribution file integer(I4B) :: tallycoverage ! Estimated areal coverage of craters since the last tally integer(I4B) :: subpixelcoverage ! Estimated areal coverage of craters since the last subpixel step + real(DP) :: rmsvel ! Root mean square impact velocity end type domaintype ! Derived data type for user input variables @@ -186,15 +185,14 @@ module module_globals real(DP) :: regcoh ! target surface regolith layer cohesion ! Crater diffusion input parameters - real(DP) :: Kd1 ! Degradation function coefficient (from Minton et al. (2019)) - real(DP) :: psi ! Degradation function exponent (from Minton et al. (2019)) - real(DP) :: fe ! Scale factor for size of degradation region (from Minton et al. (2019)) + real(DP) :: soften_factor ! Kbar,0 from Minton et al. (2017) + real(DP) :: soften_slope ! power law index of diffusion model Kbar + real(DP) :: soften_size ! size of diffusion area in crater radii ! Ejecta softening variables logical :: dosoftening ! Set T to use the extra crater softening model real(DP) :: ejecta_truncation ! Set the number of crater diameters to truncate the ejecta - logical :: dorays ! Set T to use ray model - logical :: superdomain ! Set T to include the superdomain + logical :: discontinuous ! Regolith tracking variables logical :: doregotrack ! Set T to use the regolith tracking model (EXPERIMENTAL) @@ -247,7 +245,7 @@ module module_globals ! Progress bar variables integer(I4B),parameter :: PBARRES = 100 -integer(I4B),parameter :: PBARSIZE = 50 +integer(I4B),parameter :: PBARSIZE = 40 integer(I4B),parameter :: MESSAGESIZE = 32 integer(I4B) :: pbarival integer(I4B) :: pbarpos @@ -255,13 +253,13 @@ module module_globals ! Grid array file names character(*),parameter :: DIAMFILE = 'surface_diam.dat' -character(*),parameter :: TIMEFILE = 'surface_time.dat' character(*),parameter :: EJCOVFILE = 'surface_ejc.dat' character(*),parameter :: DEMFILE = 'surface_dem.dat' character(*),parameter :: REGOFILE = 'surface_regotop.dat' character(*),parameter :: MELTFILE = 'surface_melt.dat' character(*),parameter :: COMPFILE = 'surface_comp.dat' character(*),parameter :: STACKNUMFILE = 'surface_stacknum.dat' +character(*),parameter :: AGEFILE = 'surface_age.dat' character(*),parameter :: STACKPORFILE = 'porosity_stacknum.dat' character(*),parameter :: POROFILE = 'porosity_porosity.dat' character(*),parameter :: DEPTHFILE = 'porosity_depth.dat' @@ -282,7 +280,7 @@ module module_globals integer(I4B),parameter :: PBCLIM = 1 ! periodic boundary condition limit integer(I4B),parameter :: SMALLESTCOUNTABLE = 5 ! Minimum pixel diameter for a crater to be considered countable real(DP),parameter :: SMALLESTEJECTA = 1.5 ! Minimum number of pixels from center of crater for an ejecta to have any surface effects -integer(I4B),parameter :: TRUECOLS = 7 ! Number of columns in the true crater count array +integer(I4B),parameter :: TRUECOLS = 6 ! Number of columns in the true crater count array integer(I4B) :: NTHREADS = 1 ! Number of OpenMP threads (reset by OpenMP if a parallel environment is detected) integer(I4B),parameter :: INCPAR = 1 ! Minimum size of inc variables before parallelization kicks in @@ -297,11 +295,11 @@ module module_globals real(DP),parameter :: TRSIM = 1.25_DP ! ? real(DP),parameter :: EXFAC = 0.1_DP ! Excavation depth relative to transient crater diameter real(DP),parameter :: CXEXPS = 1._DP / 0.885_DP - 1.0_DP ! Complex crater scaling exponent (see Croft 1985) -real(DP),parameter :: SIMCOMKS = 16533.8_DP ! Simple-to-complex transition scaling coefficient for silicate rock -real(DP),parameter :: SIMCOMPS = -1.0303_DP ! Simple-to-complex transition scaling exponent for silicate rock +real(DP),parameter :: SIMCOMKS = 16533.8_DP ! ? +real(DP),parameter :: SIMCOMPS = -1.0303_DP ! ? real(DP),parameter :: CXEXPI = 0.155_DP ! ? -real(DP),parameter :: SIMCOMKI = 3081.39_DP ! Simple-to-complex transition scaling coefficient for ice -real(DP),parameter :: SIMCOMPI = -1.22486_DP ! Simple-to-complex transition scaling exponent for ice +real(DP),parameter :: SIMCOMKI = 3081.39_DP ! ? +real(DP),parameter :: SIMCOMPI = -1.22486_DP ! ? real(DP),parameter :: SUBPIXFAC = 0.1_DP ! Subpixel resolution (used for lookup tables and rim creation) integer(I4B),parameter :: EJBTABSIZE = 1000 ! Lookup table size real(DP),parameter :: CRITSLP = 0.7_DP ! critical slope angle @@ -309,9 +307,10 @@ module module_globals real(DP),parameter :: BOWLFRAC = 0.2_DP ! Fraction of crater interior pixels to use for the bowl-to-rim height calculation ! (calibrated for Orientale using Potter et al. 2012) real(DP),parameter :: TRNRATIO = 0.30_DP ! The ratio of the transient crater depth to the crater diameter. -real(DP),parameter :: KD1PROX = 0.27_DP ! Intrinsic proximal ejecta degradation function coefficient -real(DP),parameter :: PSIPROX = 2.0_DP ! Intrinsic proximal ejecta degradation function exponent -real(DP),parameter :: FEPROX = 1.0_DP ! Intrinsic proximal ejecta degradation function size scale factor + +!real(DP),parameter :: SOFTEN_FACTOR = 0.60_DP ! Extra per crater diffusion constant +!#real(DP) :: SOFTEN_FACTOR = 0.60_DP ! Extra per crater diffusion constant +!real(DP),parameter :: SOFTEN_SLOPE = 1.3_DP ! Extra per crater diffusion power law slope ! Seismic shaking parameters real(DP),parameter :: SEISFREQ = 20.0_DP ! seismic wave frequency diff --git a/src/init/init_domain.f90 b/src/init/init_domain.f90 index b813e4b6..66cf02bc 100644 --- a/src/init/init_domain.f90 +++ b/src/init/init_domain.f90 @@ -24,7 +24,7 @@ subroutine init_domain(user,crater,domain,prod,pdist,vdist,crtscl,nflux) implicit none ! Arguments - type(usertype),intent(inout) :: user + type(usertype),intent(in) :: user type(cratertype),intent(inout) :: crater type(domaintype),intent(inout) :: domain real(DP),dimension(:,:),intent(inout) :: prod,vdist @@ -59,9 +59,9 @@ subroutine init_domain(user,crater,domain,prod,pdist,vdist,crtscl,nflux) domain%parea = user%pix**2 domain%area = domain%side**2 domain%biggest_crater = domain%side * user%maxcrat - domain%smallest_crater = user%pix + domain%smallest_crater = user%pix domain%smallest_ejecta = SMALLESTEJECTA * user%pix - domain%smallest_counted_crater = SMALLESTCOUNTABLE * user%pix + domain%smallest_counted_crater = 2._DP / (1._DP + COUNTINGRIM) * sqrt(SMALLESTCOUNTABLE / PI) * user%pix domain%vescsq = 2 * user%gaccel * user%trad ! Set up transition values @@ -74,10 +74,6 @@ subroutine init_domain(user,crater,domain,prod,pdist,vdist,crtscl,nflux) crater%cxtran = SIMCOMKI*(user%gaccel**SIMCOMPI) end select - ! Preliminary seismic property calculations - user%seisk = THIRD * user%tvel * user%tfrac - user%cohaccel = user%regcoh / user%trho_r - ! Now we build an idealized production population domain%initialize = .true. @@ -95,6 +91,7 @@ subroutine init_domain(user,crater,domain,prod,pdist,vdist,crtscl,nflux) end do domain%vhi = min(domain%vhi + 1,domain%vnum) rmsvel = sqrt(rmsvel/numvel) + domain%rmsvel = rmsvel domain%smallest_impactor_index = 1 ! Find the smallest impactor that produces a crater at least 1 pixel wide at the maximum possible impact velocity and angle @@ -176,7 +173,6 @@ subroutine init_domain(user,crater,domain,prod,pdist,vdist,crtscl,nflux) pdist(4,i) = pdist(4,i) + diffnum ! Differential number nflux(3,k) = diffnum / domain%area / user%interval - end do do i = 1,domain%pdistl diff --git a/src/init/init_regolith_stack.f90 b/src/init/init_regolith_stack.f90 index d020e9bb..b9fd331e 100644 --- a/src/init/init_regolith_stack.f90 +++ b/src/init/init_regolith_stack.f90 @@ -28,11 +28,14 @@ subroutine init_regolith_stack(user,surf) type(usertype),intent(in) :: user type(surftype),dimension(:,:),intent(inout) :: surf type(regodatatype) :: bedrock - integer(I4B) :: xp,yp + integer(I4B) :: xp,yp,k ! Internal variables logical :: initstat + ! Temporary variable setup for initialize a pre-exising structure + type(regodatatype) :: test_stratig + !call init_regolith_parab(user,surf) !======================================= ! Initialize the grid space @@ -40,6 +43,7 @@ subroutine init_regolith_stack(user,surf) bedrock%thickness = user%trad bedrock%meltfrac = 0._DP bedrock%comp = 0._DP + bedrock%age(:) = 0.0_SP do yp = 1, user%gridsize do xp = 1, user%gridsize diff --git a/src/init/init_surf.f90 b/src/init/init_surf.f90 index 838f799f..8a0609f7 100644 --- a/src/init/init_surf.f90 +++ b/src/init/init_surf.f90 @@ -38,9 +38,6 @@ subroutine init_surf(user,surf) !if (user%docrustal_thinning) surf%mantle = 0._DP if (user%doregotrack) call init_regolith_stack(user,surf) - - ! If doporosity, call init_porosity_stack to define the porolayer linked list. - if (user%doporosity) call init_porosity_stack(user,surf) return -end subroutine init_surf + end subroutine init_surf diff --git a/src/init/module_init.f90 b/src/init/module_init.f90 index fee0ebe1..e93da2f6 100644 --- a/src/init/module_init.f90 +++ b/src/init/module_init.f90 @@ -56,13 +56,4 @@ subroutine init_regolith_stack(user,surf) end subroutine init_regolith_stack end interface - interface - subroutine init_porosity_stack(user,surf) - use module_globals - implicit none - type(usertype),intent(in) :: user - type(surftype),dimension(:,:),intent(inout) :: surf - end subroutine init_porosity_stack - end interface - end module module_init diff --git a/src/io/io_ejecta_table.f90 b/src/io/io_ejecta_table.f90 index 11c12027..7b61b964 100644 --- a/src/io/io_ejecta_table.f90 +++ b/src/io/io_ejecta_table.f90 @@ -41,7 +41,7 @@ subroutine io_ejecta_table(crater,domain,ejb,ejtble,filename) write(LUN,'(A63)') '# "r (m)" "h (m)" "v (m/s)" "ang (deg)" "erad (m)"' do k=1,ejtble write(LUN,'(5(ES13.5E3,1X))') exp(ejb(k)%lrad),exp(ejb(k)%thick),sqrt(ejb(k)%vesq),ejb(k)%angle/DEG2RAD, & - exp(ejb(k)%erad) + ejb(k)%erad end do close(LUN) diff --git a/src/io/io_input.f90 b/src/io/io_input.f90 index 83f6c39f..49b08d3e 100644 --- a/src/io/io_input.f90 +++ b/src/io/io_input.f90 @@ -77,8 +77,6 @@ subroutine io_input(infile,user) user%doscour = .false. user%tallyonly = .false. user%dosoftening = .true. - user%dorays = .false. - user%superdomain = .true. user%doregotrack = .false. user%basinimp = huge(0._DP) user%maxcrat = 1.00_DP @@ -86,11 +84,12 @@ subroutine io_input(infile,user) user%testtally = .false. user%killatmaxcrater = .false. user%doporosity = .false. - user%Kd1 = 0.00_DP - user%psi = 2.0_DP - user%fe = 1.0_DP + user%soften_factor = 0.9_DP + user%soften_slope = 1.8_DP + user%soften_size = 30.0_DP user%ejecta_truncation = 10.0_DP user%doquasimc = .false. + user%discontinuous = .true. open(unit=LUN,file=infile,status="old",iostat=ierr) if (ierr /= 0) then @@ -282,16 +281,6 @@ subroutine io_input(infile,user) call io_get_token(line, ilength, ifirst, ilast, ierr) token = line(ifirst:ilast) read(token, *) user%dosoftening - case ("DORAYS") - ifirst = ilast + 1 - call io_get_token(line, ilength, ifirst, ilast, ierr) - token = line(ifirst:ilast) - read(token, *) user%dorays - case ("SUPERDOMAIN") - ifirst = ilast + 1 - call io_get_token(line, ilength, ifirst, ilast, ierr) - token = line(ifirst:ilast) - read(token, *) user%superdomain case ("DOREGOTRACK") ifirst = ilast + 1 call io_get_token(line, ilength, ifirst, ilast, ierr) @@ -323,10 +312,15 @@ subroutine io_input(infile,user) token = line(ifirst:ilast) read(token, *) user%testtally case ("EJECTA_TRUNCATION") ! Radius of ejecta blankets to model in terms of crater radius + ifirst = ilast + 1 + call io_get_token(line, ilength, ifirst, ilast, ierr) + token = line(ifirst:ilast) + read(token, *) user%ejecta_truncation + case ("DISCONTINUOUS") ! Do discontinuous ejecta blanket ifirst = ilast + 1 call io_get_token(line, ilength, ifirst, ilast, ierr) token = line(ifirst:ilast) - read(token, *) user%ejecta_truncation + read(token, *) user%discontinuous ! Porosity model case ("POROSITYFLG") ifirst = ilast + 1 @@ -448,21 +442,21 @@ subroutine io_input(infile,user) token = line(ifirst:ilast) read(token, *) user%shadedmaxh read(token, *) user%shadedminh - case ("KD1") + case ("SOFTEN_FACTOR") ifirst = ilast + 1 call io_get_token(line, ilength, ifirst, ilast, ierr) token = line(ifirst:ilast) - read(token, *) user%Kd1 - case ("PSI") + read(token, *) user%soften_factor + case ("SOFTEN_SLOPE") ifirst = ilast + 1 call io_get_token(line, ilength, ifirst, ilast, ierr) token = line(ifirst:ilast) - read(token, *) user%psi - case ("FE") + read(token, *) user%soften_slope + case ("SOFTEN_SIZE") ifirst = ilast + 1 call io_get_token(line, ilength, ifirst, ilast, ierr) token = line(ifirst:ilast) - read(token, *) user%fe + read(token, *) user%soften_size !************************************************************************** ! The following is for backwards compatibility with older style input files !************************************************************************** diff --git a/src/io/io_read_regotrack.f90 b/src/io/io_read_regotrack.f90 index 06093b3a..ed93300c 100644 --- a/src/io/io_read_regotrack.f90 +++ b/src/io/io_read_regotrack.f90 @@ -31,11 +31,13 @@ subroutine io_read_regotrack(user,surf) integer(I4B), parameter :: LUM=8 integer(I4B), parameter :: LUP=9 integer(I4B), parameter :: LUC=10 + integer(I4B), parameter :: LUA=11 real(DP),dimension(user%gridsize,user%gridsize) :: regotop,melt,comp + real(SP),dimension(user%gridsize,user%gridsize,60) :: age integer(I4B),dimension(user%gridsize,user%gridsize) :: stacks_num - real(DP), dimension(:),allocatable :: regotopi,melti,compi + real(DP), dimension(:),allocatable :: regotopi,melti,compi,agei type(regodatatype) :: newsurfi - integer(I4B) :: ioerr,i,j,k,itmp + integer(I4B) :: ioerr,i,j,k,q,itmp integer(kind=8) :: recsize logical :: initstat @@ -71,6 +73,12 @@ subroutine io_read_regotrack(user,surf) stop end if + open(LUA,file=AGEFILE,status='old',form='unformatted',iostat=ioerr) + if (ioerr/=0) then + write(*,*) 'Error! Cannot read file ',trim(adjustl(MELTFILE)) + stop + end if + ! Start pushing regolith thickness and melt fraction of each layer in FILO manner do j=1,user%gridsize @@ -81,7 +89,8 @@ subroutine io_read_regotrack(user,surf) allocate(regotopi(stacks_num(i,j))) allocate(compi(stacks_num(i,j))) allocate(melti(stacks_num(i,j))) - + allocate(agei(60 * stacks_num(i,j))) + do k=1,stacks_num(i,j) read(LUN) regotop(i,j) regotopi(k) = regotop(i,j) @@ -89,16 +98,23 @@ subroutine io_read_regotrack(user,surf) compi(k) = comp(i,j) read(LUM) melt(i,j) melti(k) = melt(i,j) + read(LUA) age(i,j,:) + do q=1,60 + agei(60*k - (60-q)) = age(i,j,q) + end do end do do k=max(stacks_num(i,j)-1,1),1,-1 newsurfi%thickness = regotopi(k) newsurfi%comp = compi(k) newsurfi%meltfrac = melti(k) + do q=1,60 + newsurfi%age(q) = agei(60*k-(60-q)) + end do call util_push(surf(i,j)%regolayer,newsurfi) end do - deallocate(regotopi,compi,melti) + deallocate(regotopi,compi,melti,agei) end do end do diff --git a/src/io/io_read_surf.f90 b/src/io/io_read_surf.f90 index 3dbade81..85fb3e32 100644 --- a/src/io/io_read_surf.f90 +++ b/src/io/io_read_surf.f90 @@ -48,7 +48,6 @@ subroutine io_read_surf(user,surf) read(LUN,rec=1) surf%dem close(LUN) - open(LUN,file=EJCOVFILE,status='old',form='unformatted',recl=recsize,access='direct',iostat=ioerr) if (ioerr/=0) then write(*,*) 'Error! Cannot read file ',trim(adjustl(EJCOVFILE)) @@ -67,17 +66,6 @@ subroutine io_read_surf(user,surf) end do close(LUN) - open(LUN,file=TIMEFILE,status='old',form='unformatted',recl=recsize,access='direct',iostat=ioerr) - if (ioerr/=0) then - write(*,*) 'Error! Cannot read file ',trim(adjustl(DIAMFILE)) - stop - end if - do i=1,user%numlayers - read(LUN,rec=i) surf%timestamp(i) - end do - close(LUN) - - recsize = sizeof(stmp) * user%gridsize * user%gridsize open(LUN,file=POSFILE,status='old',form='unformatted',recl=recsize,access='direct',iostat=ioerr) if (ioerr/=0) then @@ -91,9 +79,6 @@ subroutine io_read_surf(user,surf) close(LUN) if (user%doregotrack) call io_read_regotrack(user,surf) - - ! if doporosity, call io_read_porotrack to define the porosity linked list from the read files. - if (user%doporosity) call io_read_porotrack(user,surf) !if (user%docrustal_thinning) then ! recsize=sizeof(itmp)*user%gridsize*user%gridsize diff --git a/src/io/io_updatePbar.f90 b/src/io/io_updatePbar.f90 index 7ba679d9..f7e9f57a 100644 --- a/src/io/io_updatePbar.f90 +++ b/src/io/io_updatePbar.f90 @@ -39,20 +39,20 @@ subroutine io_updatePbar(message) perc=floor(100*real(pbarpos)/real(PBARRES)) write(unit=bar(1:3),fmt="(i3)") perc endpoint = min(ceiling(real(pbarpos*PBARSIZE)/real(PBARRES)),PBARSIZE) -do k = 1,endpoint !- 1 +do k = 1,endpoint - 1 bar(6+k:6+k)=pbarchar(k:k) end do -!select case(flip) -!case(1) -! bar(6+endpoint:6+endpoint)="/" -!case(2) -! bar(6+endpoint:6+endpoint)="-" -!case(3) -! bar(6+endpoint:6+endpoint)="\" -!case(4) -! bar(6+endpoint:6+endpoint)="|" -!end select -!flip = flip + 1 +select case(flip) +case(1) + bar(6+endpoint:6+endpoint)="/" +case(2) + bar(6+endpoint:6+endpoint)="-" +case(3) + bar(6+endpoint:6+endpoint)="\" +case(4) + bar(6+endpoint:6+endpoint)="|" +end select +flip = flip + 1 if (flip > 4) flip = 1 ! print the progress bar. write(fmtlabel,'("(A1,A",I2.2,",1X,A",I2.2,",$)")') PBARSIZE+7,MESSAGESIZE diff --git a/src/io/io_write_age.f90 b/src/io/io_write_age.f90 new file mode 100644 index 00000000..2f102188 --- /dev/null +++ b/src/io/io_write_age.f90 @@ -0,0 +1,101 @@ +!********************************************************************************************************************************** +! +! Unit Name : io_write_age +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Writes new files for terrain grids for age information +! +! Input +! Arguments : +! +! Output +! Arguments : surf : Surface expression matrix +! +! Notes : +! +!********************************************************************************************************************************** +subroutine io_write_age(user,surf,n_size,icrater,ncrat) + use module_globals + use module_io, EXCEPT_THIS_ONE => io_write_age + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + integer(I2B),intent(in) :: n_size + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + + ! Regotrack Internals + integer(I4B) :: i,j,k + integer(I4B), parameter :: LUN=7 + real(DP),parameter :: sdepth = 0.1 + real(SP),dimension(user%gridsize,user%gridsize) :: agetop + real(SP),dimension(:),allocatable :: age_prev + real(SP),dimension(:),allocatable :: agedepthtot + integer(kind=8) :: recsize + real(SP) :: stmp + real(SP) :: agetot, age_weighted + type(regolisttype),pointer :: current => null() + real(DP) :: depth, depth_prev + real(SP) :: recyclratio + ! Output multiple "comphisto" files + character(len=255) :: fname + integer(I4B) :: n_age + + ! Executable code + allocate(age_prev(n_size)) + allocate(agedepthtot(n_size)) + agetop = 0.0_SP + + do j=1,user%gridsize + do i=1,user%gridsize + + depth = 0.0 + depth_prev = 0.0 + current => surf(i,j)%regolayer + age_prev(:) = current%regodata%age(:) + agedepthtot = 0.0_SP + do + if (depth > sdepth) then + recyclratio = real( (depth - sdepth) / (depth - depth_prev) ) + agedepthtot(:) = agedepthtot(:) - recyclratio * age_prev(:) + depth = sdepth + exit + end if + depth_prev = depth + depth = depth + current%regodata%thickness + agedepthtot(:) = agedepthtot(:) + current%regodata%age(:) + age_prev(:) = current%regodata%age(:) + current => current%next + end do + + age_weighted = 0.0_SP + do k=1, n_size + age_weighted = age_weighted + agedepthtot(k) * (float(k) - 0.5) * 0.5 + end do + + agetot = sum(agedepthtot(:)) + age_weighted = age_weighted / agetot + if (agetot == 0.0_SP .and. age_weighted == 0.0_SP) then + agetop(i,j) = -0.5 + else + agetop(i,j) = age_weighted + end if + + end do + end do + + deallocate(age_prev,agedepthtot) + + n_age = max(int(icrater/ncrat), 1) + recsize = sizeof(stmp) * user%gridsize * user%gridsize + write(fname,'(a,i6.6)') 'agetop', n_age + open(LUN,file=fname,status='replace',form='unformatted',recl=recsize,access='direct') + write(LUN,rec=1) agetop + close(LUN) + + return +end subroutine io_write_age diff --git a/src/io/io_write_age_depth.f90 b/src/io/io_write_age_depth.f90 new file mode 100644 index 00000000..a1b61f5a --- /dev/null +++ b/src/io/io_write_age_depth.f90 @@ -0,0 +1,83 @@ +!********************************************************************************************************************************** +! +! Unit Name : io_write_age_depth +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Writes new files for terrain grids for age information +! +! Input +! Arguments : +! +! Output +! Arguments : surf : Surface expression matrix +! +! Notes : +! +!********************************************************************************************************************************** +subroutine io_write_age_depth(user,surf,n_size,icrater,ncrat,age,age_2_depth) + use module_globals + use module_io, EXCEPT_THIS_ONE => io_write_age_depth + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + integer(I2B),intent(in) :: n_size + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + real(DP),intent(in) :: age + real(SP),dimension(:,:,:),intent(inout) :: age_2_depth + + ! Regotrack Internals + integer(I4B) :: i,j,k + real(SP),dimension(:),allocatable :: age_prev + real(SP),dimension(:,:),allocatable :: agedepthtot + real(DP) :: depth, depth_prev, recyclratio + real(DP),dimension(5),parameter :: sdepth = [0.3, 3.0, 7.0, 8.0, 9.0] ![0.1, 0.5, 0.8, 1.0, 3.0] ![0.3, 2.0, 4.0, 6.0, 10.0] + type(regolisttype),pointer :: current => null() + integer(I4B) :: n + + ! Executable code + allocate(age_prev(n_size)) + allocate(agedepthtot(n_size,5)) + + agedepthtot = 0.0_SP + + do k = 1, 5 + do j = 1,user%gridsize + do i = 1,user%gridsize + + depth = 0.0 + depth_prev = 0.0 + current => surf(i,j)%regolayer + age_prev(:) = current%regodata%age(:) + do + if (depth > sdepth(k)) then + recyclratio = (depth - sdepth(k)) / (depth - depth_prev) + agedepthtot(:,k) = agedepthtot(:,k) - recyclratio * age_prev(:) + depth = sdepth(k) + exit + end if + depth_prev = depth + depth = depth + current%regodata%thickness + agedepthtot(:,k) = agedepthtot(:,k) + current%regodata%age(:) + age_prev(:) = current%regodata%age(:) + current => current%next + end do + + end do + end do + end do + + n = max( icrater / ncrat, 1) + do k = 1, 5 + age_2_depth(n,1,k) = age + age_2_depth(n,2:n_size+1,k) = agedepthtot(:,k) + end do + + deallocate(age_prev,agedepthtot) + + return +end subroutine io_write_age_depth diff --git a/src/io/io_write_pindex_map.f90 b/src/io/io_write_pindex_map.f90 new file mode 100644 index 00000000..4f35fb55 --- /dev/null +++ b/src/io/io_write_pindex_map.f90 @@ -0,0 +1,48 @@ +!********************************************************************************************************************************** +! +! Unit Name : io_write_pindex_map +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : write files about pindex map (scoring old melts) +! +! Input +! Arguments : +! +! Output +! Arguments : surf : Surface expression matrix +! +! Notes : +! +!********************************************************************************************************************************** +subroutine io_write_pindex_map(user,pindex,icrater,ncrat) + use module_globals + use module_io, EXCEPT_THIS_ONE => io_write_pindex_map + implicit none + + ! Arguments + type(usertype),intent(in) :: user + integer(I2B),dimension(:,:),intent(inout) :: pindex + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + + ! Regotrack Internals + integer(I4B), parameter :: LUN=7 + integer(kind=8) :: recsize + integer(I2B) :: itmp + ! Output multiple "pindex" files + character(len=255) :: fname + integer(I2B) :: n_age + + ! Executable code + + n_age = int(icrater/ncrat) + recsize = sizeof(itmp) * user%gridsize * user%gridsize + write(fname,'(a,i6.6)') 'pindex', n_age + open(LUN,file=fname,status='replace',form='unformatted',recl=recsize,access='direct') + write(LUN,rec=1) pindex + close(LUN) + + return +end subroutine io_write_pindex_map diff --git a/src/io/io_write_regotrack.f90 b/src/io/io_write_regotrack.f90 index 91ea33db..a6f3c2e1 100644 --- a/src/io/io_write_regotrack.f90 +++ b/src/io/io_write_regotrack.f90 @@ -30,13 +30,17 @@ subroutine io_write_regotrack(user,surf) integer(I4B), parameter :: LUN=7 integer(I4B), parameter :: LUM=8 integer(I4B), parameter :: LUC=9 + integer(I4B), parameter :: LUA=10 type(regolisttype),pointer :: current => null() - real(DP),dimension(user%gridsize,user%gridsize) :: regotop,comp,melt + real(DP),dimension(user%gridsize,user%gridsize) :: regotop,comp,melt + real(SP),dimension(user%gridsize,user%gridsize) :: agetop + real(SP),dimension(user%gridsize,user%gridsize,60) :: age integer(I4B),dimension(user%gridsize,user%gridsize) :: stacks_num integer(kind=8) :: recsize real(DP) :: dtmp + real(SP) :: stmp integer(I4B) :: itmp - real(DP),dimension(user%gridsize,user%gridsize) :: comptop!,surface + real(DP),dimension(user%gridsize,user%gridsize) :: comptop, rego real(DP),dimension(:),allocatable :: marehisto real(DP) :: mare, z @@ -51,24 +55,47 @@ subroutine io_write_regotrack(user,surf) logical :: exist ! Executable code - open(LUN,file=MELTFILE,status='replace',form='unformatted') - open(LUM,file=REGOFILE,status='replace',form='unformatted') - open(LUC,file=COMPFILE,status='replace',form='unformatted') + ! Output mulitple "comphisto" files + inquire(file=clockfile, exist=exist) + if (exist) then + open(LUN,file=clockfile,status='old') + read(LUN,*) tictoc + else + write(*,*) clockfile,' is missing!' + end if + tictoc = tictoc + 1 + close(LUN) + open(LUN,file=clockfile,status='replace') + write(LUN,*) tictoc + close(LUN) + + write(fname,'(a,i4.4)') 'surface_melt',tictoc + open(LUN,file=fname,status='replace',form='unformatted') + write(fname,'(a,i4.4)') 'surface_rego',tictoc + open(LUM,file=fname,status='replace',form='unformatted') + write(fname,'(a,i4.4)') 'surface_comp',tictoc + open(LUC,file=fname,status='replace',form='unformatted') + write(fname,'(a,i4.4)') 'surface_age',tictoc + open(LUA,file=fname,status='replace',form='unformatted') do j=1,user%gridsize do i=1,user%gridsize stacks_num(i,j) = 0 current => surf(i,j)%regolayer comptop(i,j) = current%regodata%comp + rego(i,j) = current%regodata%thickness + agetop(i,j) = current%regodata%age(1) do if (.not. associated(current)) exit stacks_num(i,j) = stacks_num(i,j) + 1 regotop(i,j) = current%regodata%thickness comp(i,j) = current%regodata%comp melt(i,j) = current%regodata%meltfrac + age(i,j,:)= current%regodata%age(:) write(LUM) regotop(i,j) write(LUC) comp(i,j) write(LUN) melt(i,j) + write(LUA) age(i,j,:) current => current%next end do end do @@ -76,25 +103,16 @@ subroutine io_write_regotrack(user,surf) close(LUN) close(LUM) close(LUC) + close(LUA) recsize = sizeof(dtmp) * user%gridsize * user%gridsize - open(LUN,file='comptop.dat',status='replace',form='unformatted',recl=recsize,access='direct') - write(LUN,rec=1) comptop + open(LUN,file='agetop.dat',status='replace',form='unformatted',recl=recsize,access='direct') + write(LUN,rec=1) agetop close(LUN) - ! Output mulitple "comphisto" files - inquire(file=clockfile, exist=exist) - if (exist) then - open(LUN,file=clockfile,status='old') - read(LUN,*) tictoc - else - write(*,*) clockfile,' is missing!' - end if - tictoc = tictoc + 1 - close(LUN) - - open(LUN,file=clockfile,status='replace') - write(LUN,*) tictoc + recsize = sizeof(dtmp) * user%gridsize * user%gridsize + open(LUN,file='comptop.dat',status='replace',form='unformatted',recl=recsize,access='direct') + write(LUN,rec=1) comptop close(LUN) allocate(marehisto(user%gridsize)) @@ -114,8 +132,14 @@ subroutine io_write_regotrack(user,surf) close(LUN) deallocate(marehisto) + recsize = sizeof(dtmp) * user%gridsize * user%gridsize + open(LUN,file='regotop.dat',status='replace',form='unformatted',recl=recsize,access='direct') + write(LUN,rec=1) rego + close(LUN) + recsize = sizeof(itmp) * user%gridsize * user%gridsize - open(LUN,file=STACKNUMFILE,status='replace',form='unformatted',recl=recsize,access='direct') + write(fname,'(a,i4.4)') 'surface_stacknum',tictoc + open(LUN,file=fname,status='replace',form='unformatted',recl=recsize,access='direct') write(LUN,rec=1) stacks_num close(LUN) diff --git a/src/io/io_write_surf.f90 b/src/io/io_write_surf.f90 index 9755ed02..5f407581 100644 --- a/src/io/io_write_surf.f90 +++ b/src/io/io_write_surf.f90 @@ -53,12 +53,6 @@ subroutine io_write_surf(user,surf) end do close(LUN) - open(LUN,file=TIMEFILE,status='replace',form='unformatted',recl=recsize,access='direct') - do i=1,user%numlayers - write(LUN,rec=i) surf%timestamp(i) - end do - close(LUN) - recsize = sizeof(stmp) * user%gridsize * user%gridsize open(LUN,file=POSFILE,status='replace',form='unformatted',recl=recsize,access='direct') do i=1,user%numlayers @@ -71,10 +65,6 @@ subroutine io_write_surf(user,surf) !call io_write_regodist(user,surf) call io_write_regotrack(user,surf) end if - - ! write data from porosity analysis - if (user%doporosity) call io_write_porotrack(user, surf) - ! if (user%docrustal_thinning) then ! recsize = sizeof(itmp) * user%gridsize * user%gridsize ! open(LUN,file=THICKFILE,status='replace',form='unformatted',recl=recsize,access='direct') diff --git a/src/io/io_write_tally.f90 b/src/io/io_write_tally.f90 index a8df6774..64dff416 100644 --- a/src/io/io_write_tally.f90 +++ b/src/io/io_write_tally.f90 @@ -42,7 +42,7 @@ subroutine io_write_tally(tdist,tlist,odist,olist,oposlist,depthdiam) distl = size(tdist,2) allocate(oldtdist(distc,distl)) 1000 format(3F16.4,2F15.0,F15.6) -2000 format(ES23.15,1X,7(ES14.6,1X,:)) +2000 format(ES23.15,1X,6(ES14.6,1X,:)) oldtdist = 0._DP inquire(file=tdistfile, exist=file_exists) @@ -74,7 +74,7 @@ subroutine io_write_tally(tdist,tlist,odist,olist,oposlist,depthdiam) close(LUN) open(LUN, FILE=OLISTFILE, status='REPLACE') - write(LUN,'("#Dcrat(m) xpos(m) ypos(m) time(y) depth/diam")' ) + write(LUN,'("#Dcrat(m) xpos(m) ypos(m) depth/diam")' ) do i=1,onum write(LUN,2000) olist(i),oposlist(:,i),depthdiam(i) @@ -83,7 +83,7 @@ subroutine io_write_tally(tdist,tlist,odist,olist,oposlist,depthdiam) open(LUN, FILE=TLISTFILE, status='REPLACE') - write(LUN,'("#Dcrat(m) Dimp(m) xpos(m) ypos(m) vimp(m/s) sinang time(y)")') + write(LUN,'("#Dcrat(m) Dimp(m) xpos(m) ypos(m) vimp(m/s) sinang")') do i=1,size(tlist,2) write(LUN,2000) tlist(:,i) end do diff --git a/src/io/module_io.f90 b/src/io/module_io.f90 index 71656675..b7da8ef8 100644 --- a/src/io/module_io.f90 +++ b/src/io/module_io.f90 @@ -66,15 +66,6 @@ subroutine io_read_regotrack(user,surf) end subroutine io_read_regotrack end interface - interface - subroutine io_read_porotrack(user,surf) - use module_globals - implicit none - type(usertype),intent(in) :: user - type(surftype),dimension(:,:),intent(out) :: surf - end subroutine io_read_porotrack - end interface - interface subroutine io_write_surf(user,surf) use module_globals @@ -93,15 +84,6 @@ subroutine io_write_regotrack(user,surf) end subroutine io_write_regotrack end interface - interface - subroutine io_write_porotrack(user,surf) - use module_globals - implicit none - type(usertype),intent(in) :: user - type(surftype),dimension(:,:),intent(in) :: surf - end subroutine io_write_porotrack - end interface - interface subroutine io_crater_profile(user,surf) use module_globals @@ -207,13 +189,41 @@ subroutine io_splash() end subroutine io_splash end interface - !interface - ! subroutine io_write_regodist(user,surf) - ! use module_globals - ! implicit none - ! type(usertype),intent(in) :: user - ! type(surftype),dimension(:,:),intent(in) :: surf - ! end subroutine io_write_regodist - !end interface + interface + subroutine io_write_age(user,surf,n_size,icrater,ncrat) + use module_globals + implicit none + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + integer(I2B),intent(in) :: n_size + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + end subroutine io_write_age + end interface + + interface + subroutine io_write_pindex_map(user,pindex,icrater,ncrat) + use module_globals + implicit none + type(usertype),intent(in) :: user + integer(I2B),dimension(:,:),intent(inout) :: pindex + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + end subroutine io_write_pindex_map + end interface + + interface + subroutine io_write_age_depth(user,surf,n_size,icrater,ncrat,age,age_2_depth) + use module_globals + implicit none + type(usertype),intent(in) :: user + type(surftype),dimension(:,:),intent(in) :: surf + integer(I2B),intent(in) :: n_size + integer(I8B),intent(in) :: icrater + integer(I8B),intent(in) :: ncrat + real(DP),intent(in) :: age + real(SP),dimension(:,:,:),intent(inout) :: age_2_depth + end subroutine io_write_age_depth + end interface end module module_io diff --git a/src/main/CTEM.f90 b/src/main/CTEM.f90 index 24d5e8a3..c02112dc 100644 --- a/src/main/CTEM.f90 +++ b/src/main/CTEM.f90 @@ -48,7 +48,7 @@ program CTEM logical :: restart ! F = new run (start with a fresh surface) integer(I8B) :: totalimpacts ! Total number of impacts ever produced integer(I4B) :: ncount ! Current count in ctem_driver IDL run -integer(I4B) :: n, xp, yp ! Size of random number generator seed array +integer(I4B) :: n, xp, yp, i ! Size of random number generator seed array integer(I4B),dimension(:),allocatable :: seedarr ! Random number generator seed array real(DP) :: curyear real(DP) :: mass @@ -60,6 +60,7 @@ program CTEM integer(I4B) :: ntotkilled integer(I8B) :: ntotcrat integer(I4B) :: onum +real(DP) :: lambda !$ real(DP) :: t1,t2 real(DP),dimension(:,:),allocatable :: nflux @@ -159,15 +160,6 @@ program CTEM end do end if -! If doporosity is true, then destroy the linked list for porosity -if (user%doporosity) then - do yp = 1, user%gridsize - do xp = 1, user%gridsize - call util_destroy_list(surf(xp,yp)%porolayer) - end do - end do -end if - ! Deallocate all the allocatables deallocate(seedarr) deallocate(surf,prod,vdist,pdist,crtscl,truedist,truelist,obsdist,obslist,nflux,production_list) diff --git a/src/regolith/.regolith_streamtube_volume_func.f90.swp b/src/regolith/.regolith_streamtube_volume_func.f90.swp new file mode 100644 index 00000000..7521f00f Binary files /dev/null and b/src/regolith/.regolith_streamtube_volume_func.f90.swp differ diff --git a/src/regolith/module_regolith.f90 b/src/regolith/module_regolith.f90 index 516623bb..527e76f8 100644 --- a/src/regolith/module_regolith.f90 +++ b/src/regolith/module_regolith.f90 @@ -76,7 +76,8 @@ end subroutine regolith_transport end interface interface - subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,rm) + subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,& + rm,vsq,age,age_resolution) use module_globals implicit none type(usertype),intent(in) :: user @@ -87,53 +88,68 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, type(ejbtype),dimension(ejtble),intent(in) :: ejb real(DP),intent(in) :: xp,yp,lrad,ebh integer(I4B),intent(in) :: xpi,ypi - real(DP),intent(in) :: rm + real(DP),intent(in) :: rm, vsq, age, age_resolution end subroutine regolith_streamtube end interface interface - subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,vseg,newlayer,rm) + subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,rsh,depthb) use module_globals implicit none type(usertype),intent(in) :: user type(surftype),intent(inout) :: surfi - real(DP),intent(in) :: deltar,ri,rip1,eradi,erado,vseg,rm + real(DP),intent(in) :: deltar,ri,rip1,eradi,erado type(regodatatype),intent(inout) :: newlayer + real(DP),intent(out) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints, rsh, depthb end subroutine regolith_traverse_streamtube end interface interface - subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,newlayer,rm) + subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,vol) use module_globals implicit none type(usertype),intent(in) :: user - type(surftype),intent(inout) :: surfi - real(DP),intent(in) :: deltar,ri,rip1,eradi,vseg - type(regodatatype),intent(inout) :: newlayer - real(DP),intent(in) :: rm + type(surftype),intent(in) :: surfi + real(DP),intent(in) :: deltar,ri,rip1,eradi + type(regodatatype),intent(inout) :: newlayer + real(DP),intent(out) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints + real(DP),intent(inout) :: vol end subroutine regolith_subpixel_streamtube end interface interface - subroutine regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,vseg,newlayer,rm) + subroutine regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,newlayer,vmare,& + totseb,age_collector,xmints,xsfints,depthb) use module_globals implicit none type(usertype),intent(in) :: user type(surftype),intent(in) :: surfi - real(DP),intent(in) :: thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,vseg,rm + real(DP),intent(in) :: thetast,ri,rip1,zmin,zmax,erad,eradi,deltar type(regodatatype),intent(inout) :: newlayer + real(DP),intent(inout) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints, depthb end subroutine regolith_streamtube_lineseg end interface interface - subroutine regolith_streamtube_head(user,surfi,deltar,newlayer,eradi,rm) + subroutine regolith_streamtube_head(user,surfi,deltar,totmare,tots,age_collector) use module_globals implicit none type(usertype),intent(in) :: user type(surftype),intent(in) :: surfi real(DP),intent(in) :: deltar - type(regodatatype),intent(inout) :: newlayer - real(DP),intent(in) :: eradi,rm + real(DP),intent(inout) :: totmare,tots + real(SP),dimension(:),intent(inout) :: age_collector end subroutine regolith_streamtube_head end interface @@ -228,4 +244,73 @@ subroutine regolith_depth_model(user,domain,finterval,nflux,p) end subroutine regolith_depth_model end interface + interface + subroutine regolith_melt_glass(user,crater,age,age_resolution,ebh,rm,eradc,lrad,deltar,newlayer,xmints) + use module_globals + type(usertype),intent(in) :: user + type(cratertype),intent(in) :: crater + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),intent(in) :: ebh + real(DP),intent(in) :: rm + real(DP),intent(in) :: eradc + real(DP),intent(in) :: lrad + real(DP),intent(out) :: deltar + type(regodatatype),intent(out) :: newlayer + real(DP),intent(out) :: xmints + end subroutine regolith_melt_glass + end interface + + interface + subroutine regolith_superdomain(user,crater,domain,regolayer,ejdistribution,xpi,ypi,age,age_resolution,rm,depthb) + use module_globals + type(usertype),intent(in) :: user + type(cratertype),intent(inout) :: crater + type(domaintype),intent(in) :: domain + type(regolisttype),pointer :: regolayer + real(DP),intent(in) :: ejdistribution + integer(I4B),intent(in) :: xpi, ypi + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),intent(in) :: rm + real(DP),intent(in) :: depthb + end subroutine regolith_superdomain + end interface + + interface + subroutine regolith_melt_zone_superdomain(user,crater,domain,rm,depthb) + use module_globals + type(usertype),intent(in) :: user + type(cratertype),intent(inout) :: crater + type(domaintype),intent(in) :: domain + real(DP),intent(out) :: rm, depthb + end subroutine regolith_melt_zone_superdomain + end interface + + interface + function regolith_streamtube_volume_func(eradi,ri,rip1,deltar) result(vol) + use module_globals + implicit none + real(DP), intent(in) :: eradi, ri, rip1, deltar + real(DP) :: vol + end function regolith_streamtube_volume_func + end interface + + interface + subroutine regolith_shock_damage_zone(crater,rm,eradi,depthb,xsfints) + use module_globals + type(cratertype),intent(in) :: crater + real(DP),intent(in) :: rm, eradi, depthb + real(DP),intent(out) :: xsfints + end subroutine regolith_shock_damage_zone + end interface + + interface + function regolith_shock_damage(erad,deltar,xmints,xsfints,xleft,xright) result(vsh) + use module_globals + real(DP),intent(in) :: erad, deltar, xmints, xsfints, xleft, xright + real(DP) :: vsh + end function regolith_shock_damage + end interface + end module diff --git a/src/regolith/regolith_melt_func.f90 b/src/regolith/regolith_melt_func.f90 index 85cf196e..3cc1c430 100755 --- a/src/regolith/regolith_melt_func.f90 +++ b/src/regolith/regolith_melt_func.f90 @@ -75,5 +75,5 @@ function regolith_melt_func(r,depthb,erad) result(vol) else if (yints > ymax) then vol = vol0 + PI/6.0 * erad**3 * (1.0 - 4.0*xints/erad)**1.5 end if - + end function regolith_melt_func diff --git a/src/regolith/regolith_melt_glass.f90 b/src/regolith/regolith_melt_glass.f90 new file mode 100644 index 00000000..339bcce1 --- /dev/null +++ b/src/regolith/regolith_melt_glass.f90 @@ -0,0 +1,162 @@ +!****f* regolith/regolith_melt_glass +! Name +! regolith_melt_glass -- Calculate melt glass within a stream tube during excavation stage. +! SYNOPSIS +! This uses +! * module_globals +! * module_util +! * module_regolith +! +! call regolith_melt_glass(user,age,ebh,deltar,newlayer) +! +! DESCRIPTION +! +! The modeling of production of glass spherules is based on the terrestrial +! tektites and microtektites record. A direct cutoff (no glass spherules +! passing a specific landing distance) is applied. Future work can be done to +! interpret the efficiency of glass spherule production from their trajectory +! from iSale and check interaction between hot ejecta, vapor, and cold ejecta. +! +! ARGUMENTS +! Input +! * user -- The user-defined variables from the input file +! * age -- The age of modeled glass spherule which is equivalent to the +! formtion of its parent impact crater. +! * ebh -- The thickness of ejecta blanket +! +! Output +! * deltar -- The size or cross section's radius of a stream tube +! * newlayer -- The linked list that contains ejecta's properites. +! +! NOTES +! In future, a segment may contain multicomponent, and as a result the advanced analysis is needed. +! +!*** + +!********************************************************************************************************************************** +! +! Unit Name : regolith_melt_glass +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Determine an abundance of glass spherules within a stream tube +! +! +! Input +! Arguments : +! +! Output +! Arguments : +! newlayer +! deltar +! +! +! Notes : +! +!********************************************************************************************************************************** +subroutine regolith_melt_glass(user,crater,age,age_resolution,ebh,rm,eradc,lrad,deltar,newlayer,xmints) + use module_globals + use module_util + use module_regolith, EXCEPT_THIS_ONE => regolith_melt_glass + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(cratertype),intent(in) :: crater + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),intent(in) :: ebh + real(DP),intent(in) :: rm + real(DP),intent(in) :: eradc + real(DP),intent(in) :: lrad + real(DP),intent(out) :: deltar + type(regodatatype),intent(out) :: newlayer + real(DP),intent(out) :: xmints + + ! Internal variables + ! Stream tube parameters + real(DP),parameter :: a = 0.936457 ! Fitting parameters for the relation between height difference and a radial position of a stream tube + real(DP),parameter :: b = 1.12368 + + ! Constrain the tangital tube's volume with CTEM result + real(DP) :: k1,k2,k3,k4,c1,c2 + + ! Calculate vapor and melt zone intersection point with stream tubes + real(DP) :: vst, erado, eradi + real(DP) :: cosvints, sinvints, xvints, rints + real(DP) :: volv1, melt, volm1, depthb + real(DP) :: q1, q2, q3 + real(DP) :: thetaq + integer(I2B) :: n_age + ! Estimate melt droplet size + real(DP),parameter :: b_exponent = -0.97 + real(DP) :: cvpgsqr, p1, p2, p3, p4, p5 + real(DP) :: dm + + + ! Executalbe code + ! ******************************** Size of a tangential stream tube ********************************************** + ! Determine the radius of a tangential-shaped circule stream tube at the head of the stream tube + ! The ejecta blanket thickness data from CTEM will be used to constrain our tube, then two calibrated + ! streamlines will be given for estimation of thickness of a layer inside a stream tube + ! A cubic function is given after considering the constraint of ejecta blanket thickness by CTEM, so the cubic + ! function's solution is based on Nmuerical Recipe: Fortran 77, p.178-200, which is believed in a optimized way to do so! + ! The total volume of a stream tube is given: + ! Vst = (0.25_DP * PI * deltar**2 * a**2 * eradi / b *(tan(b)-b)) + sqrt(2.0_DP)/2.0_DP*PI*deltar**3 + + k1 = PI * (0.5 * a)**2 * (tan(b) - b) + k2 = ebh * (user%pix)**2 + k3 = eradc/b + k4 = sqrt(3.0_DP)/2.0_DP * PI - k1/b + c1 = k1 * k3 /k4 + c2 = k2/k4 + deltar = regolith_cubic_func(c1,c2) + erado = eradc + deltar + eradi = eradc - deltar + + ! ******************************* Start to estimate STREAM TUBE'S volume in layering systerm *************************** + ! Purpose: How much layer material are contained in a stream tube? + ! Intro: There are two volume approximation with regarding to discretized stream tubes. First, the subpixel approximation + ! is important to distal landing ejecta, and the advantage of it is that you can use Maxwell Z model equation to calculate + ! the total volume of a stream tube if it is contained inside the whole layer. For the small craters or subpixel craters, + ! this method will be used frequently. + + vst = (0.25_DP * PI * deltar**2 * a**2 * eradi / b *(tan(b)-b)) + sqrt(2.0_DP)/2.0_DP*PI*deltar**3 + + newlayer%meltfrac = 0.0_DP ! default value: no melt (zero) + newlayer%thickness = ebh ! default value: stream tube's volume = paraboloid shell's volume + newlayer%comp = 0.0_DP + rints = sqrt(rm**2 - (crater%imp/2.0)**2) + cosvints = eradi / (crater%imp + eradi) + sinvints = sqrt(1.0 - cosvints**2) + xvints = eradi * ( 1.0 - cosvints) * sinvints + volv1 = regolith_streamtube_volume_func(eradi,0.0_DP,xvints,deltar) + melt = 0.0_DP + newlayer%age(:) = 0.0_SP + if (eradi <= rints) then + volm1 = vst - volv1 + melt = volm1 + newlayer%meltfrac = 1.0 + xmints = rints + else if (eradi > rints) then + depthb = crater%imp / 2.0 + q1 = 1.0 / (1.0 + 2.0 * depthb / eradi) + q2 = -1.0 - q1 + q3 = ( 1.0 + (depthb**2 - rm**2)/eradi**2 ) * q1 + thetaq = acos( -0.5 * q2 - 0.5 * sqrt(q2**2 - 4.0 * q3) ) + xmints = eradi * (1.0 - cos(thetaq)) * sin(thetaq) + volm1 = regolith_streamtube_volume_func(eradi,0.0_DP,xmints,deltar) + melt = volm1 - volv1 + newlayer%meltfrac = melt/vst + end if + + n_age = max(ceiling(age / age_resolution), 1) + if (lrad >= RAD_GP * crater%rad) then + newlayer%age(n_age) = melt / (user%pix * user%pix) + else + newlayer%age(n_age) = 0.0_SP + end if + + return +end subroutine regolith_melt_glass diff --git a/src/regolith/regolith_melt_zone_superdomain.f90 b/src/regolith/regolith_melt_zone_superdomain.f90 new file mode 100644 index 00000000..20d91d0d --- /dev/null +++ b/src/regolith/regolith_melt_zone_superdomain.f90 @@ -0,0 +1,57 @@ +!********************************************************************************************************************************** +! +! Unit Name : regolith_melt_zone_superdomain +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Estimate the melt zone size of a superdomain crater +! +! +! Input +! Arguments : +! +! Output +! Arguments : +! +! +! Notes : +! +!********************************************************************************************************************************** +subroutine regolith_melt_zone_superdomain(user,crater,domain,rm,depthb) + use module_globals + use module_util + use module_regolith, EXCEPT_THIS_ONE => regolith_melt_zone_superdomain + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(cratertype),intent(inout) :: crater + type(domaintype),intent(in) :: domain + real(DP),intent(out) :: rm, depthb + + ! Internal variables + real(DP) :: cvpg + real(DP) :: vimp, sinimp, rimp, dimp + real(DP) :: pvelv, pmass + real(DP) :: c1, c2, pitwo, pithree, pifour, pivolg + + + crater%grad = crater%rad + cvpg = sqrt(2.0_DP) / 0.85_DP * ( user%mu_r / (user%mu_r + 1) ) + vimp = domain%rmsvel + crater%impvel = vimp + crater%sinimpang = sqrt(2.0_DP) / 2.0_DP + pvelv = vimp * crater%sinimpang + pmass = 4 * THIRD * PI * user%prho + c1 = 1.0_DP + 0.5_DP * user%mu_b + c2 = (-3 * user%mu_r) / (2.0 + user%mu_r) + pitwo = (user%gaccel / pvelv**2) + pifour = user%trho_r / user%prho + rimp = ( PI/(3.0 * user%kv_r) * (crater%grad)**3 * (pitwo**(-1.0 * c2)) * & + (pifour**(c2/3.0)) * user%trho_r / pmass )**(1.0 / (3.0 + c2)) + dimp = rimp * 2.0_DP + crater%imp = dimp + call regolith_melt_zone(user,crater,dimp,vimp,rm,depthb) + return +end subroutine regolith_melt_zone_superdomain diff --git a/src/regolith/regolith_mix.f90 b/src/regolith/regolith_mix.f90 index fc4017c5..dbd08e75 100644 --- a/src/regolith/regolith_mix.f90 +++ b/src/regolith/regolith_mix.f90 @@ -36,14 +36,16 @@ subroutine regolith_mix(surfi,mixing_depth) call util_traverse_pop(surfi%regolayer,mixing_depth,poppedlist_top) newlayer%thickness = 0.0_DP - newlayer%comp = 0.0_DP - newlayer%meltfrac = 0.0_DP + newlayer%comp = 0.0_DP + newlayer%meltfrac = 0.0_DP + newlayer%age(:) = 0.0_DP poppedlist => poppedlist_top do while(associated(poppedlist%next)) newlayer%thickness = newlayer%thickness + poppedlist%regodata%thickness - newlayer%comp = newlayer%comp + poppedlist%regodata%thickness * poppedlist%regodata%comp - newlayer%meltfrac = newlayer%meltfrac + poppedlist%regodata%thickness * poppedlist%regodata%meltfrac + newlayer%comp = newlayer%comp + poppedlist%regodata%thickness * poppedlist%regodata%comp + newlayer%meltfrac = newlayer%meltfrac + poppedlist%regodata%thickness * poppedlist%regodata%meltfrac + newlayer%age(:) = newlayer%age(:) + poppedlist%regodata%age(:) poppedlist => poppedlist%next end do diff --git a/src/regolith/regolith_shock_damage.f90 b/src/regolith/regolith_shock_damage.f90 new file mode 100644 index 00000000..e7890be7 --- /dev/null +++ b/src/regolith/regolith_shock_damage.f90 @@ -0,0 +1,75 @@ +!****f* regolith/regolith_shock_damage_zone +! Name +! regolith_shock_damage -- Calculate the radius of shock damage zone +! and the intersection point between shock damage zone and the stream +! tube +! SYNOPSIS +! This uses +! * module_globals +! * module_regolith +! +! call regolith_shock_damage_zone(user,crater,rm,eradi,depthb,xsfints) +! +! DESCRIPTION +! +! This subroutine calculates the radius of shock damage zone by a +! given shock pressure, setting from globals module, and returns the +! intersection point's x location between shock zone and a given +! stream tube. +! +! ARGUMENTS +! Input +! * user -- The user-defined variables from the input file +! * crater -- Crater dimension container +! * rm -- Radius of melt zone +! * eradi -- The inner radial distance of a stream tube +! * depthb -- The burial depth of shock pressure decay zone +! +! Output +! * xsfints -- X position of intersection point between shock zone +! and stream tube +! +!*** + +!********************************************************************************************************** +! +! Unit Name : regolith_shock_damage_zone(user,crater,rm,eradi,depthb,xsfints) +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Calculate the intersection point between shock damage +! zone and the stream +! +! +! Input +! Arguments : +! +! Output +! Arguments : xsfints :: +! +! +! Notes : +! +!*********************************************************************************************************** +function regolith_shock_damage(erad,deltar,xmints,xsfints,xleft,xright) result(vsh) + use module_globals + use module_regolith, EXCEPT_THIS_ONE => regolith_shock_damage + implicit none + + ! Arguments + real(DP),intent(in) :: erad, deltar, xmints, xsfints, xleft, xright + real(DP) :: vsh + real(DP) :: x_low_sh, x_up_sh + + if (xsfints > xmints) then + x_low_sh = max(xmints,xleft) + x_up_sh = min(xsfints,xright) + vsh = regolith_streamtube_volume_func(erad,x_low_sh,x_up_sh,deltar) + else + vsh = 0.0_DP + end if + + return + +end function regolith_shock_damage diff --git a/src/regolith/regolith_shock_damage_zone.f90 b/src/regolith/regolith_shock_damage_zone.f90 new file mode 100644 index 00000000..48eef234 --- /dev/null +++ b/src/regolith/regolith_shock_damage_zone.f90 @@ -0,0 +1,98 @@ +!****f* regolith/regolith_shock_damage_zone +! Name +! regolith_shock_damage -- Calculate the radius of shock damage zone +! and the intersection point between shock damage zone and the stream +! tube +! SYNOPSIS +! This uses +! * module_globals +! * module_regolith +! +! call regolith_shock_damage_zone(user,crater,rm,eradi,depthb,xsfints) +! +! DESCRIPTION +! +! This subroutine calculates the radius of shock damage zone by a +! given shock pressure, setting from globals module, and returns the +! intersection point's x location between shock zone and a given +! stream tube. +! +! ARGUMENTS +! Input +! * user -- The user-defined variables from the input file +! * crater -- Crater dimension container +! * rm -- Radius of melt zone +! * eradi -- The inner radial distance of a stream tube +! * depthb -- The burial depth of shock pressure decay zone +! +! Output +! * xsfints -- X position of intersection point between shock zone +! and stream tube +! +!*** + +!********************************************************************************************************** +! +! Unit Name : regolith_shock_damage_zone(user,crater,rm,eradi,depthb,xsfints) +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Calculate the intersection point between shock damage +! zone and the stream +! +! +! Input +! Arguments : +! +! Output +! Arguments : xsfints :: +! +! +! Notes : +! +!*********************************************************************************************************** +subroutine regolith_shock_damage_zone(crater,rm,eradi,depthb,xsfints) + use module_globals + use module_regolith, EXCEPT_THIS_ONE => regolith_shock_damage_zone + implicit none + + ! Arguments + type(cratertype),intent(in) :: crater + real(DP),intent(in) :: rm, eradi, depthb + real(DP),intent(out) :: xsfints + + ! Parameters for shock pressure calculation based on numerical modeling + ! results (Montuex and Pierazo) + real(DP),parameter :: rho_dunite = 3320.0 + real(DP),parameter :: c_dunite = 6500.0 + real(DP),parameter :: s_dunite = 0.9 + real(DP),parameter :: n = -2.85 + real(DP) :: pmax, up + real(DP) :: rsh, xshints0 + real(DP) :: q1, q2, q3, thetaq + + ! Calculate the radius of shock pressure decay zone by a given shock + ! P(r) = Pmax * (r/r_p)**(n), where n is negative and we use -3 (fast decay + ! that may be accounted for by acoustic fluidization). + ! Make Pf equal to P(r) and solve the variable of "r", which becomes "rsh" in + ! the following. We assume the projectile and target are the same materials. + ! The maximum peak shock pressure is estimated from planar impact + up = crater%impvel * 0.5 + pmax = rho_dunite * (c_dunite + s_dunite * up) * up + rsh = (crater%imp/2.0) * (PF / pmax)**(1.0/n) + xshints0 = sqrt(rsh**2 - (crater%imp / 2.0)**2) + + if (eradi <= xshints0) then + xsfints = xshints0 + else if (eradi > xshints0) then + q1 = 1.0 / (1.0 + 2.0 * depthb / eradi) + q2 = -1.0 - q1 + q3 = (1.0 + (depthb**2 - rsh**2)/eradi**2) * q1 + thetaq = acos( -0.5 * q2 - 0.5 * sqrt(q2**2 - 4.0 * q3) ) + xsfints = eradi * (1.0 - cos(thetaq)) * sin(thetaq) + end if + + return + +end subroutine regolith_shock_damage_zone diff --git a/src/regolith/regolith_streamtube.f90 b/src/regolith/regolith_streamtube.f90 index 46c6db85..9b07af8a 100644 --- a/src/regolith/regolith_streamtube.f90 +++ b/src/regolith/regolith_streamtube.f90 @@ -56,7 +56,7 @@ ! Notes : ! !********************************************************************************************************************************** -subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,rm) +subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi,lrad,ebh,rm,vsq,age,age_resolution) use module_globals use module_util use module_regolith, EXCEPT_THIS_ONE => regolith_streamtube @@ -71,7 +71,7 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, type(ejbtype),dimension(ejtble),intent(in) :: ejb real(DP),intent(in) :: xp,yp,lrad,ebh integer(I4B),intent(in) :: xpi,ypi - real(DP),intent(in) :: rm + real(DP),intent(in) :: rm, vsq, age, age_resolution ! Traversing a linked list real(DP),parameter :: a = 0.936457 ! Fitting parameters for the relation between height difference and a radial position of a stream tube @@ -88,7 +88,7 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, integer(I4B) :: i,j,k,toti,totj,toty,cnt,xstpi,ystpi real(DP) :: vtot,vseg,ri,rip1,xc,yc,thetast real(DP) :: vst,vbody,rbody,vmare,totmare,totseb,tots - type(regodatatype) :: newlayer, sumlayer + type(regodatatype) :: newlayer ! Constrain the tangital tube's volume with CTEM result real(DP) :: k1,k2,k3,k4,c1,c2 @@ -102,11 +102,17 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, ! Monte Carlo method for two layers system !real(DP) :: compnohead,compmc,mceb - - ! Fresh melt's calculation - real(DP) :: meltfrac, melt, volm1, volv1 + ! Melt vs glass variables + real(DP) :: meltfrac, melt, volm1, volv1, vol real(DP) :: xm, sinvints, cosvints, rvints, rmints, xvints - real(DP) :: cosq1, cosq2, thetaq, depthb, q1, q2, q3, xmints + real(DP) :: thetaq, depthb, q1, q2, q3, xmints + + ! Shock fragmentation variables + real(DP) :: xsfints, rsh + + ! Melt vs age estimation + real(SP),dimension(MAXAGEBINS) :: age_collector + integer(I2B) :: n_age ! Executalbe code @@ -120,26 +126,22 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, if (k==ejtble) then logdelta = logtablerad - ejb(k - 1)%lrad frac = (loglrad - ejb(k-1)%lrad) / logdelta - eradc = exp(ejb(k-1)%erad) + ((exp(ejb(k)%erad) - exp(ejb(k-1)%erad)) * frac) - ! frac = (loglrad - logtablerad) / logdelta - ! eradc = ejb(k)%erad - ((ejb(k)%erad - LOGVSMALL) * frac) + eradc = ejb(k-1)%erad + ((ejb(k)%erad - ejb(k-1)%erad) * frac) else logdelta = ejb(k + 1)%lrad - logtablerad frac = (loglrad - logtablerad) / logdelta - eradc = exp(ejb(k)%erad) - ((exp(ejb(k)%erad) - exp(ejb(k+1)%erad)) * frac) + eradc = ejb(k)%erad - ((ejb(k)%erad - ejb(k+1)%erad) * frac) end if if (eradc<=0.0_DP) then write(*,*) k,ebh,crater%ejdis,lrad,exp(ejb(k-1)%lrad),exp(ejb(k)%lrad),eradc,ejb(k-1)%erad,ejb(k)%erad stop end if - + ! ********* Calculate the height difference between two streamlines that define a stream tube with varying radial position ******* xl = xp - crater%xl yl = yp - crater%yl phi = atan(yl/xl) - !toti = ceiling((eradc * abs(xl)/lrad - 0.5_DP * user%pix) / user%pix) ! Refer to the definition of CTEM in ejecta_emplace.f90 - !totj = ceiling((eradc * abs(yl)/lrad - 0.5_DP * user%pix) / user%pix) ! toti = floor((eradc * abs(xl)/lrad) / user%pix) totj = floor((eradc * abs(yl)/lrad) / user%pix) ! *************************** Intersection points with grid lines ************************************************ @@ -156,44 +158,28 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, xints(cnt) = eradc * xl/lrad yints(cnt) = eradc * yl/lrad - !write(*,*) toti,totj ! 1) Intersect with vertical grid line: start to calculate the intersection point from the larger absolute value of i or j ! , and the quadrant of an intersection point will be recovered from the sign of yl or xl that is shifted to the coordinate ! centered by the center of a crater. Later, it will be shited back to the grid space by adding the location of ! a crater in pixel space. do j=totj,1,-1 - !yj = sign(1.0_DP,yl) * (real(j-1) * user%pix + 0.5_DP * user%pix) yj = sign(1.0_DP,yl) * (real(j) * user%pix) cnt = cnt + 1 xints(cnt) = yj/tan(phi) yints(cnt) = yj - !if (abs(phi) < VSMALL .or. (abs(phi) >= PI/2.0_DP - VSMALL .and. abs(phi) <= PI/2.0_DP + VSMALL) ) then - !if (totj == 0) then - ! write(*,*) 'y',phi,cnt,yj,xints(cnt),yints(cnt),sqrt(xints(cnt)**2 + yints(cnt)**2) - !end if end do do i=toti,1,-1 - !xi = sign(1.0_DP,xl) * (real(i-1) * user%pix + 0.5_DP * user%pix) xi = sign(1.0_DP,xl) * (real(i) * user%pix) cnt = cnt + 1 xints(cnt) = xi yints(cnt) = tan(phi) * xi - !if (abs(phi) < VSMALL .or. (abs(phi) >= PI/2.0_DP - VSMALL .and. abs(phi) <= PI/2.0_DP + VSMALL) ) then - ! write(*,*) 'x',phi,cnt,xi,xints(cnt),yints(cnt),sqrt(xints(cnt)**2 + yints(cnt)**2) - !end if end do cnt = cnt + 1 xints(cnt) = 0._DP yints(cnt) = 0._DP - - !if (lrad/1000.0<=1.0 .and. lrad/1000.0>=0.98) then - ! do i=cnt,1,-1 - ! write(*,*) lrad/1000.0,xints(i),yints(i),sqrt(xints(i)**2 + yints(i)**2) - ! end do - !end if ! ******* Sort those final intersection points by a difference of a radial distance of an intersection point ********* ! ******************************* Compare the radial distance of an intersected point ****************************** @@ -214,62 +200,19 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, end do end do - ! ******************************** Size of a tangential stream tube ********************************************** - ! Determine the radius of a tangential-shaped circule stream tube at the head of the stream tube - ! The ejecta blanket thickness data from CTEM will be used to constrain our tube, then two calibrated - ! streamlines will be given for estimation of thickness of a layer inside a stream tube - ! A cubic function is given after considering the constraint of ejecta blanket thickness by CTEM, so the cubic - ! function's solution is based on Nmuerical Recipe: Fortran 77, p.178-200, which is believed in a optimized way to do so! - ! The total volume of a stream tube is given: - ! Vst = (0.25_DP * PI * deltar**2 * a**2 * eradi / b *(tan(b)-b)) + sqrt(2.0_DP)/2.0_DP*PI*deltar**3 - - k1 = PI * (0.5 * a)**2 * (tan(b) - b) - k2 = ebh * (user%pix)**2 - k3 = eradc/b - k4 = sqrt(3.0_DP)/2.0_DP * PI - k1/b - c1 = k1 * k3 /k4 - c2 = k2/k4 - deltar = regolith_cubic_func(c1,c2) + ! Purpose 1: Calculate the size of a stream tube constrained by ejecta thickness + ! Purpose 2: Once we have the size information of a stream tube, we can + ! calculate the distal melt: the precursor of glass spherules within a + ! stream tube. The result is contained in a linked list "newlayer". + call regolith_melt_glass(user,crater,age,age_resolution,ebh,rm,eradc,lrad,deltar,newlayer,xmints) erado = eradc + deltar eradi = eradc - deltar - !if (deltar <= VSMALL) write(*,*) crater%frad,lrad/crater%frad,eradc,deltar,ebh,k1,k2,k3,k4,c1,c2 - - ! Comparison with melt zone's radius - !write(*,*) lrad / crater%frad, eradi, erado, deltar - - - ! ******************************* Start to estimate STREAM TUBE'S volume in layering systerm *************************** - ! Purpose: How much layer material are contained in a stream tube? - ! Intro: There are two volume approximation with regarding to discretized stream tubes. First, the subpixel approximation - ! is important to distal landing ejecta, and the advantage of it is that you can use Maxwell Z model equation to calculate - ! the total volume of a stream tube if it is contained inside the whole layer. For the small craters or subpixel craters, - ! this method will be used frequently. + age_collector(:) = 0.0_SP + vol = 0.0_DP + totmare = 0.0_DP + tots = 0.0_DP - vst = (0.25_DP * PI * deltar**2 * a**2 * eradi / b *(tan(b)-b)) + sqrt(2.0_DP)/2.0_DP*PI*deltar**3 - - ! Fresh melt's calculation - depthb = crater%imp / 2.0 - rints = sqrt(rm**2 - (depthb)**2) - cosvints = eradi / (crater%imp + eradi) - sinvints = sqrt(1.0 - cosvints**2) - xvints = eradi * ( 1.0 - cosvints) * sinvints - volv1 = ( 0.25_DP * PI * deltar**2 * a**2 * eradi / b * (tan(b/eradi*(xvints))-b/eradi*(xvints)) ) - if (eradi <= rints) then - volm1 = vst - volv1 - melt = volm1 - newlayer%meltfrac = 1.0 - else if (eradi > rints) then - q1 = 1.0 / (1.0 + 2.0 * depthb / eradi) - q2 = -1.0 - 1.0/q1 - q3 = ( 1.0 + (depthb**2 - rm**2)/eradi**2 ) * q1 - cosq1 = 0.5 * q1 * (-1.0 * q2 + sqrt(q2**2 - 4.0 * q3/q1)) - cosq2 = 0.5 * q1 * (-1.0 * q2 - sqrt(q2**2 - 4.0 * q3/q1)) - thetaq = acos( min(abs(cosq1),abs(cosq2)) ) - xmints = eradi * (1.0 - cos(thetaq)) * sin(thetaq) - volm1 = ( 0.25_DP * PI * deltar**2 * a**2 * eradi / b * (tan(b/eradi*(xmints))-b/eradi*(xmints)) ) - melt = volm1 - volv1 - newlayer%meltfrac = melt/(vst-volv1) - end if + call regolith_shock_damage_zone(crater,rm,eradi,depthb,xsfints) if (eradc <= user%pix) then @@ -279,30 +222,34 @@ subroutine regolith_streamtube(user,surf,crater,domain,ejb,ejtble,xp,yp,xpi,ypi, ystpi = crater%ylpx + nint(yc/user%pix) ri = sqrt(xints(2)**2 + yints(2)**2) rip1 = sqrt(xints(1)**2 + yints(1)**2) - vseg = 0.25_DP * PI * deltar**2 * a**2 * eradi / b * abs(tan(b) - b) + vseg = regolith_streamtube_volume_func(eradi,0.0_DP,eradi,deltar) + newlayer%thickness = vseg/(user%pix**2) call util_periodic(xstpi,ystpi,user%gridsize) - call regolith_subpixel_streamtube(user,surf(xstpi,ystpi),deltar,ri,rip1,eradi,vseg,newlayer,rm) - newlayer%comp = newlayer%comp / newlayer%thickness + call regolith_subpixel_streamtube(user,surf(xstpi,ystpi),deltar,ri,rip1,eradi,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,vol) + + newlayer%age(:) = newlayer%age(:) + age_collector(:) + + totmare = vmare + tots = totseb newlayer%thickness = ebh + newlayer%comp = min(totmare/tots, 1.0_DP) + newlayer%age(:) = newlayer%age(:) * min( (ebh * user%pix**2) / tots, 1.0_DP) else - ! Define a regodata typed layer that is able to sum up all components during travesing a stream tube - sumlayer%thickness = 0._DP - sumlayer%comp = 0._DP - sumlayer%meltfrac = 0._DP - rbody = sqrt(xints(2)**2 + yints(2)**2) if (rbodyuser%pix/1000000.0) then - vseg = 0.25_DP * PI * deltar**2 * a**2 * eradi / b * (abs(tan(b/eradi * rip1) - tan(b/eradi * ri)) & - - abs(b/eradi * rip1 - b/eradi * ri)) + vseg = regolith_streamtube_volume_func(eradi,ri,rip1,deltar) + newlayer%thickness = vseg/(user%pix**2) call util_periodic(xstpi,ystpi,user%gridsize) - call regolith_traverse_streamtube(user,surf(xstpi,ystpi),deltar,ri,rip1,eradi,erado,vseg,newlayer,rm) - sumlayer%comp = sumlayer%comp + newlayer%comp - sumlayer%thickness = sumlayer%thickness + newlayer%thickness + call regolith_traverse_streamtube(user,surf(xstpi,ystpi),deltar,ri,rip1,eradi,erado,newlayer,vmare,& + totseb,age_collector,xmints,xsfints,rsh,depthb) + totmare = totmare + vmare + tots = tots + totseb end if end do - newlayer%thickness = 0._DP - newlayer%comp = 0._DP xstpi = crater%xlpx + nint(eradc*xl/lrad/user%pix) ystpi = crater%ylpx + nint(eradc*yl/lrad/user%pix) call util_periodic(xstpi,ystpi,user%gridsize) - call regolith_streamtube_head(user,surf(xstpi,ystpi),deltar,newlayer,eradi,rm) - sumlayer%comp = sumlayer%comp + newlayer%comp - sumlayer%thickness = sumlayer%thickness + newlayer%thickness - newlayer%comp = sumlayer%comp / sumlayer%thickness + call regolith_streamtube_head(user,surf(xstpi,ystpi),deltar,totmare,tots,age_collector) + newlayer%thickness = ebh + newlayer%comp = min(totmare/tots, 1.0_DP) + newlayer%age(:) = newlayer%age(:) + age_collector(:) + newlayer%age(:) = newlayer%age(:) * min( (ebh * user%pix**2) / tots, 1.0_DP) end if call util_push(surf(xpi,ypi)%regolayer,newlayer) + deallocate(xints,yints) return diff --git a/src/regolith/regolith_streamtube_head.f90 b/src/regolith/regolith_streamtube_head.f90 index 9cef521b..7624d742 100644 --- a/src/regolith/regolith_streamtube_head.f90 +++ b/src/regolith/regolith_streamtube_head.f90 @@ -18,8 +18,7 @@ ! Notes : The stream tube's head is always attached to the surface. ! !********************************************************************************************************************************** -subroutine regolith_streamtube_head(user,surfi,deltar,newlayer,eradi,rm) -!subroutine regolith_streamtube_head(user,surfi,deltar,totmare,tots,turnover) +subroutine regolith_streamtube_head(user,surfi,deltar,totmare,tots,age_collector) use module_globals use module_regolith, EXCEPT_THIS_ONE => regolith_streamtube_head implicit none @@ -27,9 +26,9 @@ subroutine regolith_streamtube_head(user,surfi,deltar,newlayer,eradi,rm) type(usertype),intent(in) :: user type(surftype),intent(in) :: surfi real(DP),intent(in) :: deltar - type(regodatatype),intent(inout) :: newlayer - real(DP),intent(in) :: eradi,rm - + real(DP),intent(inout) :: totmare,tots + real(SP),dimension(:),intent(inout) :: age_collector + ! internal variables type(regolisttype),pointer :: current real(DP),parameter :: vratio = sqrt(2.0_DP)/2.0_DP ! Unfortunately, the approximate function that is used to get the size of a stream @@ -37,49 +36,54 @@ subroutine regolith_streamtube_head(user,surfi,deltar,newlayer,eradi,rm) ! from the analytical function that we use here to approximate the stream tube's ! head intersected with underlying layers, about 30% of volume difference. real(DP) :: z,zstart,zend,zmin,zmax - real(DP) :: headtot,headcomp,headmelt,vhead,vsgly + real(DP) :: tothead,totmarehead,marehead,vhead,vsgly + + ! melt collector + real(DP) :: recyratio current => surfi%regolayer z = current%regodata%thickness vsgly = vratio * PI * deltar**3 + tothead = 0._DP + totmarehead = 0._DP + vhead = 0._DP + marehead = 0.0_DP zstart = 0._DP zend = z zmin = zstart zmax = 2.0 * deltar if (zend >= zmax) then ! Stream tube's head is inside the 1st layer. - - newlayer%thickness = newlayer%thickness + vsgly - newlayer%comp = newlayer%comp + vsgly * current%regodata%comp - + tots = tots + vsgly + totmare = totmare + vsgly * current%regodata%comp + recyratio = vsgly / (user%pix**2) /current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio else ! head is not intersected with layers. - headtot = 0._DP - headcomp = 0._DP - headmelt = 0._DP - vhead = 0._DP - do if (.not. associated(current%next)) exit if (zend < zmax) then vhead = regolith_circle_sector_func(deltar,zstart,zend) - headtot = headtot + vhead * vratio - headcomp = headcomp + vhead * vratio * current%regodata%comp + tothead = tothead + vhead * vratio + totmarehead = totmarehead + vhead * vratio * current%regodata%comp + recyratio = vhead * vratio / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio current => current%next z = z + current%regodata%thickness zstart = zend zend = z else - headcomp = headcomp + (vsgly-headtot) * current%regodata%comp - headtot = vsgly - !write(*,*) '2',zstart,zend,current%comp,(vsgly-tothead)/2500.0,totmarehead/2500.0,tothead/2500.0 + totmarehead = totmarehead + (vsgly-tothead) * current%regodata%comp + tothead = vsgly + recyratio = (vsgly - tothead) / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio exit end if end do - newlayer%thickness = newlayer%thickness + headtot - newlayer%comp = newlayer%comp + headcomp + tots = tots + tothead + totmare = totmare + totmarehead end if diff --git a/src/regolith/regolith_streamtube_lineseg.f90 b/src/regolith/regolith_streamtube_lineseg.f90 index f1070747..e859f468 100644 --- a/src/regolith/regolith_streamtube_lineseg.f90 +++ b/src/regolith/regolith_streamtube_lineseg.f90 @@ -18,23 +18,32 @@ ! Notes : ! !********************************************************************************************************************************** -subroutine regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,vseg,newlayer,rm) +subroutine regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,depthb) use module_globals use module_regolith, EXCEPT_THIS_ONE => regolith_streamtube_lineseg implicit none ! arguemnts type(usertype),intent(in) :: user type(surftype),intent(in) :: surfi - real(DP),intent(in) :: thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,vseg,rm + real(DP),intent(in) :: thetast,ri,rip1,zmin,zmax,erad,eradi,deltar type(regodatatype),intent(inout) :: newlayer + real(DP),intent(inout) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints, depthb ! internal variables - real(DP),parameter :: a = 0.936457 - real(DP),parameter :: b = 1.12368 type(regolisttype),pointer :: current real(DP) :: z,zstart,zend,rstart,rend,r - real(DP) :: vsgly + real(DP) :: vsgly,x,vseg, vsh + ! Melt zone + real(DP) :: recyratio, xsh, rst + real(DP) :: theta1, theta2, r1, r2, vol + ! Shock damaged zone + real(DP) :: ebh_recyl + current => surfi%regolayer z = current%regodata%thickness zstart = 0.0_DP @@ -48,42 +57,95 @@ subroutine regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad rend = rip1 end if + vol = 0.0_DP + do if (.not. associated(current%next)) exit !it should exit until it hit the very bottom. if (zend <= zmin) then + if (zmax <= zend + current%next%regodata%thickness) then - newlayer%thickness = vseg - newlayer%comp = vseg * current%next%regodata%comp + + vsgly = newlayer%thickness * user%pix**2 + vmare = vsgly * current%next%regodata%comp + totseb = vsgly + + if (ri > xmints) then + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,ri,rip1) + ebh_recyl = (1.0 - newlayer%meltfrac) * newlayer%thickness - vsh / user%pix**2 + recyratio = max(ebh_recyl,0.0_DP) / current%next%regodata%thickness + age_collector(:) = age_collector(:) + current%next%regodata%age(:) * recyratio + vol = vol + sum(current%next%regodata%age(:)) * recyratio + else if (ri <= xmints .and. rip1 > xmints) then + vseg = regolith_streamtube_volume_func(eradi,xmints,rip1,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,ri,rip1) + recyratio = max((vseg-vsh),0.0_DP) / (user%pix**2) / current%next%regodata%thickness + age_collector(:) = age_collector(:) + current%next%regodata%age(:) * recyratio + vol = vol + sum(current%next%regodata%age(:)) * recyratio + end if exit else + current => current%next z = z + current%regodata%thickness zstart = zend zend = z + end if + else if (zend > zmin .and. zend < zmax) then - rend = regolith_quadratic_func(zend,erad,ri,rip1,rstart) - vsgly = 0.25_DP * PI * deltar**2 * a**2 * eradi / b * (abs(tan(b/eradi * rend) & - - tan(b/eradi * rstart)) - abs(b/eradi * rend - b/eradi * rstart)) - newlayer%thickness = newlayer%thickness + vsgly - newlayer%comp = newlayer%comp + vsgly * current%regodata%comp + rend = regolith_quadratic_func(zend,erad,ri,rip1,rstart) + vsgly = regolith_streamtube_volume_func(eradi,rstart,rend,deltar) + vmare = vmare + vsgly * current%regodata%comp + totseb = totseb + vsgly + + ! A segment coming from the side of impact site, ri + if (thetast>=0_DP .and. rend > xmints) then + vseg = regolith_streamtube_volume_func(eradi,max(xmints,rstart),rend,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,rstart,rend) + recyratio = max((vseg-vsh),0.0_DP) / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio + vol = vol + sum(current%regodata%age(:)) * recyratio + end if + + ! A segment coming from the side of emerging location of a streamtube rip1 + if (thetast<0._DP .and. rstart > xmints) then + vseg = regolith_streamtube_volume_func(eradi,max(xmints,rend),rstart,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,rend,rstart) + recyratio = max((vseg-vsh),0.0_DP) / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio + vol = vol + sum(current%regodata%age(:)) * recyratio + end if current => current%next z = z + current%regodata%thickness r = rstart rstart = rend zstart = zend zend = z + else if (zend >= zmax .and. zstart <= zmin) then - newlayer%thickness = vseg - newlayer%comp = vseg * current%regodata%comp + + vsgly = newlayer%thickness * user%pix**2 + vmare = vsgly * current%regodata%comp + totseb = vsgly + + if (rip1 > xmints) then + vseg = regolith_streamtube_volume_func(eradi,max(xmints,ri),rip1,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,ri,rip1) + recyratio = max((vseg-vsh),0.0_DP) / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio + vol = vol + sum(current%regodata%age(:)) * recyratio + end if + exit + else if (zend >= zmax .and. zstart > zmin) then - ! last part of a stream tube - newlayer%comp = newlayer%comp + (vseg - newlayer%thickness) * current%regodata%comp - newlayer%thickness = vseg + ! last part of a stream tube + vsgly = regolith_streamtube_volume_func(eradi,ri,rip1,deltar) + vmare = vmare + (vsgly - totseb) * current%regodata%comp + totseb = vsgly exit end if diff --git a/src/regolith/regolith_streamtube_volume_func.f90 b/src/regolith/regolith_streamtube_volume_func.f90 new file mode 100644 index 00000000..5200e6be --- /dev/null +++ b/src/regolith/regolith_streamtube_volume_func.f90 @@ -0,0 +1,64 @@ +!****f* regolith/regolith_streamtube_volume_func +! Name +! regolith_streamtube_volume_func -- Calculate the volume of a segment of a stream tube +! SYNOPSIS +! This uses +! * module_globals +! * module_regolith +! +! volume = regolith_streamtube_volume_func() +! +! DESCRIPTION +! +! This function is used very frequently if "doregotrack" is turned +! on. As a a result, we separated it into an independent function. +! +! ARGUMENTS +! Input +! * user -- The user-defined variables from the input file +! * surfi -- A given pixel from surface grid +! * deltar -- The size of a stream tube +! * ri -- A point of a stream tube's projection on surface grid +! * rip1 -- A point of a stream tube's projection on surface grid +! * eradi -- The inner radial distance of a stream tube +! +! Output +! * newlayer -- +! +!*** + +!********************************************************************************************************** +! +! Unit Name : regolith_streamtube_volume_func +! Unit Type : function +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Calculate the volume of a segment of stream tube +! +! +! Input +! Arguments : +! +! Output +! Arguments : surf :: surface +! +! +! Notes : +! +!*********************************************************************************************************** +function regolith_streamtube_volume_func(eradi,ri,rip1,deltar) result(vol) + use module_globals + use module_regolith, EXCEPT_THIS_ONE => regolith_streamtube_volume_func + implicit none + + real(DP), intent(in) :: eradi, ri, rip1, deltar + real(DP) :: vol + real(DP), parameter :: a = 0.936457 + real(DP), parameter :: b = 1.12368 + + vol = 0.25 * PI * (deltar**2) * (a**2) * eradi / b * abs( & + abs(tan(b/eradi * rip1) - (b/eradi) * rip1) - & + abs(tan(b/eradi * ri) - (b/eradi) * ri)) + +end function regolith_streamtube_volume_func diff --git a/src/regolith/regolith_subcrater_mix.f90 b/src/regolith/regolith_subcrater_mix.f90 index 25cf3ee0..c5f5e66f 100644 --- a/src/regolith/regolith_subcrater_mix.f90 +++ b/src/regolith/regolith_subcrater_mix.f90 @@ -36,6 +36,9 @@ subroutine regolith_subcrater_mix(user,surf,domain,nflux,finterval,p) real(DP) :: dd, ds !mixing depth for shallow and deep integer(I4B) :: klo, khi + ! Test age + real(SP) :: age_mean + ! Find the deepest depth for 100% true saturation klo = 1 ds = p(1,1) diff --git a/src/regolith/regolith_subpixel_streamtube.f90 b/src/regolith/regolith_subpixel_streamtube.f90 index 5b2458ef..57f30744 100644 --- a/src/regolith/regolith_subpixel_streamtube.f90 +++ b/src/regolith/regolith_subpixel_streamtube.f90 @@ -50,38 +50,62 @@ ! Notes : ! !********************************************************************************************************************************** -subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,newlayer,rm) +subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,vol) use module_globals use module_regolith, EXCEPT_THIS_ONE => regolith_subpixel_streamtube implicit none ! Arguments type(usertype),intent(in) :: user - type(surftype),intent(inout) :: surfi - real(DP),intent(in) :: deltar,ri,rip1,eradi,vseg - type(regodatatype),intent(inout) :: newlayer - real(DP),intent(in) :: rm + type(surftype),intent(in) :: surfi + real(DP),intent(in) :: deltar,ri,rip1,eradi + type(regodatatype),intent(inout) :: newlayer + real(DP),intent(out) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints + real(DP),intent(inout) :: vol + ! Traversing a linked list real(DP),parameter :: a = 0.936457 real(DP),parameter :: b = 1.12368 type(regolisttype),pointer :: current - real(DP) :: z,zmax,zstart,zend,rlefti,rleftf,rrighti,rrightf,rc,vsgly,x + real(DP) :: z,zmax,zstart,zend,rlefti,rleftf,rrighti,rrightf,rc,vsgly,vsgly1,vsgly2,x + + ! Stream tube's distance from the edge of a melt zone + real(DP) :: zm, recyratio, xmints1, vseg + + ! Parameters for calculating shocked segment of stream tube + real(DP) :: x_up_sh, x_low_sh, vsh ! The depth that a stream tube dips zmax = rip1/4.0_DP - + current => surfi%regolayer z = surfi%regolayer%regodata%thickness zstart = 0.0_DP zend = z + vmare = 0._DP + totseb = 0._DP + vseg = 0.0_DP + vsgly1 = 0.0_DP + vsgly2 = 0.0_DP ! Two cases: subpixel is inside the first layer, and its volume is simply the landing ejecta blanket. if (zend>=zmax) then - - newlayer%thickness = vseg - newlayer%comp = vseg * surfi%regolayer%regodata%comp - + vmare = newlayer%thickness * user%pix**2 * surfi%regolayer%regodata%comp + totseb = newlayer%thickness * user%pix**2 + if (eradi>xmints) then + vseg = regolith_streamtube_volume_func(eradi,xmints,eradi,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,0.0_DP,eradi) + recyratio = max(vseg-vsh,0.0 )/ (user%pix**2) / (surfi%regolayer%regodata%thickness) + age_collector(:) = age_collector(:) + surfi%regolayer%regodata%age(:) * recyratio + vol = vol + sum(age_collector(:)) +! write(*,*) '1',eradi, xmints, xsfints, & +! vseg/user%pix**2, (vseg-vsh)/user%pix**2, recyratio + end if else ! The subpixel stream tube may dip deeper than the first layer. And we use the line segments approximation, but ! the layer now intersects with both sides of a stream tube, so two intersection points between the layer and the @@ -92,7 +116,7 @@ subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,new ! ** | | * * !-----*--------------------------------------------------------*----------------------------*--------------------- > z ! *| * * | - ! | * * | * + ! | * * | * rrightf ! | * * * | * ! | * * * | * ! | * | @@ -101,15 +125,14 @@ subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,new ! | * * | ! | * * | !^ ^ ^ ^ ^ - !0.0 rleftf rc rrighti eradi + !0.0 rleftf rc rrighti eradi + !rlefti rlefti = 0.0_DP rleftf = 0.0_DP rrighti = eradi rrightf = eradi rc = rip1 * sqrt(3.0) / 4.0 - newlayer%thickness = 0._DP - newlayer%comp = 0._DP do @@ -120,12 +143,47 @@ subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,new rleftf = regolith_quadratic_func(zend,rip1,rlefti,rc,rlefti) rrighti = regolith_quadratic_func(zend,rip1,rc,rrightf,rrightf) - vsgly = 0.25 * PI * deltar**2 * a**2 * eradi / b * (abs(tan(b/eradi * rleftf) + tan(b/eradi * rrightf)& - - tan(b/eradi * rlefti) - tan(b/eradi * rrighti)) - abs(b/eradi * rleftf + b/eradi * rrightf & - - b/eradi * rlefti - b/eradi * rrighti)) - - newlayer%comp = newlayer%comp + vsgly * current%regodata%comp - newlayer%thickness = newlayer%thickness + vsgly + vsgly1 = regolith_streamtube_volume_func(eradi,rlefti,rleftf,deltar) + vsgly2 = regolith_streamtube_volume_func(eradi,rrighti,rrightf,deltar) + vsgly = vsgly1 + vsgly2 + vmare = vmare + (vsgly * current%regodata%comp) + totseb = totseb + vsgly + + ! If this segmentr, intersecting with layer, is beyond "xmints" + ! (melt-and-streamline intersection point), a streamtube will retain + ! whatever it is in the layer. However, if this segment is completely + ! within shock fragmentation zone, then it would not retain. + ! Fragmentation subroutine only should place under the following two + ! if-then conditions for both segments. If a segment is not satisfied + ! with the following if-then conditions, it means that a segment is + ! inside the melt zone that is previously calculated in + ! "regolith_melt_glass" subroutine. Then next step is to examine how a + ! segment locates in our shock pressure decay zone. The rule of thumb + ! is a segment remaining the same volume no matter what it experiences + ! shock pressues. We should only examine how the ends of a streamtube's + ! segment locate inside our decay zone. In the first if-then condition, + ! it is to describe the segment closer to emerging location. Its ends + ! are "rrighti" and "rrightf". The volume is "vsgly2". The "xsh" is the + ! x-location of a current layer intersecting with shock pressure decay + ! zone. + ! 1) rrighti > xsh: no damage, retaining ratio (recyratio) is 1.0 + ! 2) rrighti < xsh < rrightf: partial damage, retaining ratio is + ! affected to be (vsgly2 - v_shocked) / vsgly2. + ! 3) rrightf < xsh: complete damage, retaining ratio is 0.0 + !if (rrighti>max(xmints,sqrt(rm**2 - z**2))) then + if (rrighti > xmints) then + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,rrighti,rrightf) + recyratio = max((vsgly2 -vsh),0.0)/ (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio + vol = vol + sum(current%regodata%age(:)) * recyratio + end if + + if (rlefti > xmints) then + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,rlefti,rleftf) + recyratio = max((vsgly1-vsh),0.0) / (user%pix**2) / current%regodata%thickness + age_collector(:) = age_collector(:) + current%regodata%age(:) * recyratio + vol = vol + sum(current%regodata%age(:)) * recyratio + end if current => current%next z = z + current%regodata%thickness @@ -136,16 +194,14 @@ subroutine regolith_subpixel_streamtube(user,surfi,deltar,ri,rip1,eradi,vseg,new ! final part of a stream tube else vsgly = 0.25 * PI * deltar**2 * a**2 * eradi / b * (abs(tan(b) - b)) - newlayer%comp = newlayer%comp + (vsgly - newlayer%thickness) * current%regodata%comp - newlayer%thickness = vsgly + vmare = vmare + (vsgly - totseb) * current%regodata%comp + totseb = vsgly exit end if - end do - end if - call regolith_streamtube_head(user,surfi,deltar,newlayer,eradi,rm) + call regolith_streamtube_head(user,surfi,deltar,vmare,totseb,age_collector) return end subroutine regolith_subpixel_streamtube diff --git a/src/regolith/regolith_superdomain.f90 b/src/regolith/regolith_superdomain.f90 new file mode 100644 index 00000000..db4ff8aa --- /dev/null +++ b/src/regolith/regolith_superdomain.f90 @@ -0,0 +1,67 @@ +!********************************************************************************************************************************** +! +! Unit Name : regolith_superdomain +! Unit Type : subroutine +! Project : CTEM +! Language : Fortran 2003 +! +! Description : Softens the terrain under the ejecta using a box filter model where the size of the box is proportional to the +! thickness of the ejecta +! +! +! Input +! Arguments : +! +! Output +! Arguments : +! +! +! Notes : +! +!********************************************************************************************************************************** +subroutine regolith_superdomain(user,crater,domain,regolayer,ejdistribution,xpi,ypi,age,age_resolution,rm,depthb) + use module_globals + use module_util + use module_regolith, EXCEPT_THIS_ONE => regolith_superdomain + implicit none + + ! Arguments + type(usertype),intent(in) :: user + type(cratertype),intent(inout) :: crater + type(domaintype),intent(in) :: domain + type(regolisttype),pointer :: regolayer + real(DP),intent(in) :: ejdistribution + integer(I4B),intent(in) :: xpi, ypi + real(DP),intent(in) :: age + real(DP),intent(in) :: age_resolution + real(DP),intent(in) :: rm + real(DP),intent(in) :: depthb + + ! Internal variables + real(DP) :: xp, yp + real(DP) :: lrad, vej + real(DP) :: ebh + real(DP) :: erad + real(DP) :: cvpg + real(DP) :: deltar, xmints + type(regodatatype) :: newlayer + integer(I2B) :: n_age + + ! Interpret landing distance from a super domain crater to ray's deposits in + ! local domain + xp = dble(xpi) * user%pix + yp = dble(ypi) * user%pix + lrad = sqrt((crater%xl - xp)**2 + (crater%yl - yp)**2) + ebh = 0.14_DP * crater%frad**(0.74_DP) * (lrad / crater%frad)**(-3.0_DP) + ebh = ebh * ejdistribution + ! Estimate radial position of a stream tube + ! Assume streamlines' maximum depth is within regolith. + cvpg = sqrt(2.0_DP) / 0.85_DP * ( user%mu_b / (user%mu_b + 1) ) + erad = cvpg**(user%mu_b) * (lrad**(-0.5_DP * user%mu_b)) * (crater%rad)**(user%mu_b * 0.5_DP + 1.0_DP) + vej = cvpg * sqrt(user%gaccel * crater%grad) * (erad / crater%grad)**(-1.0_DP / user%mu_b) !equation 18 in Richardson 2009 + lrad = ( vej **2 ) / user%gaccel !assume ejection angle is 45 degree. + call regolith_melt_glass(user,crater,age,age_resolution,ebh,rm,erad,lrad,deltar,newlayer,xmints) + call util_push(regolayer,newlayer) + + return +end subroutine regolith_superdomain diff --git a/src/regolith/regolith_traverse_streamtube.f90 b/src/regolith/regolith_traverse_streamtube.f90 index a89b1e24..1dbe640d 100644 --- a/src/regolith/regolith_traverse_streamtube.f90 +++ b/src/regolith/regolith_traverse_streamtube.f90 @@ -18,7 +18,8 @@ ! Notes : ! !********************************************************************************************************************************** -subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,vseg,newlayer,rm) +subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,newlayer,vmare,totseb,& + age_collector,xmints,xsfints,depthb) use module_globals use module_regolith, EXCEPT_THIS_ONE => regolith_traverse_streamtube implicit none @@ -26,12 +27,25 @@ subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,vs ! Arguments type(usertype),intent(in) :: user type(surftype),intent(inout) :: surfi - real(DP),intent(in) :: deltar,ri,rip1,eradi,erado,vseg,rm + real(DP),intent(in) :: deltar,ri,rip1,eradi,erado type(regodatatype),intent(inout) :: newlayer + real(DP),intent(out) :: vmare,totseb + real(SP),dimension(:),intent(inout) :: age_collector + real(DP),intent(in) :: xmints + real(DP),intent(in) :: xsfints, depthb ! Traversing a linked list real(DP) :: zri,zrip1,cosi,coso,rzmax - real(DP) :: erad,z,zmin,zmax,thetast + real(DP) :: erad,z,zmin,zmax,thetast,vseg + + real(DP),parameter :: a = 0.936457 + real(DP),parameter :: b = 1.12368 + + ! Melt zone + real(DP) :: recyratio + + ! Shock zone + real(DP) :: vsh erad = (eradi + erado)/2.0 rzmax = erad * sqrt(3.0)/4.0 @@ -50,17 +64,24 @@ subroutine regolith_traverse_streamtube(user,surfi,deltar,ri,rip1,eradi,erado,vs end if z = surfi%regolayer%regodata%thickness + vmare = 0._DP + totseb = 0._DP if (z>=zmax) then - newlayer%thickness = vseg - newlayer%comp = vseg * surfi%regolayer%regodata%comp + vmare = newlayer%thickness * user%pix**2 * surfi%regolayer%regodata%comp + totseb = newlayer%thickness * user%pix**2 + if (rip1 > xmints .and. ri < xmints) then + vseg = regolith_streamtube_volume_func(eradi,max(xmints,ri),rip1,deltar) + vsh = regolith_shock_damage(eradi,deltar,xmints,xsfints,ri,rip1) + recyratio = max(vseg-vsh,0.0_DP) / (user%pix**2) / surfi%regolayer%regodata%thickness + age_collector(:) = age_collector(:) + surfi%regolayer%regodata%age(:) * recyratio + end if else - newlayer%thickness = 0._DP - newlayer%comp = 0._DP - call regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,vseg,newlayer,rm) + call regolith_streamtube_lineseg(user,surfi,thetast,ri,rip1,zmin,zmax,erad,eradi,deltar,& + newlayer,vmare,totseb,age_collector,xmints,xsfints,depthb) end if diff --git a/src/util/util_add_to_layer.f90 b/src/util/util_add_to_layer.f90 index 04ca287c..a99dd9dd 100644 --- a/src/util/util_add_to_layer.f90 +++ b/src/util/util_add_to_layer.f90 @@ -47,7 +47,6 @@ subroutine util_add_to_layer(user,surfi,crater) surfi%diam(layer) = crater%fcrat surfi%xl(layer) = crater%xl surfi%yl(layer) = crater%yl - surfi%timestamp(layer) = crater%timestamp else write(*,*) write(*,*) 'WARNING! No free layer to add crater pixel. Consider increasing NUMLAYERS' diff --git a/src/util/util_init_list.f90 b/src/util/util_init_list.f90 index 2159497d..672f9c11 100644 --- a/src/util/util_init_list.f90 +++ b/src/util/util_init_list.f90 @@ -54,7 +54,7 @@ ! layer. ! !********************************************************************************************************************************** -subroutine util_init_list(regolayer, initstat) +subroutine util_init_list(regolayer,initstat) use module_globals use module_util, EXCEPT_THIS_ONE => util_init_list implicit none @@ -74,11 +74,10 @@ subroutine util_init_list(regolayer, initstat) initstat = .true. nullify(regolayer%next) regolayer%regodata%thickness = VBIG ! This generates a buffer layer that the model should never reach if the run is structured properly - regolayer%regodata%comp = 0.0_DP - regolayer%regodata%meltfrac = 0.0_DP - regolayer%regodata%porosity = 0.07_DP ! This is also the initial bedrock porosity, Should be in the input file. - regolayer%regodata%depth = - 30000.0_DP ! The depth at the boundary of the crust. - ! This must be defined in the input file. But not in this version. + regolayer%regodata%comp = 0.0_DP + regolayer%regodata%meltfrac = 0.0_DP + regolayer%regodata%porosity = 0.0_DP + regolayer%regodata%age(:) = 0.0_SP else write(*,*) 'util_init_list: Initialization failed. Exhausted memory.' end if @@ -87,4 +86,5 @@ subroutine util_init_list(regolayer, initstat) end if return -end subroutine util_init_list \ No newline at end of file +end subroutine util_init_list + diff --git a/src/util/util_remove_from_layer.f90 b/src/util/util_remove_from_layer.f90 index 22bb26d4..b9e773b7 100644 --- a/src/util/util_remove_from_layer.f90 +++ b/src/util/util_remove_from_layer.f90 @@ -32,6 +32,5 @@ subroutine util_remove_from_layer(surfi,layer) surfi%diam(layer) = 0.0_DP surfi%xl(layer) = 0.0_SP surfi%yl(layer) = 0.0_SP -surfi%timestamp(layer) = 0.0_SP end subroutine util_remove_from_layer diff --git a/src/util/util_search.f90 b/src/util/util_search.f90 index 61d3e415..caef13b8 100644 --- a/src/util/util_search.f90 +++ b/src/util/util_search.f90 @@ -92,75 +92,6 @@ subroutine util_search_double(arr,ind,n,val,klo) end subroutine util_search_double -subroutine util_search_double_1(arr,ind,n,val,klo) -use module_globals -use module_util, EXCEPT_THIS_ONE => util_search_double_1 -implicit none - - ! Arguments - integer(I4B),intent(in) :: ind,n - real(DP),dimension(:),intent(in) :: arr - real(DP),intent(in) :: val - integer(I4B),intent(inout) :: klo - - ! Internals - integer(I4B) :: k,khi,inc - logical :: uporder ! true if arr is in ascending order - - ! Executable code - uporder = arr(1) <= arr(n) - ! First hunt for the starting value - if (.not.((klo <= 0).or.(klo > n))) then ! Only proceed if guess is useful - inc = 1 - if ((val >= arr(klo)) .eqv. uporder) then - do - khi = klo + inc - if (khi > n) then - khi = n + 1 - else if ((val >= arr(khi)) .eqv. uporder) then - klo = khi - inc = 2 * inc - cycle - end if - exit - end do - else - khi = klo - do - klo = khi - inc - if (klo < 1 ) then - klo = 0 - else if ((val < arr(klo)) .eqv. uporder) then - khi = klo - inc = 2 * inc - cycle - end if - exit - end do - end if - else - klo = 0 - khi = n + 1 - end if - - ! Start the bisection method search - do - if (khi - klo == 1) then - if (val == arr(n)) klo = n-1 - if (val == arr(1)) klo = 1 - return - end if - k = (khi + klo) / 2 - if ((val >= arr(k)) .eqv. uporder) then - klo = k - else - khi = k - end if - end do - -end subroutine util_search_double_1 - - subroutine util_search_int(arr,ind,n,val,klo) use module_globals use module_util, EXCEPT_THIS_ONE => util_search_int diff --git a/src/util/util_sort_layer.f90 b/src/util/util_sort_layer.f90 index c3d055b1..a230c4c5 100644 --- a/src/util/util_sort_layer.f90 +++ b/src/util/util_sort_layer.f90 @@ -31,7 +31,7 @@ subroutine util_sort_layer(user,surf,crater) ! Internal variables integer(I4B),dimension(user%numlayers) :: ind real(DP),dimension(user%numlayers) :: tempdiam - real(SP),dimension(user%numlayers) :: tempxpos,tempypos,temptime + real(SP),dimension(user%numlayers) :: tempxpos,tempypos integer(I4B) :: i,j,k,inc,incsq,mx,my,iradsq inc = min(crater%rimdispx,(user%gridsize - 1)/2) @@ -54,7 +54,6 @@ subroutine util_sort_layer(user,surf,crater) tempdiam = surf(mx,my)%diam(1:user%numlayers) tempxpos = surf(mx,my)%xl(1:user%numlayers) tempypos = surf(mx,my)%yl(1:user%numlayers) - temptime = surf(mx,my)%timestamp(1:user%numlayers) ! Sort the layers by crater diameter call util_mrgrnk(surf(mx,my)%diam(1:user%numlayers),ind) @@ -63,7 +62,6 @@ subroutine util_sort_layer(user,surf,crater) surf(mx,my)%diam(k)=tempdiam(ind(k)) surf(mx,my)%xl(k)=tempxpos(ind(k)) surf(mx,my)%yl(k)=tempypos(ind(k)) - surf(mx,my)%timestamp(k)=temptime(ind(k)) end do end if end do diff --git a/src/util/util_traverse_pop.f90 b/src/util/util_traverse_pop.f90 index 987e915d..cefa3d95 100755 --- a/src/util/util_traverse_pop.f90 +++ b/src/util/util_traverse_pop.f90 @@ -67,7 +67,8 @@ subroutine util_traverse_pop(regolayer,traverse_depth,poppedlist) ! Internal variables real(DP) :: z,depth,dz type(regodatatype) :: oldregodata - logical :: initstat + logical :: initstat + real(DP) :: recyratio depth = regolayer%regodata%thickness dz = 0._DP @@ -88,9 +89,12 @@ subroutine util_traverse_pop(regolayer,traverse_depth,poppedlist) if (z <= depth) then dz = depth - z + oldregodata = regolayer%regodata + oldregodata%thickness = z + oldregodata%age(:) = z / regolayer%regodata%thickness * regolayer%regodata%age(:) + recyratio = dz / regolayer%regodata%thickness + regolayer%regodata%age(:) = recyratio * regolayer%regodata%age(:) regolayer%regodata%thickness = dz - oldregodata = regolayer%regodata - oldregodata%thickness = z call util_push(poppedlist,oldregodata) exit else diff --git a/test/CTEM b/test/CTEM new file mode 100755 index 00000000..611133f6 Binary files /dev/null and b/test/CTEM differ diff --git a/test/NPF.plt b/test/NPF.plt new file mode 100644 index 00000000..e1c747a3 --- /dev/null +++ b/test/NPF.plt @@ -0,0 +1,105 @@ +#gnuplot 5.0 script +# The Neukum production function +# Ivanov, Neukum, and Hartmann (2001) SSR v. 96 pp. 55-86 +# N1 is number of 1 km craters and larger per km^2 vs. time (T) +# N is number of craters per Gy vs. diameter (D) (Neukum et al. (2001), page 60: per km^2?) +# T is Gy +# D is km +# scale factor in time T is N1(T)/N(1.0) + +N1lunar(T) = 5.44e-14 * (exp(6.93*T) - 1) + 8.38e-4*T + +# Lunar crater SFD +aL00 = -3.0876 +aL01 = -3.557528 +aL02 = 0.781027 +aL03 = 1.021521 +aL04 = -0.156012 +aL05 = -0.444058 +aL06 = 0.019977 +aL07 = 0.086850 +aL08 = -0.005874 +aL09 = -0.006809 +aL10 = 8.25e-4 +aL11 = 5.54e-5 + +Nlunar(D) = D < 0.01 ? 1/0 : D > 1000 ? 1/0 : 10**( \ + aL00 \ + + aL01 * log10(D)**1 \ + + aL02 * log10(D)**2 \ + + aL03 * log10(D)**3 \ + + aL04 * log10(D)**4 \ + + aL05 * log10(D)**5 \ + + aL06 * log10(D)**6 \ + + aL07 * log10(D)**7 \ + + aL08 * log10(D)**8 \ + + aL09 * log10(D)**9 \ + + aL10 * log10(D)**10 \ + + aL11 * log10(D)**11 ) + +#Projectile SFD + +aP00 = 0.0 +aP01 = -1.375458 +aP02 = 1.272521e-1 +aP03 = -1.282166 +aP04 = -3.074558e-1 +aP05 = 4.149280e-1 +aP06 = 1.910668e-1 +aP07 = -4.260980e-2 +aP08 = -3.976305e-2 +aP09 = -3.180179e-3 +aP10 = 2.799369e-3 +aP11 = 6.892223e-4 +aP12 = 2.614385e-6 +aP13 = -1.416178e-5 +aP14 = -1.191124e-6 + +Rproj(D) = D < 1e-4 ? 1/0 : D > 300 ? 1/0 : 10**( \ + aP00 \ + + aP01 * log10(D)**1 \ + + aP02 * log10(D)**2 \ + + aP03 * log10(D)**3 \ + + aP04 * log10(D)**4 \ + + aP05 * log10(D)**5 \ + + aP06 * log10(D)**6 \ + + aP07 * log10(D)**7 \ + + aP08 * log10(D)**8 \ + + aP09 * log10(D)**9 \ + + aP10 * log10(D)**10 \ + + aP11 * log10(D)**11 \ + + aP12 * log10(D)**12 \ + + aP13 * log10(D)**13 \ + + aP14 * log10(D)**14 ) + + +# Mars crater SFD +# Ivanov (2001) SSR v. 96 pp. 87-104 +aM00 = -3.384 +aM01 = -3.197 +aM02 = 1.257 +aM03 = 0.7915 +aM04 = -0.4861 +aM05 = -0.3630 +aM06 = 0.1016 +aM07 = 6.756e-2 +aM08 = -1.181e-2 +aM09 = -4.753e-3 +aM10 = 6.233e-4 +aM11 = 5.805e-5 + +N1mars(T) = 2.68e-14 * (exp(6.93*T) - 1) + 4.13e-4*T + +Nmars(D) = D < 0.01 ? 1/0 : D > 1000 ? 1/0 : 10**( \ + aM00 \ + + aM01 * log10(D)**1 \ + + aM02 * log10(D)**2 \ + + aM03 * log10(D)**3 \ + + aM04 * log10(D)**4 \ + + aM05 * log10(D)**5 \ + + aM06 * log10(D)**6 \ + + aM07 * log10(D)**7 \ + + aM08 * log10(D)**8 \ + + aM09 * log10(D)**9 \ + + aM10 * log10(D)**10 \ + + aM11 * log10(D)**11 ) diff --git a/test/Plottingya b/test/Plottingya new file mode 100755 index 00000000..b6166e9b --- /dev/null +++ b/test/Plottingya @@ -0,0 +1,20 @@ +#!/bin/csh + +#http://hamelot.io/visualization/using-ffmpeg-to-convert-a-set-of-images-into-a-video/ +module load idl + +@ count = 1 +set cnt = 1 +foreach file (agetop0*) +@ cnt = $count +sed '2 i\ncount='`printf %d $count`'' tem.pro > tem1.pro +sed -e 's/INFILE/agetop'`printf %06d $cnt`'/' tem1.pro > tem2.pro +idl < tem.in +idl < run.in +rm tem1.pro tem2.pro +@ count++ +end + +cd agetop +module load ffmpeg +ffmpeg -f image2 -r 10 -i ./agetop%06d.jpg ./out.mp4 diff --git a/test/Robbins2014-A15-FassettCounts-binned.dat b/test/Robbins2014-A15-FassettCounts-binned.dat new file mode 100644 index 00000000..e7a8761f --- /dev/null +++ b/test/Robbins2014-A15-FassettCounts-binned.dat @@ -0,0 +1,13 @@ + 5.1241684784040373 6.23948354994535758E-004 21.000000000000000 + 6.9159685663443886 1.94218692856060401E-002 376.00000000000000 + 9.1971717131274460 5.97003450726182050E-002 695.00000000000000 + 12.816081239799573 6.62346057220059986E-002 403.00000000000000 + 17.996125645322635 5.46997230809128931E-002 170.00000000000000 + 25.800613087626900 6.43643621282638384E-002 96.000000000000000 + 36.348639964664329 5.70035776365636210E-002 43.000000000000000 + 50.608244555146413 5.81896598544816915E-002 23.000000000000000 + 72.473302918894660 8.93145572505870955E-002 17.000000000000000 + 101.84498213506704 8.24770394157215703E-002 8.0000000000000000 + 147.19614402527847 0.13205344016811349 6.0000000000000000 + 210.22410381342851 0.0000000000000000 0.0000000000000000 + 262.53658899999999 6.24379576535417230E-002 1.0000000000000000 diff --git a/test/agetop.dat b/test/agetop.dat new file mode 100644 index 00000000..404c1037 Binary files /dev/null and b/test/agetop.dat differ diff --git a/examples/regolith-transport-run-example/cleanup b/test/cleanup similarity index 51% rename from examples/regolith-transport-run-example/cleanup rename to test/cleanup index 43b86768..ba870cc9 100755 --- a/examples/regolith-transport-run-example/cleanup +++ b/test/cleanup @@ -1,33 +1,28 @@ #!/bin/bash -rm console/console*.* -rm surf/surf*.* -rm rego/rego*.* -rm shaded/shaded*.* -rm dist/odist*.dat -rm dist/tdist*.dat -rm dist/pdist*.dat -rm dist/ocum*.dat -rm dist/tcum*.dat -rm misc/mass*.dat -rm misc/ctem*.dat +rm console/console*.jpg +rm surf/surf*.jpg +rm rego/rego*.jpg +rm shaded/shaded*.jpg +rm dist/*.dat +rm misc/ctem_*.dat rm presentation/presentation*.jpg rm surface_*.dat rm odistribution.dat rm pdistribution.dat rm tdistribution.dat -rm tcumulative.dat -rm ocumulative.dat rm craterscale.dat rm ctem.dat -rm fracdone.dat rm production.dat +rm tcumulative.dat rm ejecta_table_max.dat rm ejecta_table_min.dat -rm impactmass.dat rm frames/* +rm impactmass.dat +rm fracdone.dat rm regolithdepth.dat -rm avgkdiff.dat -rm *.o* -rm term.out -rm time.out -rm testprofile.dat +rm agedepth* +rm *top*.dat +rm newsuper* +rm loc* +rm surface* +rm comphisto* diff --git a/test/comptop.dat b/test/comptop.dat new file mode 100644 index 00000000..404c1037 Binary files /dev/null and b/test/comptop.dat differ diff --git a/test/craterscale.dat b/test/craterscale.dat new file mode 100644 index 00000000..c5982cdf --- /dev/null +++ b/test/craterscale.dat @@ -0,0 +1,2690 @@ +#Dimp(m) Dcrat(m) + 1.0069363000E-06 1.4688822571E-03 + 1.0171073000E-06 1.4805065633E-03 + 1.0273811000E-06 1.4922229331E-03 + 1.0377587000E-06 1.5040320511E-03 + 1.0482411000E-06 1.5159345962E-03 + 1.0588294000E-06 1.5279313547E-03 + 1.0695247000E-06 1.5400231063E-03 + 1.0803280000E-06 1.5522105115E-03 + 1.0912404000E-06 1.5644943377E-03 + 1.1022630000E-06 1.5768753457E-03 + 1.1133970000E-06 1.5893544021E-03 + 1.1246434000E-06 1.6019321425E-03 + 1.1360034000E-06 1.6146094203E-03 + 1.1474782000E-06 1.6273870816E-03 + 1.1590689000E-06 1.6402658544E-03 + 1.1707767000E-06 1.6532465715E-03 + 1.1826027000E-06 1.6663299478E-03 + 1.1945482000E-06 1.6795169131E-03 + 1.2066143000E-06 1.6928081691E-03 + 1.2188023000E-06 1.7062046312E-03 + 1.2311135000E-06 1.7197072073E-03 + 1.2435490000E-06 1.7333165787E-03 + 1.2561101000E-06 1.7470336394E-03 + 1.2687980000E-06 1.7608591668E-03 + 1.2816142000E-06 1.7747942578E-03 + 1.2945598000E-06 1.7888395664E-03 + 1.3076362000E-06 1.8029960655E-03 + 1.3208446000E-06 1.8172645043E-03 + 1.3341865000E-06 1.8316459484E-03 + 1.3476631000E-06 1.8461411321E-03 + 1.3612759000E-06 1.8607511054E-03 + 1.3750261000E-06 1.8754765882E-03 + 1.3889153000E-06 1.8903187217E-03 + 1.4029447000E-06 1.9052782111E-03 + 1.4171159000E-06 1.9203561810E-03 + 1.4314302000E-06 1.9355534282E-03 + 1.4458891000E-06 1.9508709547E-03 + 1.4604940000E-06 1.9663096482E-03 + 1.4752465000E-06 1.9818705999E-03 + 1.4901479000E-06 1.9975545761E-03 + 1.5051999000E-06 2.0133627565E-03 + 1.5204040000E-06 2.0292961017E-03 + 1.5357616000E-06 2.0453554592E-03 + 1.5512743000E-06 2.0615418784E-03 + 1.5669438000E-06 2.0778565035E-03 + 1.5827715000E-06 2.0943001578E-03 + 1.5987591000E-06 2.1108739686E-03 + 1.6149082000E-06 2.1275789499E-03 + 1.6312204000E-06 2.1444161076E-03 + 1.6476973000E-06 2.1613864390E-03 + 1.6643408000E-06 2.1784912408E-03 + 1.6811523000E-06 2.1957312869E-03 + 1.6981336000E-06 2.2131077533E-03 + 1.7152865000E-06 2.2306218061E-03 + 1.7326126000E-06 2.2482743983E-03 + 1.7501137000E-06 2.2660666778E-03 + 1.7677917000E-06 2.2839998841E-03 + 1.7856481000E-06 2.3020748420E-03 + 1.8036850000E-06 2.3202929745E-03 + 1.8219040000E-06 2.3386551894E-03 + 1.8403071000E-06 2.3571627886E-03 + 1.8588961000E-06 2.3758168628E-03 + 1.8776728000E-06 2.3946184931E-03 + 1.8966392000E-06 2.4135689515E-03 + 1.9157972000E-06 2.4326693995E-03 + 1.9351486000E-06 2.4519208895E-03 + 1.9546956000E-06 2.4713248617E-03 + 1.9744400000E-06 2.4908823483E-03 + 1.9943838000E-06 2.5105945703E-03 + 2.0145291000E-06 2.5304628372E-03 + 2.0348779000E-06 2.5504883487E-03 + 2.0554322000E-06 2.5706722948E-03 + 2.0761942000E-06 2.5910160511E-03 + 2.0971658000E-06 2.6115206885E-03 + 2.1183493000E-06 2.6321876589E-03 + 2.1397468000E-06 2.6530182075E-03 + 2.1613604000E-06 2.6740135688E-03 + 2.1831923000E-06 2.6951750639E-03 + 2.2052448000E-06 2.7165040993E-03 + 2.2275200000E-06 2.7380018770E-03 + 2.2500202000E-06 2.7596697811E-03 + 2.2727476000E-06 2.7815090883E-03 + 2.2957047000E-06 2.8035213515E-03 + 2.3188936000E-06 2.8257077286E-03 + 2.3423168000E-06 2.8480697491E-03 + 2.3659766000E-06 2.8706087392E-03 + 2.3898753000E-06 2.8933260142E-03 + 2.4140155000E-06 2.9162231622E-03 + 2.4383995000E-06 2.9393014746E-03 + 2.4630298000E-06 2.9625624205E-03 + 2.4879088000E-06 2.9860073624E-03 + 2.5130392000E-06 3.0096379335E-03 + 2.5384235000E-06 3.0334555653E-03 + 2.5640641000E-06 3.0574615840E-03 + 2.5899638000E-06 3.0816576778E-03 + 2.6161250000E-06 3.1060451485E-03 + 2.6425505000E-06 3.1306256582E-03 + 2.6692429000E-06 3.1554006698E-03 + 2.6962050000E-06 3.1803718190E-03 + 2.7234394000E-06 3.2055405428E-03 + 2.7509489000E-06 3.2309084507E-03 + 2.7787362000E-06 3.2564770465E-03 + 2.8068043000E-06 3.2822480966E-03 + 2.8351558000E-06 3.3082229862E-03 + 2.8637938000E-06 3.3344035459E-03 + 2.8927210000E-06 3.3607912260E-03 + 2.9219404000E-06 3.3873877376E-03 + 2.9514549000E-06 3.4141946865E-03 + 2.9812676000E-06 3.4412138461E-03 + 3.0113814000E-06 3.4684467944E-03 + 3.0417994000E-06 3.4958952761E-03 + 3.0725247000E-06 3.5235610213E-03 + 3.1035603000E-06 3.5514456558E-03 + 3.1349094000E-06 3.5795509710E-03 + 3.1665751000E-06 3.6078786537E-03 + 3.1985607000E-06 3.6364305547E-03 + 3.2308694000E-06 3.6652084204E-03 + 3.2635045000E-06 3.6942140714E-03 + 3.2964691000E-06 3.7234491356E-03 + 3.3297668000E-06 3.7529156692E-03 + 3.3634008000E-06 3.7826153584E-03 + 3.3973746000E-06 3.8125501391E-03 + 3.4316915000E-06 3.8427217554E-03 + 3.4663550000E-06 3.8731321118E-03 + 3.5013687000E-06 3.9037831843E-03 + 3.5367361000E-06 3.9346768452E-03 + 3.5724607000E-06 3.9658149508E-03 + 3.6085462000E-06 3.9971995155E-03 + 3.6449961000E-06 4.0288323636E-03 + 3.6818143000E-06 4.0607156499E-03 + 3.7190043000E-06 4.0928511657E-03 + 3.7565700000E-06 4.1252410320E-03 + 3.7945151000E-06 4.1578871798E-03 + 3.8328436000E-06 4.1907917813E-03 + 3.8715592000E-06 4.2239567336E-03 + 3.9106658000E-06 4.2573840886E-03 + 3.9501675000E-06 4.2910760515E-03 + 3.9900682000E-06 4.3250346385E-03 + 4.0303719000E-06 4.3592619342E-03 + 4.0710827000E-06 4.3937600899E-03 + 4.1122048000E-06 4.4285313233E-03 + 4.1537422000E-06 4.4635776650E-03 + 4.1956992000E-06 4.4989013809E-03 + 4.2380800000E-06 4.5345046335E-03 + 4.2808889000E-06 4.5703896513E-03 + 4.3241302000E-06 4.6065586437E-03 + 4.3678083000E-06 4.6430138850E-03 + 4.4119275000E-06 4.6797575473E-03 + 4.4564925000E-06 4.7167921162E-03 + 4.5015075000E-06 4.7541196424E-03 + 4.5469773000E-06 4.7917426551E-03 + 4.5929064000E-06 4.8296634151E-03 + 4.6392994000E-06 4.8678842460E-03 + 4.6861610000E-06 4.9064075344E-03 + 4.7334960000E-06 4.9452357285E-03 + 4.7813090000E-06 4.9843710924E-03 + 4.8296051000E-06 5.0238162791E-03 + 4.8783890000E-06 5.0635735936E-03 + 4.9276656000E-06 5.1036454841E-03 + 4.9774400000E-06 5.1440345400E-03 + 5.0277172000E-06 5.1847432484E-03 + 5.0785022000E-06 5.2257740751E-03 + 5.1298002000E-06 5.2671296265E-03 + 5.1816164000E-06 5.3088124870E-03 + 5.2339560000E-06 5.3508252190E-03 + 5.2868242000E-06 5.3931703635E-03 + 5.3402265000E-06 5.4358506798E-03 + 5.3941681000E-06 5.4788686648E-03 + 5.4486547000E-06 5.5222271917E-03 + 5.5036916000E-06 5.5659287925E-03 + 5.5592845000E-06 5.6099762944E-03 + 5.6154388000E-06 5.6543722637E-03 + 5.6721604000E-06 5.6991196393E-03 + 5.7294550000E-06 5.7442211780E-03 + 5.7873283000E-06 5.7896796136E-03 + 5.8457861000E-06 5.8354977348E-03 + 5.9048345000E-06 5.8816785416E-03 + 5.9644793000E-06 5.9282247746E-03 + 6.0247265000E-06 5.9751393070E-03 + 6.0855824000E-06 6.0224252207E-03 + 6.1470529000E-06 6.0700852618E-03 + 6.2091443000E-06 6.1181224624E-03 + 6.2718630000E-06 6.1665399063E-03 + 6.3352151000E-06 6.2153404203E-03 + 6.3992072000E-06 6.2645271915E-03 + 6.4638456000E-06 6.3141031503E-03 + 6.5291370000E-06 6.3640715081E-03 + 6.5950879000E-06 6.4144352968E-03 + 6.6617049000E-06 6.4651975989E-03 + 6.7289949000E-06 6.5163616987E-03 + 6.7969645000E-06 6.5679306257E-03 + 6.8656208000E-06 6.6199077619E-03 + 6.9349705000E-06 6.6722961588E-03 + 7.0050207000E-06 6.7250991438E-03 + 7.0757784000E-06 6.7783199408E-03 + 7.1472510000E-06 6.8319620466E-03 + 7.2194454000E-06 6.8860285546E-03 + 7.2923691000E-06 6.9405229798E-03 + 7.3660294000E-06 6.9954486589E-03 + 7.4404337000E-06 7.0508089746E-03 + 7.5155896000E-06 7.1066074297E-03 + 7.5915047000E-06 7.1628474974E-03 + 7.6681865000E-06 7.2195325477E-03 + 7.7456430000E-06 7.2766662908E-03 + 7.8238818000E-06 7.3342521115E-03 + 7.9029109000E-06 7.3922936595E-03 + 7.9827383000E-06 7.4507945541E-03 + 8.0633720000E-06 7.5097583837E-03 + 8.1448202000E-06 7.5691888526E-03 + 8.2270911000E-06 7.6290896337E-03 + 8.3101930000E-06 7.6894644416E-03 + 8.3941344000E-06 7.7503171046E-03 + 8.4789236000E-06 7.8116512741E-03 + 8.5645693000E-06 7.8734708592E-03 + 8.6510801000E-06 7.9357796642E-03 + 8.7384648000E-06 7.9985816049E-03 + 8.8267321000E-06 8.0618804926E-03 + 8.9158910000E-06 8.1256803209E-03 + 9.0059505000E-06 8.1899850497E-03 + 9.0969197000E-06 8.2547986768E-03 + 9.1888078000E-06 8.3201252375E-03 + 9.2816240000E-06 8.3859687328E-03 + 9.3753778000E-06 8.4523333425E-03 + 9.4700786000E-06 8.5192231404E-03 + 9.5657359000E-06 8.5866422367E-03 + 9.6623595000E-06 8.6545949173E-03 + 9.7599591000E-06 8.7230853624E-03 + 9.8585446000E-06 8.7921178567E-03 + 9.9581258000E-06 8.8616965789E-03 + 1.0058713000E-05 8.9318260209E-03 + 1.0160316000E-05 9.0025102894E-03 + 1.0262946000E-05 9.0737544272E-03 + 1.0366612000E-05 9.1455619123E-03 + 1.0471325000E-05 9.2179375746E-03 + 1.0577096000E-05 9.2908862031E-03 + 1.0683935000E-05 9.3644118592E-03 + 1.0791854000E-05 9.4385199418E-03 + 1.0900862000E-05 9.5132137510E-03 + 1.1010972000E-05 9.5884992914E-03 + 1.1122194000E-05 9.6643804721E-03 + 1.1234539000E-05 9.7408618495E-03 + 1.1348020000E-05 9.8179492989E-03 + 1.1462646000E-05 9.8956459373E-03 + 1.1578430000E-05 9.9739575586E-03 + 1.1695384000E-05 1.0052889233E-02 + 1.1813519000E-05 1.0132445317E-02 + 1.1932848000E-05 1.0212631471E-02 + 1.2053382000E-05 1.0293451968E-02 + 1.2175133000E-05 1.0374911715E-02 + 1.2298114000E-05 1.0457016244E-02 + 1.2422338000E-05 1.0539771040E-02 + 1.2547816000E-05 1.0623180214E-02 + 1.2674561000E-05 1.0707249168E-02 + 1.2802587000E-05 1.0791983919E-02 + 1.2931906000E-05 1.0877389114E-02 + 1.3062532000E-05 1.0963470678E-02 + 1.3194476000E-05 1.1050232515E-02 + 1.3327754000E-05 1.1137681773E-02 + 1.3462378000E-05 1.1225822925E-02 + 1.3598361000E-05 1.1314661059E-02 + 1.3735719000E-05 1.1404203171E-02 + 1.3874463000E-05 1.1494452953E-02 + 1.4014609000E-05 1.1585417304E-02 + 1.4156171000E-05 1.1677101775E-02 + 1.4299163000E-05 1.1769511867E-02 + 1.4443599000E-05 1.1862653036E-02 + 1.4589494000E-05 1.1956531335E-02 + 1.4736862000E-05 1.2051152124E-02 + 1.4885719000E-05 1.2146521999E-02 + 1.5036080000E-05 1.2242646860E-02 + 1.5187960000E-05 1.2339532560E-02 + 1.5341373000E-05 1.2437184264E-02 + 1.5496337000E-05 1.2535609633E-02 + 1.5652865000E-05 1.2634813098E-02 + 1.5810975000E-05 1.2734802212E-02 + 1.5970682000E-05 1.2835582571E-02 + 1.6132002000E-05 1.2937160355E-02 + 1.6294952000E-05 1.3039542318E-02 + 1.6459547000E-05 1.3142733907E-02 + 1.6625805000E-05 1.3246742396E-02 + 1.6793743000E-05 1.3351574374E-02 + 1.6963376000E-05 1.3457235131E-02 + 1.7134724000E-05 1.3563733017E-02 + 1.7307802000E-05 1.3671073214E-02 + 1.7482628000E-05 1.3779262713E-02 + 1.7659220000E-05 1.3888308448E-02 + 1.7837596000E-05 1.3998217296E-02 + 1.8017774000E-05 1.4108996073E-02 + 1.8199771000E-05 1.4220650927E-02 + 1.8383608000E-05 1.4333190398E-02 + 1.8569301000E-05 1.4446619906E-02 + 1.8756869000E-05 1.4560946651E-02 + 1.8946333000E-05 1.4676178986E-02 + 1.9137710000E-05 1.4792322771E-02 + 1.9331020000E-05 1.4909385629E-02 + 1.9526283000E-05 1.5027375121E-02 + 1.9723518000E-05 1.5146298142E-02 + 1.9922745000E-05 1.5266162127E-02 + 2.0123985000E-05 1.5386975053E-02 + 2.0327258000E-05 1.5508744226E-02 + 2.0532584000E-05 1.5631476895E-02 + 2.0739983000E-05 1.5755180245E-02 + 2.0949478000E-05 1.5879863187E-02 + 2.1161089000E-05 1.6005532773E-02 + 2.1374837000E-05 1.6132196593E-02 + 2.1590745000E-05 1.6259863349E-02 + 2.1808833000E-05 1.6388539906E-02 + 2.2029124000E-05 1.6518234833E-02 + 2.2251641000E-05 1.6648956627E-02 + 2.2476405000E-05 1.6780712544E-02 + 2.2703439000E-05 1.6913510946E-02 + 2.2932767000E-05 1.7047360707E-02 + 2.3164411000E-05 1.7182269466E-02 + 2.3398395000E-05 1.7318245954E-02 + 2.3634742000E-05 1.7455298254E-02 + 2.3873477000E-05 1.7593435534E-02 + 2.4114623000E-05 1.7732665731E-02 + 2.4358206000E-05 1.7872998444E-02 + 2.4604248000E-05 1.8014440893E-02 + 2.4852776000E-05 1.8157003101E-02 + 2.5103814000E-05 1.8300693293E-02 + 2.5357388000E-05 1.8445520766E-02 + 2.5613523000E-05 1.8591494168E-02 + 2.5872245000E-05 1.8738622644E-02 + 2.6133581000E-05 1.8886915827E-02 + 2.6397557000E-05 1.9036382704E-02 + 2.6664199000E-05 1.9187032188E-02 + 2.6933534000E-05 1.9338873677E-02 + 2.7205590000E-05 1.9491917054E-02 + 2.7480394000E-05 1.9646171558E-02 + 2.7757974000E-05 1.9801646909E-02 + 2.8038357000E-05 1.9958352187E-02 + 2.8321573000E-05 2.0116298067E-02 + 2.8607650000E-05 2.0275494023E-02 + 2.8896616000E-05 2.0435949448E-02 + 2.9188501000E-05 2.0597674763E-02 + 2.9483334000E-05 2.0760679751E-02 + 2.9781146000E-05 2.0924975213E-02 + 3.0081965000E-05 2.1090570208E-02 + 3.0385823000E-05 2.1257475918E-02 + 3.0692751000E-05 2.1425702878E-02 + 3.1002779000E-05 2.1595260992E-02 + 3.1315938000E-05 2.1766160625E-02 + 3.1632261000E-05 2.1938413140E-02 + 3.1951778000E-05 2.2112028180E-02 + 3.2274524000E-05 2.2287018012E-02 + 3.2600529000E-05 2.2463392098E-02 + 3.2929827000E-05 2.2641161979E-02 + 3.3262452000E-05 2.2820339097E-02 + 3.3598436000E-05 2.3000933725E-02 + 3.3937814000E-05 2.3182957656E-02 + 3.4280620000E-05 2.3366422049E-02 + 3.4626889000E-05 2.3551338504E-02 + 3.4976656000E-05 2.3737718522E-02 + 3.5329955000E-05 2.3925572976E-02 + 3.5686824000E-05 2.4114914768E-02 + 3.6047297000E-05 2.4305754575E-02 + 3.6411411000E-05 2.4498104570E-02 + 3.6779203000E-05 2.4691976821E-02 + 3.7150710000E-05 2.4887383293E-02 + 3.7525970000E-05 2.5084336379E-02 + 3.7905020000E-05 2.5282847841E-02 + 3.8287899000E-05 2.5482930387E-02 + 3.8674645000E-05 2.5684596098E-02 + 3.9065298000E-05 2.5887857991E-02 + 3.9459897000E-05 2.6092728456E-02 + 3.9858482000E-05 2.6299220297E-02 + 4.0261093000E-05 2.6507346208E-02 + 4.0667771000E-05 2.6717119293E-02 + 4.1078556000E-05 2.6928552032E-02 + 4.1493491000E-05 2.7141658337E-02 + 4.1912617000E-05 2.7356450981E-02 + 4.2335977000E-05 2.7572943651E-02 + 4.2763613000E-05 2.7791149407E-02 + 4.3195569000E-05 2.8011082218E-02 + 4.3631888000E-05 2.8232755429E-02 + 4.4072614000E-05 2.8456182777E-02 + 4.4517792000E-05 2.8681378388E-02 + 4.4967467000E-05 2.8908356273E-02 + 4.5421683000E-05 2.9137129817E-02 + 4.5880488000E-05 2.9367714304E-02 + 4.6343928000E-05 2.9600123887E-02 + 4.6812048000E-05 2.9834372097E-02 + 4.7284897000E-05 3.0070474351E-02 + 4.7762522000E-05 3.0308444937E-02 + 4.8244972000E-05 3.0548299018E-02 + 4.8732295000E-05 3.0790051132E-02 + 4.9224540000E-05 3.1033716191E-02 + 4.9721758000E-05 3.1279309967E-02 + 5.0223998000E-05 3.1526847116E-02 + 5.0731311000E-05 3.1776343151E-02 + 5.1243748000E-05 3.2027813457E-02 + 5.1761362000E-05 3.2281274265E-02 + 5.2284204000E-05 3.2536740695E-02 + 5.2812327000E-05 3.2794228713E-02 + 5.3345785000E-05 3.3053754638E-02 + 5.3884632000E-05 3.3315334649E-02 + 5.4428921000E-05 3.3578984308E-02 + 5.4978708000E-05 3.3844720493E-02 + 5.5534048000E-05 3.4112559456E-02 + 5.6094998000E-05 3.4382518278E-02 + 5.6661614000E-05 3.4654613413E-02 + 5.7233954000E-05 3.4928862136E-02 + 5.7812075000E-05 3.5205281097E-02 + 5.8396035000E-05 3.5483887284E-02 + 5.8985894000E-05 3.5764698493E-02 + 5.9581711000E-05 3.6047731894E-02 + 6.0183547000E-05 3.6333005461E-02 + 6.0791461000E-05 3.6620536072E-02 + 6.1405516000E-05 3.6910342348E-02 + 6.2025774000E-05 3.7202442283E-02 + 6.2652297000E-05 3.7496853719E-02 + 6.3285149000E-05 3.7793595285E-02 + 6.3924392000E-05 3.8092684519E-02 + 6.4570093000E-05 3.8394141142E-02 + 6.5222317000E-05 3.8697983780E-02 + 6.5881128000E-05 3.9004230436E-02 + 6.6546594000E-05 3.9312900815E-02 + 6.7218782000E-05 3.9624013996E-02 + 6.7897759000E-05 3.9937588895E-02 + 6.8583595000E-05 4.0253645650E-02 + 6.9276359000E-05 4.0572203771E-02 + 6.9976120000E-05 4.0893282604E-02 + 7.0682949000E-05 4.1216902246E-02 + 7.1396919000E-05 4.1543083538E-02 + 7.2118100000E-05 4.1871845778E-02 + 7.2846565000E-05 4.2203209468E-02 + 7.3582389000E-05 4.2537195841E-02 + 7.4325646000E-05 4.2873825501E-02 + 7.5076410000E-05 4.3213118877E-02 + 7.5834757000E-05 4.3555097127E-02 + 7.6600765000E-05 4.3899782131E-02 + 7.7374510000E-05 4.4247194688E-02 + 7.8156071000E-05 4.4597356762E-02 + 7.8945526000E-05 4.4950289689E-02 + 7.9742956000E-05 4.5306015960E-02 + 8.0548440000E-05 4.5664556988E-02 + 8.1362061000E-05 4.6025935780E-02 + 8.2183900000E-05 4.6390174264E-02 + 8.3014040000E-05 4.6757295068E-02 + 8.3852566000E-05 4.7127321510E-02 + 8.4699561000E-05 4.7500275832E-02 + 8.5555112000E-05 4.7876181845E-02 + 8.6419305000E-05 4.8255062722E-02 + 8.7292228000E-05 4.8636942313E-02 + 8.8173967000E-05 4.9021843397E-02 + 8.9064613000E-05 4.9409790735E-02 + 8.9964256000E-05 4.9800808449E-02 + 9.0872986000E-05 5.0194920453E-02 + 9.1790895000E-05 5.0592151328E-02 + 9.2718076000E-05 5.0992525878E-02 + 9.3654622000E-05 5.1396068699E-02 + 9.4600628000E-05 5.1802805037E-02 + 9.5556190000E-05 5.2212760356E-02 + 9.6521404000E-05 5.2625959904E-02 + 9.7496368000E-05 5.3042429573E-02 + 9.8481179000E-05 5.3462194607E-02 + 9.9475939000E-05 5.3885282165E-02 + 1.0048075000E-04 5.4311719176E-02 + 1.0149570000E-04 5.4741526420E-02 + 1.0252091000E-04 5.5174738433E-02 + 1.0355648000E-04 5.5611380612E-02 + 1.0460250000E-04 5.6051473941E-02 + 1.0565909000E-04 5.6495051807E-02 + 1.0672636000E-04 5.6942143131E-02 + 1.0780440000E-04 5.7392768238E-02 + 1.0889333000E-04 5.7846959785E-02 + 1.0999327000E-04 5.8304750153E-02 + 1.1110431000E-04 5.8766159001E-02 + 1.1222658000E-04 5.9231222387E-02 + 1.1336018000E-04 5.9699963668E-02 + 1.1450523000E-04 6.0172414251E-02 + 1.1566185000E-04 6.0648605278E-02 + 1.1683015000E-04 6.1128563525E-02 + 1.1801025000E-04 6.1612319637E-02 + 1.1920227000E-04 6.2099904001E-02 + 1.2040634000E-04 6.2591350826E-02 + 1.2162256000E-04 6.3086681827E-02 + 1.2285107000E-04 6.3585934775E-02 + 1.2409199000E-04 6.4089139023E-02 + 1.2534545000E-04 6.4596327716E-02 + 1.2661156000E-04 6.5107525654E-02 + 1.2789047000E-04 6.5622773530E-02 + 1.2918229000E-04 6.6142095625E-02 + 1.3048716000E-04 6.6665528043E-02 + 1.3180522000E-04 6.7193106581E-02 + 1.3313658000E-04 6.7724854763E-02 + 1.3448140000E-04 6.8260815827E-02 + 1.3583979000E-04 6.8801012779E-02 + 1.3721191000E-04 6.9345488252E-02 + 1.3859789000E-04 6.9894272657E-02 + 1.3999787000E-04 7.0447400092E-02 + 1.4141199000E-04 7.1004904369E-02 + 1.4284039000E-04 7.1566819017E-02 + 1.4428323000E-04 7.2133185123E-02 + 1.4574063000E-04 7.2704027779E-02 + 1.4721276000E-04 7.3279391386E-02 + 1.4869976000E-04 7.3859308285E-02 + 1.5020178000E-04 7.4443814429E-02 + 1.5171897000E-04 7.5032945472E-02 + 1.5325148000E-04 7.5626736765E-02 + 1.5479948000E-04 7.6225231090E-02 + 1.5636311000E-04 7.6828459301E-02 + 1.5794253000E-04 7.7436459689E-02 + 1.5953791000E-04 7.8049274058E-02 + 1.6114940000E-04 7.8666936200E-02 + 1.6277718000E-04 7.9289491087E-02 + 1.6442139000E-04 7.9916968061E-02 + 1.6608221000E-04 8.0549411436E-02 + 1.6775981000E-04 8.1186861356E-02 + 1.6945435000E-04 8.1829353837E-02 + 1.7116601000E-04 8.2476932155E-02 + 1.7289496000E-04 8.3129635446E-02 + 1.7464138000E-04 8.3787506283E-02 + 1.7640543000E-04 8.4450579368E-02 + 1.7818731000E-04 8.5118904100E-02 + 1.7998718000E-04 8.5792514507E-02 + 1.8180523000E-04 8.6471455522E-02 + 1.8364165000E-04 8.7155771700E-02 + 1.8549661000E-04 8.7845499791E-02 + 1.8737032000E-04 8.8540691064E-02 + 1.8926294000E-04 8.9241377860E-02 + 1.9117469000E-04 8.9947614395E-02 + 1.9310575000E-04 9.0659439695E-02 + 1.9505631000E-04 9.1376896133E-02 + 1.9702658000E-04 9.2100033059E-02 + 1.9901675000E-04 9.2828892090E-02 + 2.0102702000E-04 9.3563518144E-02 + 2.0305759000E-04 9.4303955759E-02 + 2.0510868000E-04 9.5050256369E-02 + 2.0718048000E-04 9.5802460095E-02 + 2.0927322000E-04 9.6560621195E-02 + 2.1138709000E-04 9.7324779025E-02 + 2.1352231000E-04 9.8094983420E-02 + 2.1567910000E-04 9.8871283799E-02 + 2.1785768000E-04 9.9653729159E-02 + 2.2005826000E-04 1.0044236451E-01 + 2.2228107000E-04 1.0123724162E-01 + 2.2452633000E-04 1.0203840827E-01 + 2.2679428000E-04 1.0284591894E-01 + 2.2908513000E-04 1.0365981701E-01 + 2.3139912000E-04 1.0448015611E-01 + 2.3373648000E-04 1.0530698590E-01 + 2.3609746000E-04 1.0614036267E-01 + 2.3848228000E-04 1.0698033166E-01 + 2.4089119000E-04 1.0782694830E-01 + 2.4332444000E-04 1.0868026751E-01 + 2.4578226000E-04 1.0954033680E-01 + 2.4826491000E-04 1.1040721370E-01 + 2.5077264000E-04 1.1128095182E-01 + 2.5330569000E-04 1.1216160081E-01 + 2.5586434000E-04 1.1304922378E-01 + 2.5844882000E-04 1.1394386601E-01 + 2.6105942000E-04 1.1484559313E-01 + 2.6369638000E-04 1.1575445295E-01 + 2.6635998000E-04 1.1667050667E-01 + 2.6905049000E-04 1.1759381152E-01 + 2.7176817000E-04 1.1852442084E-01 + 2.7451330000E-04 1.1946239433E-01 + 2.7728616000E-04 1.2040779121E-01 + 2.8008703000E-04 1.2136067019E-01 + 2.8291620000E-04 1.2232109287E-01 + 2.8577393000E-04 1.2328911020E-01 + 2.8866054000E-04 1.2426479293E-01 + 2.9157630000E-04 1.2524819440E-01 + 2.9452152000E-04 1.2623938093E-01 + 2.9749648000E-04 1.2723840822E-01 + 3.0050150000E-04 1.2824534489E-01 + 3.0353687000E-04 1.2926024898E-01 + 3.0660290000E-04 1.3028318467E-01 + 3.0969989000E-04 1.3131421232E-01 + 3.1282818000E-04 1.3235340501E-01 + 3.1598806000E-04 1.3340081868E-01 + 3.1917986000E-04 1.3445652201E-01 + 3.2240389000E-04 1.3552057649E-01 + 3.2566050000E-04 1.3659305628E-01 + 3.2895000000E-04 1.3767402176E-01 + 3.3227273000E-04 1.3876354264E-01 + 3.3562902000E-04 1.3986168478E-01 + 3.3901921000E-04 1.4096851673E-01 + 3.4244365000E-04 1.4208410973E-01 + 3.4590267000E-04 1.4320852792E-01 + 3.4939664000E-04 1.4434184787E-01 + 3.5292590000E-04 1.4548413580E-01 + 3.5649081000E-04 1.4663546383E-01 + 3.6009172000E-04 1.4779590023E-01 + 3.6372901000E-04 1.4896552236E-01 + 3.6740304000E-04 1.5014440051E-01 + 3.7111418000E-04 1.5133260758E-01 + 3.7486281000E-04 1.5253021903E-01 + 3.7864931000E-04 1.5373730971E-01 + 3.8247405000E-04 1.5495395064E-01 + 3.8633742000E-04 1.5618021859E-01 + 3.9023982000E-04 1.5741619287E-01 + 3.9418164000E-04 1.5866194893E-01 + 3.9816327000E-04 1.5991756160E-01 + 4.0218512000E-04 1.6118311137E-01 + 4.0624760000E-04 1.6245867806E-01 + 4.1035111000E-04 1.6374433767E-01 + 4.1449607000E-04 1.6504017182E-01 + 4.1868290000E-04 1.6634626143E-01 + 4.2291202000E-04 1.6766268675E-01 + 4.2718385000E-04 1.6898952735E-01 + 4.3149884000E-04 1.7032687142E-01 + 4.3585742000E-04 1.7167480023E-01 + 4.4026002000E-04 1.7303339436E-01 + 4.4470709000E-04 1.7440273987E-01 + 4.4919908000E-04 1.7578292209E-01 + 4.5373644000E-04 1.7717402563E-01 + 4.5831964000E-04 1.7857614052E-01 + 4.6294913000E-04 1.7998934990E-01 + 4.6762539000E-04 1.8141374537E-01 + 4.7234887000E-04 1.8284940863E-01 + 4.7712007000E-04 1.8429643584E-01 + 4.8193947000E-04 1.8575491632E-01 + 4.8680754000E-04 1.8722493561E-01 + 4.9172479000E-04 1.8870659057E-01 + 4.9669171000E-04 1.9019997125E-01 + 5.0170880000E-04 1.9170516991E-01 + 5.0677656000E-04 1.9322227807E-01 + 5.1189552000E-04 1.9475139540E-01 + 5.1706618000E-04 1.9629261183E-01 + 5.2228907000E-04 1.9784602541E-01 + 5.2756472000E-04 1.9941173339E-01 + 5.3289365000E-04 2.0098982924E-01 + 5.3827642000E-04 2.0258041744E-01 + 5.4371355000E-04 2.0418358982E-01 + 5.4920561000E-04 2.0579945212E-01 + 5.5475314000E-04 2.0742810040E-01 + 5.6035671000E-04 2.0906963870E-01 + 5.6601688000E-04 2.1072416725E-01 + 5.7173422000E-04 2.1239178835E-01 + 5.7750931000E-04 2.1407260634E-01 + 5.8334274000E-04 2.1576672761E-01 + 5.8923509000E-04 2.1747425473E-01 + 5.9518696000E-04 2.1919529521E-01 + 6.0119895000E-04 2.2092995562E-01 + 6.0727167000E-04 2.2267834454E-01 + 6.1340572000E-04 2.2444056676E-01 + 6.1960174000E-04 2.2621673763E-01 + 6.2586035000E-04 2.2800696583E-01 + 6.3218217000E-04 2.2981135911E-01 + 6.3856785000E-04 2.3163003285E-01 + 6.4501803000E-04 2.3346309864E-01 + 6.5153336000E-04 2.3531066993E-01 + 6.5811450000E-04 2.3717286207E-01 + 6.6476213000E-04 2.3904979508E-01 + 6.7147689000E-04 2.4094157668E-01 + 6.7825949000E-04 2.4284833338E-01 + 6.8511060000E-04 2.4477017939E-01 + 6.9203090000E-04 2.4670723076E-01 + 6.9902112000E-04 2.4865961653E-01 + 7.0608194000E-04 2.5062745071E-01 + 7.1321408000E-04 2.5261085747E-01 + 7.2041826000E-04 2.5460995995E-01 + 7.2769521000E-04 2.5662488300E-01 + 7.3504567000E-04 2.5865575319E-01 + 7.4247037000E-04 2.6070269326E-01 + 7.4997007000E-04 2.6276583316E-01 + 7.5754553000E-04 2.6484530177E-01 + 7.6519750000E-04 2.6694122413E-01 + 7.7292677000E-04 2.6905373514E-01 + 7.8073411000E-04 2.7118296313E-01 + 7.8862031000E-04 2.7332904078E-01 + 7.9658618000E-04 2.7549210509E-01 + 8.0463250000E-04 2.7767228377E-01 + 8.1276010000E-04 2.7986971697E-01 + 8.2096980000E-04 2.8208454095E-01 + 8.2926242000E-04 2.8431689085E-01 + 8.3763881000E-04 2.8656690870E-01 + 8.4609981000E-04 2.8883473267E-01 + 8.5464627000E-04 2.9112050241E-01 + 8.6327906000E-04 2.9342436178E-01 + 8.7199905000E-04 2.9574645337E-01 + 8.8080713000E-04 2.9808692392E-01 + 8.8970417000E-04 3.0044591362E-01 + 8.9869108000E-04 3.0282357206E-01 + 9.0776877000E-04 3.0522004755E-01 + 9.1693815000E-04 3.0763548717E-01 + 9.2620015000E-04 3.1007004203E-01 + 9.3555571000E-04 3.1252386454E-01 + 9.4500576000E-04 3.1499710326E-01 + 9.5455128000E-04 3.1748991851E-01 + 9.6419321000E-04 3.2000245887E-01 + 9.7393253000E-04 3.2253488205E-01 + 9.8377024000E-04 3.2508734961E-01 + 9.9370731000E-04 3.2766001401E-01 + 1.0037448000E-03 3.3025304962E-01 + 1.0138836000E-03 3.3286658560E-01 + 1.0241248000E-03 3.3550080140E-01 + 1.0344695000E-03 3.3815587752E-01 + 1.0449187000E-03 3.4083196736E-01 + 1.0554735000E-03 3.4352924854E-01 + 1.0661348000E-03 3.4624784627E-01 + 1.0769038000E-03 3.4898796094E-01 + 1.0877817000E-03 3.5174979125E-01 + 1.0987694000E-03 3.5453345831E-01 + 1.1098680000E-03 3.5733913272E-01 + 1.1210788000E-03 3.6016703404E-01 + 1.1324029000E-03 3.6301732969E-01 + 1.1438413000E-03 3.6589016059E-01 + 1.1553952000E-03 3.6878571654E-01 + 1.1670659000E-03 3.7170421074E-01 + 1.1788544000E-03 3.7464577979E-01 + 1.1907620000E-03 3.7761063379E-01 + 1.2027899000E-03 3.8059895623E-01 + 1.2149393000E-03 3.8361092904E-01 + 1.2272114000E-03 3.8664673267E-01 + 1.2396075000E-03 3.8970657065E-01 + 1.2521288000E-03 3.9279062023E-01 + 1.2647766000E-03 3.9589908170E-01 + 1.2775521000E-03 3.9903212918E-01 + 1.2904567000E-03 4.0218998422E-01 + 1.3034916000E-03 4.0537281768E-01 + 1.3166582000E-03 4.0858084772E-01 + 1.3299577000E-03 4.1181424204E-01 + 1.3433917000E-03 4.1507326389E-01 + 1.3569613000E-03 4.1835805338E-01 + 1.3706679000E-03 4.2166882186E-01 + 1.3845131000E-03 4.2500582701E-01 + 1.3984981000E-03 4.2836922827E-01 + 1.4126243000E-03 4.3175923168E-01 + 1.4268932000E-03 4.3517606546E-01 + 1.4413063000E-03 4.3861995592E-01 + 1.4558649000E-03 4.4209107981E-01 + 1.4705707000E-03 4.4558970748E-01 + 1.4854249000E-03 4.4911598841E-01 + 1.5004292000E-03 4.5267018914E-01 + 1.5155850000E-03 4.5625250316E-01 + 1.5308940000E-03 4.5986319297E-01 + 1.5463576000E-03 4.6350244835E-01 + 1.5619773000E-03 4.6717048096E-01 + 1.5777549000E-03 4.7086757087E-01 + 1.5936918000E-03 4.7459390238E-01 + 1.6097897000E-03 4.7834972816E-01 + 1.6260502000E-03 4.8213527549E-01 + 1.6424749000E-03 4.8595076974E-01 + 1.6590656000E-03 4.8979648070E-01 + 1.6758238000E-03 4.9367260655E-01 + 1.6927514000E-03 4.9757943605E-01 + 1.7098499000E-03 5.0151716349E-01 + 1.7271211000E-03 5.0548605040E-01 + 1.7445667000E-03 5.0948633321E-01 + 1.7621886000E-03 5.1351829204E-01 + 1.7799885000E-03 5.1758215908E-01 + 1.7979682000E-03 5.2167818730E-01 + 1.8161295000E-03 5.2580662753E-01 + 1.8344742000E-03 5.2996772851E-01 + 1.8530043000E-03 5.3416178210E-01 + 1.8717215000E-03 5.3838901002E-01 + 1.8906278000E-03 5.4264969965E-01 + 1.9097250000E-03 5.4694409103E-01 + 1.9290152000E-03 5.5127248943E-01 + 1.9485002000E-03 5.5563513044E-01 + 1.9681820000E-03 5.6003229232E-01 + 1.9880626000E-03 5.6446425097E-01 + 2.0081440000E-03 5.6893127997E-01 + 2.0284283000E-03 5.7343367278E-01 + 2.0489175000E-03 5.7797169825E-01 + 2.0696136000E-03 5.8254562298E-01 + 2.0905188000E-03 5.8715575538E-01 + 2.1116352000E-03 5.9180237927E-01 + 2.1329648000E-03 5.9648575417E-01 + 2.1545099000E-03 6.0120620305E-01 + 2.1762727000E-03 6.0596402434E-01 + 2.1982552000E-03 6.1075947037E-01 + 2.2204598000E-03 6.1559287832E-01 + 2.2428887000E-03 6.2046453914E-01 + 2.2655441000E-03 6.2537474133E-01 + 2.2884284000E-03 6.3032381417E-01 + 2.3115439000E-03 6.3531206260E-01 + 2.3348928000E-03 6.4033976750E-01 + 2.3584776000E-03 6.4540727176E-01 + 2.3823006000E-03 6.5051487257E-01 + 2.4063642000E-03 6.5566288596E-01 + 2.4306709000E-03 6.6085164666E-01 + 2.4552231000E-03 6.6608146527E-01 + 2.4800234000E-03 6.7135269226E-01 + 2.5050741000E-03 6.7666561157E-01 + 2.5303779000E-03 6.8202058934E-01 + 2.5559373000E-03 6.8741794643E-01 + 2.5817548000E-03 6.9285800097E-01 + 2.6078332000E-03 6.9834113147E-01 + 2.6341749000E-03 7.0386762938E-01 + 2.6607827000E-03 7.0943786737E-01 + 2.6876593000E-03 7.1505219409E-01 + 2.7148074000E-03 7.2071095528E-01 + 2.7422297000E-03 7.2641449374E-01 + 2.7699290000E-03 7.3216317014E-01 + 2.7979081000E-03 7.3795734209E-01 + 2.8261698000E-03 7.4379736420E-01 + 2.8547169000E-03 7.4968358812E-01 + 2.8835525000E-03 7.5561642415E-01 + 2.9126793000E-03 7.6159619715E-01 + 2.9421003000E-03 7.6762329059E-01 + 2.9718184000E-03 7.7369806434E-01 + 3.0018368000E-03 7.7982093634E-01 + 3.0321584000E-03 7.8599226001E-01 + 3.0627863000E-03 7.9221242639E-01 + 3.0937235000E-03 7.9848180298E-01 + 3.1249732000E-03 8.0480079457E-01 + 3.1565386000E-03 8.1116980256E-01 + 3.1884228000E-03 8.1758920485E-01 + 3.2206291000E-03 8.2405941630E-01 + 3.2531607000E-03 8.3058082825E-01 + 3.2860209000E-03 8.3715384873E-01 + 3.3192131000E-03 8.4377890226E-01 + 3.3527405000E-03 8.5045637002E-01 + 3.3866065000E-03 8.5718666966E-01 + 3.4208147000E-03 8.6397025496E-01 + 3.4553684000E-03 8.7080751656E-01 + 3.4902711000E-03 8.7769888126E-01 + 3.5255263000E-03 8.8464477227E-01 + 3.5611377000E-03 8.9164564853E-01 + 3.5971088000E-03 8.9870192589E-01 + 3.6334432000E-03 9.0581403629E-01 + 3.6701447000E-03 9.1298244703E-01 + 3.7072169000E-03 9.2020758255E-01 + 3.7446635000E-03 9.2748988313E-01 + 3.7824884000E-03 9.3482982414E-01 + 3.8206953000E-03 9.4222783823E-01 + 3.8592882000E-03 9.4968441234E-01 + 3.8982709000E-03 9.5719999077E-01 + 3.9376474000E-03 9.6477505253E-01 + 3.9774216000E-03 9.7241005341E-01 + 4.0175976000E-03 9.8010548364E-01 + 4.0581794000E-03 9.8786181022E-01 + 4.0991711000E-03 9.9567951528E-01 + 4.1405769000E-03 1.0035590959E+00 + 4.1824009000E-03 1.0115010260E+00 + 4.2246473000E-03 1.0195057944E+00 + 4.2673206000E-03 1.0275739426E+00 + 4.3104248000E-03 1.0357059132E+00 + 4.3539644000E-03 1.0439022390E+00 + 4.3979439000E-03 1.0521634486E+00 + 4.4423676000E-03 1.0604900284E+00 + 4.4872400000E-03 1.0688824983E+00 + 4.5325656000E-03 1.0773413737E+00 + 4.5783491000E-03 1.0858672029E+00 + 4.6245951000E-03 1.0944605110E+00 + 4.6713081000E-03 1.1031218002E+00 + 4.7184931000E-03 1.1118516609E+00 + 4.7661546000E-03 1.1206505861E+00 + 4.8142976000E-03 1.1295191571E+00 + 4.8629269000E-03 1.1384579131E+00 + 4.9120473000E-03 1.1474673891E+00 + 4.9616640000E-03 1.1565481885E+00 + 5.0117818000E-03 1.1657008369E+00 + 5.0624058000E-03 1.1749259098E+00 + 5.1135413000E-03 1.1842240145E+00 + 5.1651932000E-03 1.1935956803E+00 + 5.2173669000E-03 1.2030415229E+00 + 5.2700675000E-03 1.2125620983E+00 + 5.3233005000E-03 1.2221580300E+00 + 5.3770713000E-03 1.2318299184E+00 + 5.4313851000E-03 1.2415783229E+00 + 5.4862476000E-03 1.2514038875E+00 + 5.5416642000E-03 1.2613071974E+00 + 5.5976406000E-03 1.2712888863E+00 + 5.6541825000E-03 1.2813495825E+00 + 5.7112954000E-03 1.2914898736E+00 + 5.7689853000E-03 1.3017104306E+00 + 5.8272578000E-03 1.3120118484E+00 + 5.8861190000E-03 1.3223948049E+00 + 5.9455748000E-03 1.3328599371E+00 + 6.0056311000E-03 1.3434078768E+00 + 6.0662940000E-03 1.3540392852E+00 + 6.1275697000E-03 1.3647548358E+00 + 6.1894644000E-03 1.3755551960E+00 + 6.2519842000E-03 1.3864410105E+00 + 6.3151356000E-03 1.3974129879E+00 + 6.3789248000E-03 1.4084717789E+00 + 6.4433584000E-03 1.4196180977E+00 + 6.5084428000E-03 1.4308526182E+00 + 6.5741847000E-03 1.4421760602E+00 + 6.6405906000E-03 1.4535891030E+00 + 6.7076673000E-03 1.4650924716E+00 + 6.7754215000E-03 1.4766868680E+00 + 6.8438601000E-03 1.4883730221E+00 + 6.9129900000E-03 1.5001516579E+00 + 6.9828181000E-03 1.5120234931E+00 + 7.0533517000E-03 1.5239893074E+00 + 7.1245976000E-03 1.5360497891E+00 + 7.1965633000E-03 1.5482057391E+00 + 7.2692558000E-03 1.5604578671E+00 + 7.3426827000E-03 1.5728069779E+00 + 7.4168512000E-03 1.5852538022E+00 + 7.4917689000E-03 1.5977991316E+00 + 7.5674433000E-03 1.6104437345E+00 + 7.6438821000E-03 1.6231884057E+00 + 7.7210930000E-03 1.6360339339E+00 + 7.7990839000E-03 1.6489811338E+00 + 7.8778625000E-03 1.6620307804E+00 + 7.9574369000E-03 1.6751837082E+00 + 8.0378150000E-03 1.6884407117E+00 + 8.1190051000E-03 1.7018026444E+00 + 8.2010152000E-03 1.7152703037E+00 + 8.2838538000E-03 1.7288445617E+00 + 8.3675291000E-03 1.7425262344E+00 + 8.4520496000E-03 1.7563161799E+00 + 8.5374238000E-03 1.7702152489E+00 + 8.6236604000E-03 1.7842243174E+00 + 8.7107681000E-03 1.7983442542E+00 + 8.7987556000E-03 1.8125759206E+00 + 8.8876320000E-03 1.8269202353E+00 + 8.9774060000E-03 1.8413780447E+00 + 9.0680869000E-03 1.8559502847E+00 + 9.1596837000E-03 1.8706378349E+00 + 9.2522058000E-03 1.8854416317E+00 + 9.3456624000E-03 1.9003625717E+00 + 9.4400630000E-03 1.9154015915E+00 + 9.5354172000E-03 1.9305596359E+00 + 9.6317345000E-03 1.9458376259E+00 + 9.7290248000E-03 1.9612365377E+00 + 9.8272978000E-03 1.9767573082E+00 + 9.9265634000E-03 1.9924008975E+00 + 1.0026832000E-02 2.0081683364E+00 + 1.0128113000E-02 2.0240604900E+00 + 1.0230417000E-02 2.0400784042E+00 + 1.0333755000E-02 2.0562231782E+00 + 1.0438136000E-02 2.0724955906E+00 + 1.0543572000E-02 2.0888968796E+00 + 1.0650072000E-02 2.1054278079E+00 + 1.0757649000E-02 2.1220897505E+00 + 1.0866312000E-02 2.1388834534E+00 + 1.0976073000E-02 2.1558101185E+00 + 1.1086942000E-02 2.1728706301E+00 + 1.1198931000E-02 2.1900661717E+00 + 1.1312052000E-02 2.2073979170E+00 + 1.1426315000E-02 2.2248667244E+00 + 1.1541732000E-02 2.2424737497E+00 + 1.1658316000E-02 2.2602202912E+00 + 1.1776076000E-02 2.2781070291E+00 + 1.1895027000E-02 2.2961355467E+00 + 1.2015178000E-02 2.3143065070E+00 + 1.2136544000E-02 2.3326214723E+00 + 1.2259135000E-02 2.3510812396E+00 + 1.2382965000E-02 2.3696871993E+00 + 1.2508045000E-02 2.3884402812E+00 + 1.2634389000E-02 2.4073418552E+00 + 1.2762009000E-02 2.4263929817E+00 + 1.2890918000E-02 2.4455948609E+00 + 1.3021130000E-02 2.4649488312E+00 + 1.3152656000E-02 2.4844557756E+00 + 1.3285511000E-02 2.5041171607E+00 + 1.3419709000E-02 2.5239342935E+00 + 1.3555261000E-02 2.5439080281E+00 + 1.3692183000E-02 2.5640399461E+00 + 1.3830488000E-02 2.5843311760E+00 + 1.3970190000E-02 2.6047829828E+00 + 1.4111303000E-02 2.6253966213E+00 + 1.4253841000E-02 2.6461733355E+00 + 1.4397819000E-02 2.6671145041E+00 + 1.4543252000E-02 2.6882214944E+00 + 1.4690153000E-02 2.7094953727E+00 + 1.4838539000E-02 2.7309377739E+00 + 1.4988423000E-02 2.7525497429E+00 + 1.5139821000E-02 2.7743327469E+00 + 1.5292749000E-02 2.7962882408E+00 + 1.5447221000E-02 2.8184173812E+00 + 1.5603253000E-02 2.8407216003E+00 + 1.5760862000E-02 2.8632024609E+00 + 1.5920063000E-02 2.8858612283E+00 + 1.6080871000E-02 2.9086991569E+00 + 1.6243305000E-02 2.9317180571E+00 + 1.6407378000E-02 2.9549188764E+00 + 1.6573109000E-02 2.9783034001E+00 + 1.6740515000E-02 3.0018731169E+00 + 1.6909611000E-02 3.0256292226E+00 + 1.7080415000E-02 3.0495733230E+00 + 1.7252944000E-02 3.0737068705E+00 + 1.7427216000E-02 3.0980314448E+00 + 1.7603249000E-02 3.1225486123E+00 + 1.7781059000E-02 3.1472596485E+00 + 1.7960666000E-02 3.1721663724E+00 + 1.8142087000E-02 3.1972701728E+00 + 1.8325340000E-02 3.2225725650E+00 + 1.8510445000E-02 3.2480753265E+00 + 1.8697419000E-02 3.2737798081E+00 + 1.8886282000E-02 3.2996877603E+00 + 1.9077052000E-02 3.3258006452E+00 + 1.9269750000E-02 3.3521203221E+00 + 1.9464394000E-02 3.3786482260E+00 + 1.9661004000E-02 3.4053860519E+00 + 1.9859600000E-02 3.4323354801E+00 + 2.0060202000E-02 3.4594981771E+00 + 2.0262830000E-02 3.4868757952E+00 + 2.0467505000E-02 3.5144701074E+00 + 2.0674248000E-02 3.5422828719E+00 + 2.0883078000E-02 3.5703155639E+00 + 2.1094019000E-02 3.5985703152E+00 + 2.1307090000E-02 3.6270485720E+00 + 2.1522313000E-02 3.6557521680E+00 + 2.1739710000E-02 3.6846829217E+00 + 2.1959303000E-02 3.7138426360E+00 + 2.2181114000E-02 3.7432330987E+00 + 2.2405166000E-02 3.7728562148E+00 + 2.2631480000E-02 3.8027136094E+00 + 2.2860081000E-02 3.8328074202E+00 + 2.3090991000E-02 3.8631393731E+00 + 2.3324233000E-02 3.8937113103E+00 + 2.3559832000E-02 3.9245253201E+00 + 2.3797810000E-02 3.9555830819E+00 + 2.4038192000E-02 3.9868866512E+00 + 2.4281002000E-02 4.0184379365E+00 + 2.4526264000E-02 4.0502388301E+00 + 2.4774005000E-02 4.0822915964E+00 + 2.5024247000E-02 4.1145978355E+00 + 2.5277017000E-02 4.1471597777E+00 + 2.5532341000E-02 4.1799795061E+00 + 2.5790243000E-02 4.2130588300E+00 + 2.6050751000E-02 4.2464000549E+00 + 2.6313889000E-02 4.2800049565E+00 + 2.6579686000E-02 4.3138759320E+00 + 2.6848168000E-02 4.3480149776E+00 + 2.7119362000E-02 4.3824241993E+00 + 2.7393295000E-02 4.4171056851E+00 + 2.7669994000E-02 4.4520615060E+00 + 2.7949489000E-02 4.4872940928E+00 + 2.8231807000E-02 4.5228054792E+00 + 2.8516977000E-02 4.5585979324E+00 + 2.8805027000E-02 4.5946735755E+00 + 2.9095987000E-02 4.6310347632E+00 + 2.9389886000E-02 4.6676837062E+00 + 2.9686754000E-02 4.7046227204E+00 + 2.9986620000E-02 4.7418539785E+00 + 3.0289515000E-02 4.7793798824E+00 + 3.0595470000E-02 4.8172028137E+00 + 3.0904515000E-02 4.8553250107E+00 + 3.1216682000E-02 4.8937489389E+00 + 3.1532002000E-02 4.9324769203E+00 + 3.1850507000E-02 4.9715113796E+00 + 3.2172229000E-02 5.0108547214E+00 + 3.2497201000E-02 5.0505094517E+00 + 3.2825456000E-02 5.0904780556E+00 + 3.3157026000E-02 5.1307628757E+00 + 3.3491945000E-02 5.1713664773E+00 + 3.3830248000E-02 5.2122915248E+00 + 3.4171968000E-02 5.2535404191E+00 + 3.4517139000E-02 5.2951156611E+00 + 3.4865797000E-02 5.3370199708E+00 + 3.5217977000E-02 5.3792559257E+00 + 3.5573714000E-02 5.4218260813E+00 + 3.5933044000E-02 5.4647330910E+00 + 3.6296004000E-02 5.5079797050E+00 + 3.6662631000E-02 5.5515686501E+00 + 3.7032960000E-02 5.5955023933E+00 + 3.7407031000E-02 5.6397839721E+00 + 3.7784879000E-02 5.6844158085E+00 + 3.8166545000E-02 5.7294010103E+00 + 3.8552065000E-02 5.7747420719E+00 + 3.8941480000E-02 5.8204420528E+00 + 3.9334829000E-02 5.8665037530E+00 + 3.9732150000E-02 5.9129298318E+00 + 4.0133485000E-02 5.9597233923E+00 + 4.0538874000E-02 6.0068872790E+00 + 4.0948357000E-02 6.0544243123E+00 + 4.1361977000E-02 6.1023376363E+00 + 4.1779775000E-02 6.1506301374E+00 + 4.2201793000E-02 6.1993047930E+00 + 4.2628073000E-02 6.2483645555E+00 + 4.3058660000E-02 6.2978126967E+00 + 4.3493596000E-02 6.3476521171E+00 + 4.3932925000E-02 6.3978859215E+00 + 4.4376692000E-02 6.4485173026E+00 + 4.4824942000E-02 6.4995494260E+00 + 4.5277719000E-02 6.5509853173E+00 + 4.5735069000E-02 6.6028282031E+00 + 4.6197040000E-02 6.6550815087E+00 + 4.6663677000E-02 6.7077482924E+00 + 4.7135027000E-02 6.7608318119E+00 + 4.7611138000E-02 6.8143354096E+00 + 4.8092059000E-02 6.8682625116E+00 + 4.8577837000E-02 6.9226162920E+00 + 4.9068522000E-02 6.9774002324E+00 + 4.9564164000E-02 7.0326177854E+00 + 5.0064812000E-02 7.0882722632E+00 + 5.0570517000E-02 7.1443671720E+00 + 5.1081331000E-02 7.2009060989E+00 + 5.1597304000E-02 7.2578923801E+00 + 5.2118489000E-02 7.3153296540E+00 + 5.2644938000E-02 7.3732214187E+00 + 5.3176705000E-02 7.4315713619E+00 + 5.3713843000E-02 7.4903830310E+00 + 5.4256407000E-02 7.5496601616E+00 + 5.4804452000E-02 7.6094064580E+00 + 5.5358032000E-02 7.6696254848E+00 + 5.5917204000E-02 7.7303211016E+00 + 5.6482025000E-02 7.7914971356E+00 + 5.7052550000E-02 7.8531571659E+00 + 5.7628839000E-02 7.9153052802E+00 + 5.8210948000E-02 7.9779451017E+00 + 5.8798937000E-02 8.0410806520E+00 + 5.9392866000E-02 8.1047159192E+00 + 5.9992794000E-02 8.1688547507E+00 + 6.0598782000E-02 8.2335011748E+00 + 6.1210891000E-02 8.2986591859E+00 + 6.1829183000E-02 8.3643328508E+00 + 6.2453720000E-02 8.4305262021E+00 + 6.3084565000E-02 8.4972433440E+00 + 6.3721783000E-02 8.5644885574E+00 + 6.4365438000E-02 8.6322659813E+00 + 6.5015594000E-02 8.7005797204E+00 + 6.5672317000E-02 8.7694340542E+00 + 6.6335673000E-02 8.8388332259E+00 + 6.7005731000E-02 8.9087817562E+00 + 6.7682556000E-02 8.9792837112E+00 + 6.8366218000E-02 9.0503436422E+00 + 6.9056786000E-02 9.1219659583E+00 + 6.9754330000E-02 9.1941551352E+00 + 7.0458919000E-02 9.2669155074E+00 + 7.1170625000E-02 9.3402516820E+00 + 7.1889520000E-02 9.4141682272E+00 + 7.2615677000E-02 9.4886697751E+00 + 7.3349169000E-02 9.5637609191E+00 + 7.4090069000E-02 9.6394462137E+00 + 7.4838454000E-02 9.7157305824E+00 + 7.5594398000E-02 9.7926186025E+00 + 7.6357978000E-02 9.8701151169E+00 + 7.7129270000E-02 9.9482248265E+00 + 7.7908354000E-02 1.0026952796E+01 + 7.8695307000E-02 1.0106303747E+01 + 7.9490209000E-02 1.0186282661E+01 + 8.0293141000E-02 1.0266894578E+01 + 8.1104182000E-02 1.0348144296E+01 + 8.1923417000E-02 1.0430037171E+01 + 8.2750926000E-02 1.0512578018E+01 + 8.3586794000E-02 1.0595772107E+01 + 8.4431105000E-02 1.0679624562E+01 + 8.5283944000E-02 1.0764140568E+01 + 8.6145398000E-02 1.0849325459E+01 + 8.7015554000E-02 1.0935184528E+01 + 8.7894499000E-02 1.1021723020E+01 + 8.8782322000E-02 1.1108946334E+01 + 8.9679113000E-02 1.1196859923E+01 + 9.0584963000E-02 1.1285469289E+01 + 9.1499962000E-02 1.1374779790E+01 + 9.2424204000E-02 1.1464797132E+01 + 9.3357782000E-02 1.1555526871E+01 + 9.4300790000E-02 1.1646974616E+01 + 9.5253323000E-02 1.1739146025E+01 + 9.6215478000E-02 1.1832046900E+01 + 9.7187352000E-02 1.1925682997E+01 + 9.8169042000E-02 1.2020060021E+01 + 9.9160648000E-02 1.2115183916E+01 + 1.0016227000E-01 1.2211060579E+01 + 1.0117401000E-01 1.2307696045E+01 + 1.0219597000E-01 1.2405096300E+01 + 1.0322825000E-01 1.2503267089E+01 + 1.0427096000E-01 1.2602215057E+01 + 1.0532421000E-01 1.2701946792E+01 + 1.0638809000E-01 1.2802466940E+01 + 1.0746271000E-01 1.2903781992E+01 + 1.0854820000E-01 1.3005900262E+01 + 1.0964464000E-01 1.3108825307E+01 + 1.1075216000E-01 1.3212565332E+01 + 1.1187087000E-01 1.3317126604E+01 + 1.1300088000E-01 1.3422515340E+01 + 1.1414230000E-01 1.3528737704E+01 + 1.1529526000E-01 1.3635801661E+01 + 1.1645985000E-01 1.3743711410E+01 + 1.1763622000E-01 1.3852476653E+01 + 1.1882446000E-01 1.3962101483E+01 + 1.2002471000E-01 1.4072594556E+01 + 1.2123708000E-01 1.4183961702E+01 + 1.2246170000E-01 1.4296210533E+01 + 1.2369868000E-01 1.4409346769E+01 + 1.2494817000E-01 1.4523379732E+01 + 1.2621027000E-01 1.4638314112E+01 + 1.2748512000E-01 1.4754158194E+01 + 1.2877285000E-01 1.4870919286E+01 + 1.3007358000E-01 1.4988603732E+01 + 1.3138746000E-01 1.5107220526E+01 + 1.3271460000E-01 1.5226774988E+01 + 1.3405516000E-01 1.5347276884E+01 + 1.3540925000E-01 1.5468731415E+01 + 1.3677702000E-01 1.5591147317E+01 + 1.3815860000E-01 1.5714531468E+01 + 1.3955415000E-01 1.5838893356E+01 + 1.4096378000E-01 1.5964237952E+01 + 1.4238766000E-01 1.6090575499E+01 + 1.4382592000E-01 1.6217912619E+01 + 1.4527871000E-01 1.6346257643E+01 + 1.4674617000E-01 1.6475617949E+01 + 1.4822845000E-01 1.6606001734E+01 + 1.4972571000E-01 1.6737418002E+01 + 1.5123809000E-01 1.6869873932E+01 + 1.5276575000E-01 1.7003378387E+01 + 1.5430884000E-01 1.7137939285E+01 + 1.5586751000E-01 1.7273564478E+01 + 1.5744193000E-01 1.7410263486E+01 + 1.5903225000E-01 1.7548044018E+01 + 1.6063864000E-01 1.7686915445E+01 + 1.6226125000E-01 1.7826885337E+01 + 1.6390025000E-01 1.7967962919E+01 + 1.6555581000E-01 1.8110157337E+01 + 1.6722809000E-01 1.8253476806E+01 + 1.6891727000E-01 1.8397931179E+01 + 1.7062350000E-01 1.8543527670E+01 + 1.7234697000E-01 1.8690276834E+01 + 1.7408785000E-01 1.8838187440E+01 + 1.7584631000E-01 1.8987268181E+01 + 1.7762254000E-01 1.9137529371E+01 + 1.7941671000E-01 1.9288979546E+01 + 1.8122900000E-01 1.9441628016E+01 + 1.8305959000E-01 1.9595484010E+01 + 1.8490868000E-01 1.9750558355E+01 + 1.8677644000E-01 1.9906859280E+01 + 1.8866307000E-01 2.0064397447E+01 + 1.9056876000E-01 2.0223182594E+01 + 1.9249370000E-01 2.0383224380E+01 + 1.9443808000E-01 2.0544532381E+01 + 1.9640210000E-01 2.0707116919E+01 + 1.9838596000E-01 2.0870988229E+01 + 2.0038986000E-01 2.1036156462E+01 + 2.0241400000E-01 2.1202631681E+01 + 2.0445858000E-01 2.1370423866E+01 + 2.0652382000E-01 2.1539544548E+01 + 2.0860992000E-01 2.1710003528E+01 + 2.1071709000E-01 2.1881811341E+01 + 2.1284555000E-01 2.2054979245E+01 + 2.1499550000E-01 2.2229516779E+01 + 2.1716717000E-01 2.2405435834E+01 + 2.1936078000E-01 2.2582747389E+01 + 2.2157655000E-01 2.2761462333E+01 + 2.2381469000E-01 2.2941590658E+01 + 2.2607545000E-01 2.3123145484E+01 + 2.2835904000E-01 2.3306136613E+01 + 2.3066570000E-01 2.3490576166E+01 + 2.3299565000E-01 2.3676474565E+01 + 2.3534914000E-01 2.3863844531E+01 + 2.3772641000E-01 2.4052697885E+01 + 2.4012768000E-01 2.4243044763E+01 + 2.4255322000E-01 2.4434899168E+01 + 2.4500325000E-01 2.4628271042E+01 + 2.4747803000E-01 2.4823173392E+01 + 2.4997781000E-01 2.5019618327E+01 + 2.5250284000E-01 2.5217617858E+01 + 2.5505337000E-01 2.5417183892E+01 + 2.5762967000E-01 2.5618329797E+01 + 2.6023199000E-01 2.5821067271E+01 + 2.6286059000E-01 2.6025408692E+01 + 2.6551575000E-01 2.6231367881E+01 + 2.6819773000E-01 2.6438956998E+01 + 2.7090680000E-01 2.6648188872E+01 + 2.7364323000E-01 2.6859076224E+01 + 2.7640730000E-01 2.7071632434E+01 + 2.7919929000E-01 2.7285870773E+01 + 2.8201949000E-01 2.7501805163E+01 + 2.8486817000E-01 2.7719447882E+01 + 2.8774563000E-01 2.7938813390E+01 + 2.9065215000E-01 2.8159914505E+01 + 2.9358803000E-01 2.8382765455E+01 + 2.9655356000E-01 2.8607379591E+01 + 2.9954905000E-01 2.8833771660E+01 + 3.0257480000E-01 2.9061955533E+01 + 3.0563111000E-01 2.9291944964E+01 + 3.0871830000E-01 2.9523755091E+01 + 3.1183666000E-01 2.9757398681E+01 + 3.1498653000E-01 2.9992892124E+01 + 3.1816821000E-01 3.0230248695E+01 + 3.2138203000E-01 3.0469483786E+01 + 3.2462831000E-01 3.0710611918E+01 + 3.2790739000E-01 3.0953648969E+01 + 3.3121958000E-01 3.1198608470E+01 + 3.3456524000E-01 3.1445507522E+01 + 3.3794468000E-01 3.1694359404E+01 + 3.4135827000E-01 3.1945181688E+01 + 3.4480633000E-01 3.2197988136E+01 + 3.4828922000E-01 3.2452795316E+01 + 3.5180729000E-01 3.2709618930E+01 + 3.5536090000E-01 3.2968475272E+01 + 3.5895041000E-01 3.3229380503E+01 + 3.6257617000E-01 3.3492349919E+01 + 3.6623855000E-01 3.3757400136E+01 + 3.6993793000E-01 3.4024548352E+01 + 3.7367468000E-01 3.4293810897E+01 + 3.7744917000E-01 3.4565203968E+01 + 3.8126179000E-01 3.4838745055E+01 + 3.8511292000E-01 3.5114450787E+01 + 3.8900295000E-01 3.5392338369E+01 + 3.9293227000E-01 3.5672424858E+01 + 3.9690128000E-01 3.5954727879E+01 + 4.0091039000E-01 3.6239265617E+01 + 4.0495999000E-01 3.6526054692E+01 + 4.0905049000E-01 3.6815112991E+01 + 4.1318232000E-01 3.7106459663E+01 + 4.1735587000E-01 3.7400110883E+01 + 4.2157159000E-01 3.7696086898E+01 + 4.2582989000E-01 3.7994404986E+01 + 4.3013120000E-01 3.8295083674E+01 + 4.3447596000E-01 3.8598142032E+01 + 4.3886461000E-01 3.8903598969E+01 + 4.4329758000E-01 3.9211472540E+01 + 4.4777534000E-01 3.9521783418E+01 + 4.5229832000E-01 3.9834549340E+01 + 4.5686699000E-01 4.0149790648E+01 + 4.6148181000E-01 4.0467526826E+01 + 4.6614324000E-01 4.0787777197E+01 + 4.7085176000E-01 4.1110562286E+01 + 4.7560784000E-01 4.1435901765E+01 + 4.8041196000E-01 4.1763815822E+01 + 4.8526460000E-01 4.2094324474E+01 + 4.9016626000E-01 4.2427448928E+01 + 4.9511744000E-01 4.2763210213E+01 + 5.0011862000E-01 4.3101627827E+01 + 5.0517033000E-01 4.3442724479E+01 + 5.1027306000E-01 4.3786519993E+01 + 5.1542733000E-01 4.4133036041E+01 + 5.2063367000E-01 4.4482294783E+01 + 5.2589259000E-01 4.4834316855E+01 + 5.3120464000E-01 4.5189125389E+01 + 5.3657034000E-01 4.5546741323E+01 + 5.4199025000E-01 4.5907188078E+01 + 5.4746490000E-01 4.6270486887E+01 + 5.5299484000E-01 4.6636660131E+01 + 5.5858065000E-01 4.7005731978E+01 + 5.6422288000E-01 4.7377724420E+01 + 5.6992210000E-01 4.7752660577E+01 + 5.7567889000E-01 4.8130564030E+01 + 5.8149383000E-01 4.8511458162E+01 + 5.8736750000E-01 4.8895366159E+01 + 5.9330051000E-01 4.9282312966E+01 + 5.9929344000E-01 4.9672321368E+01 + 6.0534691000E-01 5.0065416553E+01 + 6.1146153000E-01 5.0461622851E+01 + 6.1763791000E-01 5.0860964383E+01 + 6.2387667000E-01 5.1263465716E+01 + 6.3017846000E-01 5.1669153137E+01 + 6.3654390000E-01 5.2078050788E+01 + 6.4297363000E-01 5.2490183886E+01 + 6.4946832000E-01 5.2905579356E+01 + 6.5602860000E-01 5.3324261343E+01 + 6.6265515000E-01 5.3746256971E+01 + 6.6934864000E-01 5.4171592502E+01 + 6.7610974000E-01 5.4600293973E+01 + 6.8293913000E-01 5.5032387839E+01 + 6.8983750000E-01 5.5467900958E+01 + 6.9680556000E-01 5.5906861225E+01 + 7.0384400000E-01 5.6349295041E+01 + 7.1095353000E-01 5.6795229839E+01 + 7.1813488000E-01 5.7244694071E+01 + 7.2538877000E-01 5.7697715328E+01 + 7.3271593000E-01 5.8154321588E+01 + 7.4011710000E-01 5.8614541217E+01 + 7.4759303000E-01 5.9078402960E+01 + 7.5514448000E-01 5.9545935939E+01 + 7.6277220000E-01 6.0017168416E+01 + 7.7047697000E-01 6.0492130260E+01 + 7.7825956000E-01 6.0970850474E+01 + 7.8612077000E-01 6.1453359658E+01 + 7.9406138000E-01 6.1939686929E+01 + 8.0208221000E-01 6.2429863603E+01 + 8.1018405000E-01 6.2923918902E+01 + 8.1836772000E-01 6.3421883628E+01 + 8.2663406000E-01 6.3923789536E+01 + 8.3498390000E-01 6.4429667507E+01 + 8.4341808000E-01 6.4939548769E+01 + 8.5193746000E-01 6.5453465488E+01 + 8.6054289000E-01 6.5971448963E+01 + 8.6923524000E-01 6.6493531425E+01 + 8.7801539000E-01 6.7019745436E+01 + 8.8688424000E-01 6.7550124475E+01 + 8.9584266000E-01 6.8084699954E+01 + 9.0489158000E-01 6.8623506588E+01 + 9.1403190000E-01 6.9166577019E+01 + 9.2326454000E-01 6.9713944799E+01 + 9.3259045000E-01 7.0265644971E+01 + 9.4201055000E-01 7.0821710514E+01 + 9.5152581000E-01 7.1382177069E+01 + 9.6113718000E-01 7.1947078806E+01 + 9.7084564000E-01 7.2516451363E+01 + 9.8065216000E-01 7.3090329493E+01 + 9.9055774000E-01 7.3668749409E+01 + 1.0005634000E+00 7.4251748179E+01 + 1.0106701000E+00 7.4839359079E+01 + 1.0208789000E+00 7.5431620896E+01 + 1.0311908000E+00 7.6028568623E+01 + 1.0416068000E+00 7.6630236958E+01 + 1.0521281000E+00 7.7236671825E+01 + 1.0627557000E+00 7.7847907265E+01 + 1.0734906000E+00 7.8463977037E+01 + 1.0843339000E+00 7.9084920335E+01 + 1.0952868000E+00 7.9710781731E+01 + 1.1063503000E+00 8.0341594030E+01 + 1.1175255000E+00 8.0977395446E+01 + 1.1288137000E+00 8.1618235211E+01 + 1.1402158000E+00 8.2264139508E+01 + 1.1517332000E+00 8.2915162534E+01 + 1.1633668000E+00 8.3571329856E+01 + 1.1751180000E+00 8.4232694938E+01 + 1.1869879000E+00 8.4899293962E+01 + 1.1989777000E+00 8.5571168406E+01 + 1.2110886000E+00 8.6248359396E+01 + 1.2233218000E+00 8.6930907714E+01 + 1.2356786000E+00 8.7618859360E+01 + 1.2481602000E+00 8.8312254395E+01 + 1.2607678000E+00 8.9011132546E+01 + 1.2735029000E+00 8.9715549780E+01 + 1.2863665000E+00 9.0425534025E+01 + 1.2993601000E+00 9.1141140484E+01 + 1.3124850000E+00 9.1862412912E+01 + 1.3257424000E+00 9.2589389221E+01 + 1.3391338000E+00 9.3322123402E+01 + 1.3526604000E+00 9.4060652626E+01 + 1.3663236000E+00 9.4805024638E+01 + 1.3801248000E+00 9.5555286783E+01 + 1.3940655000E+00 9.6311491423E+01 + 1.4081470000E+00 9.7073679665E+01 + 1.4223707000E+00 9.7841897666E+01 + 1.4367381000E+00 9.8616196579E+01 + 1.4512506000E+00 9.9396621754E+01 + 1.4659097000E+00 1.0018322352E+02 + 1.4807168000E+00 1.0097604643E+02 + 1.4956736000E+00 1.0177515068E+02 + 1.5107814000E+00 1.0258057465E+02 + 1.5260418000E+00 1.0339237235E+02 + 1.5414564000E+00 1.0421059731E+02 + 1.5570266000E+00 1.0503529206E+02 + 1.5727542000E+00 1.0586651988E+02 + 1.5886406000E+00 1.0670432242E+02 + 1.6046874000E+00 1.0754875153E+02 + 1.6208964000E+00 1.0839986908E+02 + 1.6372691000E+00 1.0925772075E+02 + 1.6538072000E+00 1.1012236226E+02 + 1.6705123000E+00 1.1099384365E+02 + 1.6873862000E+00 1.1187222495E+02 + 1.7044305000E+00 1.1275755530E+02 + 1.7216469000E+00 1.1364988859E+02 + 1.7390373000E+00 1.1454928862E+02 + 1.7566033000E+00 1.1545580317E+02 + 1.7743468000E+00 1.1636949504E+02 + 1.7922695000E+00 1.1729041624E+02 + 1.8103732000E+00 1.1821862349E+02 + 1.8286598000E+00 1.1915417812E+02 + 1.8471311000E+00 1.2009713583E+02 + 1.8657890000E+00 1.2104755697E+02 + 1.8846354000E+00 1.2200550137E+02 + 1.9036721000E+00 1.2297102328E+02 + 1.9229011000E+00 1.2394418661E+02 + 1.9423244000E+00 1.2492505475E+02 + 1.9619438000E+00 1.2591368047E+02 + 1.9817614000E+00 1.2691013116E+02 + 2.0017792000E+00 1.2791446864E+02 + 2.0219992000E+00 1.2892675421E+02 + 2.0424234000E+00 1.2994704866E+02 + 2.0630540000E+00 1.3097542221E+02 + 2.0838929000E+00 1.3201192959E+02 + 2.1049423000E+00 1.3305663996E+02 + 2.1262044000E+00 1.3410962186E+02 + 2.1476812000E+00 1.3517093343E+02 + 2.1693749000E+00 1.3624064212E+02 + 2.1912878000E+00 1.3731881977E+02 + 2.2134220000E+00 1.3840552778E+02 + 2.2357798000E+00 1.3950083684E+02 + 2.2583635000E+00 1.4060481702E+02 + 2.2811752000E+00 1.4171752808E+02 + 2.3042174000E+00 1.4283904870E+02 + 2.3274923000E+00 1.4396944238E+02 + 2.3510023000E+00 1.4510878173E+02 + 2.3747498000E+00 1.4625713876E+02 + 2.3987372000E+00 1.4741458489E+02 + 2.4229669000E+00 1.4858119093E+02 + 2.4474413000E+00 1.4975702707E+02 + 2.4721629000E+00 1.5094216773E+02 + 2.4971343000E+00 1.5213669147E+02 + 2.5223578000E+00 1.5334066189E+02 + 2.5478362000E+00 1.5455416582E+02 + 2.5735719000E+00 1.5577727041E+02 + 2.5995676000E+00 1.5701005642E+02 + 2.6258259000E+00 1.5825259922E+02 + 2.6523493000E+00 1.5950496882E+02 + 2.6791408000E+00 1.6076725819E+02 + 2.7062028000E+00 1.6203953132E+02 + 2.7335382000E+00 1.6332187510E+02 + 2.7611497000E+00 1.6461436634E+02 + 2.7890401000E+00 1.6591708586E+02 + 2.8172122000E+00 1.6723011382E+02 + 2.8456689000E+00 1.6855353432E+02 + 2.8744130000E+00 1.6988742613E+02 + 2.9034475000E+00 1.7123187663E+02 + 2.9327752000E+00 1.7258696321E+02 + 2.9623992000E+00 1.7395277642E+02 + 2.9923224000E+00 1.7532939686E+02 + 3.0225479000E+00 1.7671691365E+02 + 3.0530787000E+00 1.7811541055E+02 + 3.0839179000E+00 1.7952497519E+02 + 3.1150686000E+00 1.8094569448E+02 + 3.1465339000E+00 1.8237765456E+02 + 3.1783171000E+00 1.8382094997E+02 + 3.2104213000E+00 1.8527566535E+02 + 3.2428498000E+00 1.8674189370E+02 + 3.2756059000E+00 1.8821972721E+02 + 3.3086928000E+00 1.8970925281E+02 + 3.3421139000E+00 1.9121056567E+02 + 3.3758726000E+00 1.9272376016E+02 + 3.4099724000E+00 1.9424893433E+02 + 3.4444165000E+00 1.9578617201E+02 + 3.4792086000E+00 1.9733557858E+02 + 3.5143521000E+00 1.9889724522E+02 + 3.5498506000E+00 2.0047127121E+02 + 3.5857077000E+00 2.0205775496E+02 + 3.6219270000E+00 2.0365679408E+02 + 3.6585121000E+00 2.0526848535E+02 + 3.6954668000E+00 2.0689293352E+02 + 3.7327947000E+00 2.0853023370E+02 + 3.7704997000E+00 2.1018049330E+02 + 3.8085856000E+00 2.1184381447E+02 + 3.8470561000E+00 2.1352029416E+02 + 3.8859153000E+00 2.1521004586E+02 + 3.9251670000E+00 2.1691316911E+02 + 3.9648151000E+00 2.1862976694E+02 + 4.0048638000E+00 2.2035995445E+02 + 4.0453169000E+00 2.2210382856E+02 + 4.0861787000E+00 2.2386150684E+02 + 4.1274532000E+00 2.2563309303E+02 + 4.1691447000E+00 2.2741870282E+02 + 4.2112573000E+00 2.2921844237E+02 + 4.2537952000E+00 2.3103242124E+02 + 4.2967628000E+00 2.3286075655E+02 + 4.3401645000E+00 2.3470356444E+02 + 4.3840045000E+00 2.3656095160E+02 + 4.4282874000E+00 2.3843304072E+02 + 4.4730176000E+00 2.4031994502E+02 + 4.5181996000E+00 2.4222178099E+02 + 4.5638380000E+00 2.4413866833E+02 + 4.6099373000E+00 2.4607072153E+02 + 4.6565024000E+00 2.4801807084E+02 + 4.7035377000E+00 2.4998082456E+02 + 4.7510482000E+00 2.5195911506E+02 + 4.7990386000E+00 2.5395306112E+02 + 4.8475137000E+00 2.5596278466E+02 + 4.8964785000E+00 2.5798841486E+02 + 4.9459379000E+00 2.6003007568E+02 + 4.9958969000E+00 2.6208789413E+02 + 5.0463605000E+00 2.6416199618E+02 + 5.0973338000E+00 2.6625251082E+02 + 5.1488220000E+00 2.6835957006E+02 + 5.2008303000E+00 2.7048330476E+02 + 5.2533640000E+00 2.7262384880E+02 + 5.3064283000E+00 2.7478133084E+02 + 5.3600286000E+00 2.7695588656E+02 + 5.4141703000E+00 2.7914765050E+02 + 5.4688588000E+00 2.8135675609E+02 + 5.5240998000E+00 2.8358334770E+02 + 5.5798988000E+00 2.8582756043E+02 + 5.6362614000E+00 2.8808953228E+02 + 5.6931934000E+00 2.9036940809E+02 + 5.7507004000E+00 2.9266732347E+02 + 5.8087883000E+00 2.9498342485E+02 + 5.8674629000E+00 2.9731785348E+02 + 5.9267302000E+00 2.9967075731E+02 + 5.9865962000E+00 3.0204228307E+02 + 6.0470668000E+00 3.0443257230E+02 + 6.1081483000E+00 3.0684178111E+02 + 6.1698468000E+00 3.0927005642E+02 + 6.2321685000E+00 3.1171754786E+02 + 6.2951197000E+00 3.1418440771E+02 + 6.3587067000E+00 3.1667078694E+02 + 6.4229361000E+00 3.1917684697E+02 + 6.4878142000E+00 3.2170273619E+02 + 6.5533477000E+00 3.2424861725E+02 + 6.6195431000E+00 3.2681464372E+02 + 6.6864072000E+00 3.2940097941E+02 + 6.7539467000E+00 3.3200778296E+02 + 6.8221684000E+00 3.3463521548E+02 + 6.8910791000E+00 3.3728343673E+02 + 6.9606860000E+00 3.3995262046E+02 + 7.0309960000E+00 3.4264292748E+02 + 7.1020161000E+00 3.4535452107E+02 + 7.1737537000E+00 3.4808757835E+02 + 7.2462158000E+00 3.5084225976E+02 + 7.3194099000E+00 3.5361874333E+02 + 7.3933434000E+00 3.5641720183E+02 + 7.4680236000E+00 3.5923780278E+02 + 7.5434582000E+00 3.6208072736E+02 + 7.6196547000E+00 3.6494614772E+02 + 7.6966209000E+00 3.6783424578E+02 + 7.7743646000E+00 3.7074520196E+02 + 7.8528935000E+00 3.7367919140E+02 + 7.9322157000E+00 3.7663640268E+02 + 8.0123391000E+00 3.7961701537E+02 + 8.0932718000E+00 3.8262121491E+02 + 8.1750220000E+00 3.8564918891E+02 + 8.2575980000E+00 3.8870112709E+02 + 8.3410081000E+00 3.9177721755E+02 + 8.4252607000E+00 3.9487765050E+02 + 8.5103643000E+00 3.9800261822E+02 + 8.5963276000E+00 4.0115231868E+02 + 8.6831592000E+00 4.0432694454E+02 + 8.7708679000E+00 4.0752669413E+02 + 8.8594625000E+00 4.1075176410E+02 + 8.9489520000E+00 4.1400235669E+02 + 9.0393455000E+00 4.1727867610E+02 + 9.1306520000E+00 4.2058092116E+02 + 9.2228808000E+00 4.2390929985E+02 + 9.3160412000E+00 4.2726401840E+02 + 9.4101426000E+00 4.3064528491E+02 + 9.5051946000E+00 4.3405331286E+02 + 9.6012066000E+00 4.3748830682E+02 + 9.6981885000E+00 4.4095048743E+02 + 9.7961500000E+00 4.4444006639E+02 + 9.8951010000E+00 4.4795726071E+02 + 9.9950515000E+00 4.5150228910E+02 + 1.0096012000E+01 4.5507538612E+02 + 1.0197992000E+01 4.5867674907E+02 + 1.0301002000E+01 4.6230660881E+02 + 1.0405052000E+01 4.6596517667E+02 + 1.0510154000E+01 4.6965273231E+02 + 1.0616317000E+01 4.7336944811E+02 + 1.0723552000E+01 4.7711556481E+02 + 1.0831871000E+01 4.8089135593E+02 + 1.0941284000E+01 4.8469702320E+02 + 1.1051802000E+01 4.8853280130E+02 + 1.1163436000E+01 4.9239892298E+02 + 1.1276198000E+01 4.9629565352E+02 + 1.1390099000E+01 5.0022322152E+02 + 1.1505151000E+01 5.0418188804E+02 + 1.1621364000E+01 5.0817184334E+02 + 1.1738752000E+01 5.1219341297E+02 + 1.1857325000E+01 5.1624678315E+02 + 1.1977096000E+01 5.2033224075E+02 + 1.2098077000E+01 5.2445003622E+02 + 1.2220280000E+01 5.2860041793E+02 + 1.2343717000E+01 5.3278363211E+02 + 1.2468401000E+01 5.3699995675E+02 + 1.2594344000E+01 5.4124963375E+02 + 1.2721560000E+01 5.4553297027E+02 + 1.2850061000E+01 5.4985020375E+02 + 1.2979859000E+01 5.5420156962E+02 + 1.3110969000E+01 5.5858740161E+02 + 1.3243403000E+01 5.6300793057E+02 + 1.3377175000E+01 5.6746345197E+02 + 1.3512298000E+01 5.7195422559E+02 + 1.3648785000E+01 5.7648050904E+02 + 1.3786652000E+01 5.8104265690E+02 + 1.3925911000E+01 5.8564088884E+02 + 1.4066577000E+01 5.9027552142E+02 + 1.4208663000E+01 5.9494680286E+02 + 1.4352185000E+01 5.9965507758E+02 + 1.4497157000E+01 6.0440062173E+02 + 1.4643593000E+01 6.0918370911E+02 + 1.4791508000E+01 6.1400464379E+02 + 1.4940917000E+01 6.1886372726E+02 + 1.5091835000E+01 6.2376125851E+02 + 1.5244278000E+01 6.2869756632E+02 + 1.5398261000E+01 6.3367294444E+02 + 1.5553799000E+01 6.3868768414E+02 + 1.5710908000E+01 6.4374210641E+02 + 1.5869604000E+01 6.4883652949E+02 + 1.6029903000E+01 6.5397126896E+02 + 1.6191821000E+01 6.5914663776E+02 + 1.6355375000E+01 6.6436297804E+02 + 1.6520581000E+01 6.6962059727E+02 + 1.6687455000E+01 6.7491980034E+02 + 1.6856015000E+01 6.8026095289E+02 + 1.7026278000E+01 6.8564438589E+02 + 1.7198261000E+01 6.9107042751E+02 + 1.7371981000E+01 6.9653940318E+02 + 1.7547455000E+01 7.0205163557E+02 + 1.7724702000E+01 7.0760750728E+02 + 1.7903740000E+01 7.1320736642E+02 + 1.8084585000E+01 7.1885149584E+02 + 1.8267258000E+01 7.2454033155E+02 + 1.8451776000E+01 7.3027418169E+02 + 1.8638157000E+01 7.3605338282E+02 + 1.8826422000E+01 7.4187836139E+02 + 1.9016587000E+01 7.4774938601E+02 + 1.9208674000E+01 7.5366690774E+02 + 1.9402701000E+01 7.5963125096E+02 + 1.9598688000E+01 7.6564279861E+02 + 1.9796655000E+01 7.7170193043E+02 + 1.9996621000E+01 7.7780899244E+02 + 2.0198607000E+01 7.8396438862E+02 + 2.0402633000E+01 7.9016848920E+02 + 2.0608720000E+01 7.9642169157E+02 + 2.0816889000E+01 8.0272438981E+02 + 2.1027161000E+01 8.0907697466E+02 + 2.1239556000E+01 8.1547980345E+02 + 2.1454097000E+01 8.2193332068E+02 + 2.1670805000E+01 8.2843790711E+02 + 2.1889703000E+01 8.3499400014E+02 + 2.2110811000E+01 8.4160194392E+02 + 2.2334152000E+01 8.4826216910E+02 + 2.2559750000E+01 8.5497513240E+02 + 2.2787626000E+01 8.6174119772E+02 + 2.3017804000E+01 8.6856081469E+02 + 2.3250307000E+01 8.7543439962E+02 + 2.3485159000E+01 8.8236239478E+02 + 2.3722382000E+01 8.8934517992E+02 + 2.3962002000E+01 8.9638324894E+02 + 2.4204043000E+01 9.0347703305E+02 + 2.4448528000E+01 9.1062693059E+02 + 2.4695483000E+01 9.1783342401E+02 + 2.4944932000E+01 9.2509693352E+02 + 2.5196901000E+01 9.3241793386E+02 + 2.5451415000E+01 9.3979686678E+02 + 2.5708500000E+01 9.4723419925E+02 + 2.5968182000E+01 9.5473039426E+02 + 2.6230487000E+01 9.6228591094E+02 + 2.6495442000E+01 9.6990123326E+02 + 2.6763072000E+01 9.7757678379E+02 + 2.7033406000E+01 9.8531309594E+02 + 2.7306471000E+01 9.9311064155E+02 + 2.7582294000E+01 1.0009698885E+03 + 2.7860903000E+01 1.0088913291E+03 + 2.8142326000E+01 1.0168754515E+03 + 2.8426592000E+01 1.0249227681E+03 + 2.8713730000E+01 1.0330337870E+03 + 2.9003767000E+01 1.0412089555E+03 + 2.9296735000E+01 1.0494488580E+03 + 2.9592661000E+01 1.0577539334E+03 + 2.9891577000E+01 1.0661247570E+03 + 3.0193512000E+01 1.0745618154E+03 + 3.0498497000E+01 1.0830656470E+03 + 3.0806563000E+01 1.0916367854E+03 + 3.1117740000E+01 1.1002757323E+03 + 3.1432061000E+01 1.1089830678E+03 + 3.1749556000E+01 1.1177592846E+03 + 3.2070259000E+01 1.1266049814E+03 + 3.2394201000E+01 1.1355206693E+03 + 3.2721415000E+01 1.1445069100E+03 + 3.3051934000E+01 1.1535642604E+03 + 3.3385792000E+01 1.1626933002E+03 + 3.3723022000E+01 1.1718945768E+03 + 3.4063659000E+01 1.1811686875E+03 + 3.4407736000E+01 1.1905161702E+03 + 3.4755289000E+01 1.1999376396E+03 + 3.5106353000E+01 1.2094336781E+03 + 3.5460962000E+01 1.2190048363E+03 + 3.5819154000E+01 1.2286517678E+03 + 3.6180964000E+01 1.2383750401E+03 + 3.6546428000E+01 1.2481752427E+03 + 3.6915584000E+01 1.2580530138E+03 + 3.7288468000E+01 1.2680089326E+03 + 3.7665120000E+01 1.2780436801E+03 + 3.8045575000E+01 1.2881577985E+03 + 3.8429874000E+01 1.2983519848E+03 + 3.8818055000E+01 1.3086268506E+03 + 3.9210156000E+01 1.3189830023E+03 + 3.9606218000E+01 1.3294211203E+03 + 4.0006281000E+01 1.3399418530E+03 + 4.0410385000E+01 1.3505458432E+03 + 4.0818571000E+01 1.3612337546E+03 + 4.1230880000E+01 1.3720062452E+03 + 4.1647353000E+01 1.3828639676E+03 + 4.2068033000E+01 1.3938076208E+03 + 4.2492963000E+01 1.4048378978E+03 + 4.2922185000E+01 1.4159554601E+03 + 4.3355742000E+01 1.4271609892E+03 + 4.3793679000E+01 1.4384552128E+03 + 4.4236040000E+01 1.4498388263E+03 + 4.4682868000E+01 1.4613124938E+03 + 4.5134210000E+01 1.4728769763E+03 + 4.5590111000E+01 1.4845329772E+03 + 4.6050618000E+01 1.4962812448E+03 + 4.6515775000E+01 1.5081224451E+03 + 4.6985632000E+01 1.5200573907E+03 + 4.7460234000E+01 1.5320867604E+03 + 4.7939630000E+01 1.5442113288E+03 + 4.8423869000E+01 1.5564318638E+03 + 4.8912999000E+01 1.5687491016E+03 + 4.9407070000E+01 1.5811638224E+03 + 4.9906131000E+01 1.5936767750E+03 + 5.0410233000E+01 1.6062887517E+03 + 5.0919428000E+01 1.6190005631E+03 + 5.1433765000E+01 1.6318129383E+03 + 5.1953298000E+01 1.6447267245E+03 + 5.2478079000E+01 1.6577427122E+03 + 5.3008161000E+01 1.6708617098E+03 + 5.3543597000E+01 1.6840845191E+03 + 5.4084441000E+01 1.6974119596E+03 + 5.4630749000E+01 1.7108448933E+03 + 5.5182574000E+01 1.7243841010E+03 + 5.5739974000E+01 1.7380304797E+03 + 5.6303004000E+01 1.7517848452E+03 + 5.6871721000E+01 1.7656480553E+03 + 5.7446183000E+01 1.7796209850E+03 + 5.8026448000E+01 1.7937045017E+03 + 5.8612573000E+01 1.8078994415E+03 + 5.9204619000E+01 1.8222067299E+03 + 5.9802646000E+01 1.8366272607E+03 + 6.0406713000E+01 1.8511618958E+03 + 6.1016882000E+01 1.8658115622E+03 + 6.1633214000E+01 1.8805771549E+03 + 6.2255772000E+01 1.8954596091E+03 + 6.2884618000E+01 1.9104598285E+03 + 6.3519816000E+01 1.9255787567E+03 + 6.4161430000E+01 1.9408173291E+03 + 6.4809526000E+01 1.9561765209E+03 + 6.5464167000E+01 1.9716572281E+03 + 6.6125422000E+01 1.9872604806E+03 + 6.6793355000E+01 2.0029871819E+03 + 6.7468035000E+01 2.0188383454E+03 + 6.8149531000E+01 2.0348149759E+03 + 6.8837910000E+01 2.0509180230E+03 + 6.9533242000E+01 2.0671484984E+03 + 7.0235598000E+01 2.0835074283E+03 + 7.0945049000E+01 2.0999958305E+03 + 7.1661665000E+01 2.1166146908E+03 + 7.2385521000E+01 2.1333651025E+03 + 7.3116687000E+01 2.1502480344E+03 + 7.3855240000E+01 2.1672646081E+03 + 7.4601252000E+01 2.1844158209E+03 + 7.5354800000E+01 2.2017027765E+03 + 7.6115960000E+01 2.2191265463E+03 + 7.6884808000E+01 2.2366881926E+03 + 7.7661422000E+01 2.2543888144E+03 + 7.8445881000E+01 2.2722295242E+03 + 7.9238264000E+01 2.2902114252E+03 + 8.0038650000E+01 2.3083356110E+03 + 8.0847121000E+01 2.3266032340E+03 + 8.1663759000E+01 2.3450154368E+03 + 8.2488646000E+01 2.3635733524E+03 + 8.3321864000E+01 2.3822781043E+03 + 8.4163499000E+01 2.4011308959E+03 + 8.5013636000E+01 2.4201328983E+03 + 8.5872359000E+01 2.4392852504E+03 + 8.6739757000E+01 2.4585891927E+03 + 8.7615916000E+01 2.4780458886E+03 + 8.8500925000E+01 2.4976565582E+03 + 8.9394874000E+01 2.5174224335E+03 + 9.0297852000E+01 2.5373447139E+03 + 9.1209952000E+01 2.5574246768E+03 + 9.2131265000E+01 2.5776635449E+03 + 9.3061883000E+01 2.5980625526E+03 + 9.4001902000E+01 2.6186230112E+03 + 9.4951417000E+01 2.6393461991E+03 + 9.5910522000E+01 2.6602333624E+03 + 9.6879315000E+01 2.6812858234E+03 + 9.7857894000E+01 2.7025048932E+03 + 9.8846357000E+01 2.7238918720E+03 + 9.9844805000E+01 2.7454481137E+03 + 1.0085334000E+02 2.7671749824E+03 + 1.0187206000E+02 2.7890737446E+03 + 1.0290107000E+02 2.8111458063E+03 + 1.0394047000E+02 2.8333924548E+03 + 1.0499038000E+02 2.8558153932E+03 + 1.0605089000E+02 2.8784156715E+03 + 1.0712211000E+02 2.9011947559E+03 + 1.0820415000E+02 2.9241541001E+03 + 1.0929712000E+02 2.9472951457E+03 + 1.1040113000E+02 2.9706193220E+03 + 1.1151630000E+02 2.9941282570E+03 + 1.1264272000E+02 3.0178229345E+03 + 1.1378053000E+02 3.0417053785E+03 + 1.1492983000E+02 3.0657767589E+03 + 1.1609073000E+02 3.0900384448E+03 + 1.1726337000E+02 3.1144924184E+03 + 1.1844785000E+02 3.1391398140E+03 + 1.1964429000E+02 3.1639821711E+03 + 1.2085282000E+02 3.1890212231E+03 + 1.2207355000E+02 3.2142582760E+03 + 1.2330662000E+02 3.2396952429E+03 + 1.2455214000E+02 3.2653334038E+03 + 1.2581024000E+02 3.2911744384E+03 + 1.2708105000E+02 3.3172200123E+03 + 1.2836470000E+02 3.3434717771E+03 + 1.2966131000E+02 3.3699311664E+03 + 1.3097102000E+02 3.3966000089E+03 + 1.3229396000E+02 3.4234799147E+03 + 1.3363027000E+02 3.4505726828E+03 + 1.3498007000E+02 3.4778796932E+03 + 1.3634350000E+02 3.5054027173E+03 + 1.3772071000E+02 3.5331437130E+03 + 1.3911183000E+02 3.5611042200E+03 + 1.4051700000E+02 3.5892859654E+03 + 1.4193636000E+02 3.6176906618E+03 + 1.4337006000E+02 3.6463202070E+03 + 1.4481824000E+02 3.6751762835E+03 + 1.4628105000E+02 3.7042607584E+03 + 1.4775864000E+02 3.7335754832E+03 + 1.4925115000E+02 3.7631220959E+03 + 1.5075874000E+02 3.7929026153E+03 + 1.5228155000E+02 3.8229186495E+03 + 1.5381975000E+02 3.8531723827E+03 + 1.5537349000E+02 3.8836655881E+03 + 1.5694292000E+02 3.9144000245E+03 + 1.5852820000E+02 3.9453776308E+03 + 1.6012949000E+02 3.9766003296E+03 + 1.6174696000E+02 4.0080702218E+03 + 1.6338077000E+02 4.0397891966E+03 + 1.6503108000E+02 4.0717591272E+03 + 1.6669806000E+02 4.1039820643E+03 + 1.6838188000E+02 4.1364600413E+03 + 1.7008271000E+02 4.1691950743E+03 + 1.7180071000E+02 4.2021889708E+03 + 1.7353608000E+02 4.2354442888E+03 + 1.7528897000E+02 4.2689626094E+03 + 1.7705956000E+02 4.3027460727E+03 + 1.7884804000E+02 4.3367969904E+03 + 1.8065459000E+02 4.3711174654E+03 + 1.8247938000E+02 4.4057093934E+03 + 1.8432261000E+02 4.4405752209E+03 + 1.8618445000E+02 4.4757168083E+03 + 1.8806510000E+02 4.5111365646E+03 + 1.8996475000E+02 4.5468366911E+03 + 1.9188359000E+02 4.5828193701E+03 + 1.9382180000E+02 4.6190865790E+03 + 1.9577960000E+02 4.6556410246E+03 + 1.9775717000E+02 4.6924846461E+03 + 1.9975472000E+02 4.7296199239E+03 + 2.0177244000E+02 4.7670489468E+03 + 2.0381055000E+02 4.8047743406E+03 + 2.0586924000E+02 4.8427981555E+03 + 2.0794873000E+02 4.8811229770E+03 + 2.1004922000E+02 4.9197510010E+03 + 2.1217093000E+02 4.9586847720E+03 + 2.1431407000E+02 4.9979266299E+03 + 2.1647886000E+02 5.0374790774E+03 + 2.1866551000E+02 5.0773444141E+03 + 2.2087426000E+02 5.1175254653E+03 + 2.2310531000E+02 5.1580243074E+03 + 2.2535890000E+02 5.1988437229E+03 + 2.2763525000E+02 5.2399861099E+03 + 2.2993460000E+02 5.2814542064E+03 + 2.3225717000E+02 5.3232503681E+03 + 2.3460320000E+02 5.3653772895E+03 + 2.3697293000E+02 5.4078376424E+03 + 2.3936660000E+02 5.4506340760E+03 + 2.4178444000E+02 5.4937690393E+03 + 2.4422671000E+02 5.5372454938E+03 + 2.4669364000E+02 5.5810658441E+03 + 2.4918550000E+02 5.6252331824E+03 + 2.5170252000E+02 5.6697498686E+03 + 2.5424497000E+02 5.7146189475E+03 + 2.5681311000E+02 5.7598432626E+03 + 2.5940718000E+02 5.8054252823E+03 + 2.6202745000E+02 5.8513679797E+03 + 2.6467419000E+02 5.8976743029E+03 + 2.6734767000E+02 5.9443471752E+03 + 2.7004815000E+02 5.9913893213E+03 + 2.7277591000E+02 6.0388037900E+03 + 2.7553122000E+02 6.0865934314E+03 + 2.7831437000E+02 6.1347614174E+03 + 2.8112562000E+02 6.1833103755E+03 + 2.8396528000E+02 6.2322437719E+03 + 2.8683361000E+02 6.2815641847E+03 + 2.8973092000E+02 6.3312750275E+03 + 2.9265750000E+02 6.3813793427E+03 + 2.9561363000E+02 6.4318799768E+03 + 2.9859963000E+02 6.4827804333E+03 + 3.0161579000E+02 6.5340836765E+03 + 3.0466241000E+02 6.5857928153E+03 + 3.0773981000E+02 6.6379112708E+03 + 3.1084829000E+02 6.6904420977E+03 + 3.1398817000E+02 6.7433886618E+03 + 3.1715977000E+02 6.7967543005E+03 + 3.2036341000E+02 6.8505423234E+03 + 3.2359940000E+02 6.9047558445E+03 + 3.2686808000E+02 6.9593984528E+03 + 3.3016978000E+02 7.0144735405E+03 + 3.3350483000E+02 7.0699844710E+03 + 3.3687356000E+02 7.1259345797E+03 + 3.4027633000E+02 7.1823276703E+03 + 3.4371346000E+02 7.2391668538E+03 + 3.4718531000E+02 7.2964558745E+03 + 3.5069224000E+02 7.3541984450E+03 + 3.5423458000E+02 7.4123977542E+03 + 3.5781271000E+02 7.4710577833E+03 + 3.6142698000E+02 7.5301819894E+03 + 3.6507776000E+02 7.5897741269E+03 + 3.6876541000E+02 7.6498377557E+03 + 3.7249031000E+02 7.7103767306E+03 + 3.7625284000E+02 7.7713948737E+03 + 3.8005338000E+02 7.8328959753E+03 + 3.8389230000E+02 7.8948836320E+03 + 3.8777000000E+02 7.9573618934E+03 + 3.9168687000E+02 8.0203346142E+03 + 3.9564330000E+02 8.0838056168E+03 + 3.9963970000E+02 8.1477790111E+03 + 4.0367646000E+02 8.2122585532E+03 + 4.0775400000E+02 8.2772484455E+03 + 4.1187273000E+02 8.3427526958E+03 + 4.1603306000E+02 8.4087752786E+03 + 4.2023541000E+02 8.4753202927E+03 + 4.2448022000E+02 8.5423921184E+03 + 4.2876789000E+02 8.6099944689E+03 + 4.3309888000E+02 8.6781319691E+03 + 4.3747362000E+02 8.7468087348E+03 + 4.4189254000E+02 8.8160288467E+03 + 4.4635611000E+02 8.8857969762E+03 + 4.5086475000E+02 8.9561169758E+03 + 4.5541894000E+02 9.0269935990E+03 + 4.6001913000E+02 9.0984310934E+03 + 4.6466579000E+02 9.1704339806E+03 + 4.6935939000E+02 9.2430067441E+03 + 4.7410039000E+02 9.3161536756E+03 + 4.7888928000E+02 9.3898794920E+03 + 4.8372655000E+02 9.4641888706E+03 + 4.8861268000E+02 9.5390862959E+03 + 4.9354816000E+02 9.6145763677E+03 + 4.9853349000E+02 9.6906637995E+03 + 5.0356918000E+02 9.7673534172E+03 + 5.0865574000E+02 9.8446500062E+03 + 5.1379368000E+02 9.9225583113E+03 + 5.1898351000E+02 1.0001083038E+04 + 5.2422577000E+02 1.0083128312E+04 + 5.2952098000E+02 1.0173338997E+04 + 5.3486968000E+02 1.0264356820E+04 + 5.4027240000E+02 1.0356188828E+04 + 5.4572970000E+02 1.0448842550E+04 + 5.5124212000E+02 1.0542325144E+04 + 5.5681022000E+02 1.0636644081E+04 + 5.6243457000E+02 1.0731806973E+04 + 5.6811572000E+02 1.0827821061E+04 + 5.7385427000E+02 1.0924694406E+04 + 5.7965077000E+02 1.1022434191E+04 + 5.8550583000E+02 1.1121048585E+04 + 5.9142003000E+02 1.1220545217E+04 + 5.9739397000E+02 1.1320932026E+04 + 6.0342826000E+02 1.1422217085E+04 + 6.0952349000E+02 1.1524408103E+04 + 6.1568029000E+02 1.1627513426E+04 + 6.2189929000E+02 1.1731541370E+04 + 6.2818110000E+02 1.1836499884E+04 + 6.3452636000E+02 1.1942397386E+04 + 6.4093572000E+02 1.2049242429E+04 + 6.4740982000E+02 1.2157043364E+04 + 6.5394931000E+02 1.2265808680E+04 + 6.6055486000E+02 1.2375547161E+04 + 6.6722713000E+02 1.2486267394E+04 + 6.7396680000E+02 1.2597978262E+04 + 6.8077454000E+02 1.2710688450E+04 + 6.8765105000E+02 1.2824407103E+04 + 6.9459702000E+02 1.2939143168E+04 + 7.0161315000E+02 1.3054905719E+04 + 7.0870016000E+02 1.3171704128E+04 + 7.1585874000E+02 1.3289547234E+04 + 7.2308964000E+02 1.3408444829E+04 + 7.3039358000E+02 1.3528406174E+04 + 7.3777129000E+02 1.3649440659E+04 + 7.4522352000E+02 1.3771557965E+04 + 7.5275103000E+02 1.3894767899E+04 + 7.6035458000E+02 1.4019080228E+04 + 7.6803493000E+02 1.4144504685E+04 + 7.7579286000E+02 1.4271051287E+04 + 7.8362915000E+02 1.4398730015E+04 + 7.9154460000E+02 1.4527551137E+04 + 7.9954000000E+02 1.4657524716E+04 + 8.0761616000E+02 1.4788661104E+04 + 8.1577390000E+02 1.4920970771E+04 + 8.2401404000E+02 1.5054464149E+04 + 8.3233741000E+02 1.5189151792E+04 + 8.4074486000E+02 1.5325044534E+04 + 8.4923723000E+02 1.5462153006E+04 + 8.5781539000E+02 1.5600488283E+04 + 8.6648019000E+02 1.5740061074E+04 + 8.7523251000E+02 1.5880882528E+04 + 8.8407324000E+02 1.6022963912E+04 + 8.9300328000E+02 1.6166316611E+04 + 9.0202351000E+02 1.6310951644E+04 + 9.1113486000E+02 1.6456880788E+04 + 9.2033824000E+02 1.6604115454E+04 + 9.2963459000E+02 1.6752667488E+04 + 9.3902484000E+02 1.6902548532E+04 + 9.4850994000E+02 1.7053770500E+04 + 9.5809085000E+02 1.7206345419E+04 + 9.6776853000E+02 1.7360285271E+04 + 9.7754397000E+02 1.7515602465E+04 + 9.8741815000E+02 1.7672309206E+04 + 9.9739207000E+02 1.7830417968E+04 + 1.0074667000E+03 1.7989940700E+04 + 1.0176432000E+03 1.8150892311E+04 + 1.0279224000E+03 1.8313282439E+04 + 1.0383055000E+03 1.8477126521E+04 + 1.0487934000E+03 1.8642435208E+04 + 1.0593873000E+03 1.8809223832E+04 + 1.0700881000E+03 1.8977502948E+04 + 1.0808971000E+03 1.9147289352E+04 + 1.0918153000E+03 1.9318595068E+04 + 1.1028437000E+03 1.9491432074E+04 + 1.1139835000E+03 1.9665815433E+04 + 1.1252359000E+03 1.9841760146E+04 + 1.1366019000E+03 2.0019278037E+04 + 1.1480827000E+03 2.0198384000E+04 + 1.1596795000E+03 2.0379092874E+04 + 1.1713935000E+03 2.0561419438E+04 + 1.1832257000E+03 2.0745375306E+04 + 1.1951775000E+03 2.0930978258E+04 + 1.2072500000E+03 2.1118241352E+04 + 1.2194444000E+03 2.1307179143E+04 + 1.2317621000E+03 2.1497809225E+04 + 1.2442041000E+03 2.1690142942E+04 + 1.2567718000E+03 2.1884197770E+04 + 1.2694665000E+03 2.2079989573E+04 + 1.2822894000E+03 2.2277532615E+04 + 1.2952418000E+03 2.2476842640E+04 + 1.3083251000E+03 2.2677936872E+04 + 1.3215405000E+03 2.2880829395E+04 + 1.3348894000E+03 2.3085537306E+04 + 1.3483731000E+03 2.3292076104E+04 + 1.3619930000E+03 2.3500462757E+04 + 1.3757505000E+03 2.3710714169E+04 + 1.3896470000E+03 2.3922847176E+04 + 1.4036838000E+03 2.4136877025E+04 + 1.4178625000E+03 2.4352823472E+04 + 1.4321843000E+03 2.4570700113E+04 + 1.4466508000E+03 2.4790526567E+04 + 1.4612634000E+03 2.5012319344E+04 + 1.4760237000E+03 2.5236097918E+04 + 1.4909330000E+03 2.5461877148E+04 + 1.5059929000E+03 2.5689676372E+04 + 1.5212050000E+03 2.5919514852E+04 + 1.5365707000E+03 2.6151408757E+04 + 1.5520916000E+03 2.6385377210E+04 + 1.5677693000E+03 2.6621439257E+04 + 1.5836054000E+03 2.6859613872E+04 + 1.5996014000E+03 2.7099918452E+04 + 1.6157590000E+03 2.7342373327E+04 + 1.6320798000E+03 2.7586997251E+04 + 1.6485654000E+03 2.7833808905E+04 + 1.6652176000E+03 2.8082829885E+04 + 1.6820380000E+03 2.8334078720E+04 + 1.6990282000E+03 2.8587573866E+04 + 1.7161901000E+03 2.8843338175E+04 + 1.7335254000E+03 2.9101391436E+04 + 1.7510358000E+03 2.9361753360E+04 + 1.7687230000E+03 2.9624443583E+04 + 1.7865889000E+03 2.9889484629E+04 + 1.8046352000E+03 3.0156895975E+04 + 1.8228639000E+03 3.0426701458E+04 + 1.8412766000E+03 3.0698918912E+04 + 1.8598754000E+03 3.0973573484E+04 + 1.8786620000E+03 3.1250684323E+04 + 1.8976384000E+03 3.1530274924E+04 + 1.9168065000E+03 3.1812367219E+04 + 1.9361681000E+03 3.2096981586E+04 + 1.9557254000E+03 3.2384144195E+04 + 1.9754802000E+03 3.2673875249E+04 + 1.9954345000E+03 3.2966197803E+04 + 2.0155904000E+03 3.3261136284E+04 + 2.0359499000E+03 3.3558713563E+04 + 2.0565151000E+03 3.3858953884E+04 + 2.0772880000E+03 3.4161879936E+04 + 2.0982707000E+03 3.4467515777E+04 + 2.1194653000E+03 3.4775885374E+04 + 2.1408741000E+03 3.5087015504E+04 + 2.1624991000E+03 3.5400928486E+04 + 2.1843425000E+03 3.5717649455E+04 + 2.2064066000E+03 3.6037204893E+04 + 2.2286935000E+03 3.6359618288E+04 + 2.2512055000E+03 3.6684915926E+04 + 2.2739450000E+03 3.7013125434E+04 + 2.2969141000E+03 3.7344270008E+04 + 2.3201153000E+03 3.7678378511E+04 + 2.3435508000E+03 3.8015475382E+04 + 2.3672230000E+03 3.8355587837E+04 + 2.3911344000E+03 3.8698744421E+04 + 2.4152872000E+03 3.9044969269E+04 + 2.4396841000E+03 3.9394293581E+04 + 2.4643274000E+03 3.9746742713E+04 + 2.4892196000E+03 4.0102344783E+04 + 2.5143632000E+03 4.0461127798E+04 + 2.5397608000E+03 4.0823121081E+04 + 2.5654149000E+03 4.1188352418E+04 + 2.5913282000E+03 4.1556852332E+04 + 2.6175033000E+03 4.1928649805E+04 + 2.6439427000E+03 4.2303772289E+04 + 2.6706492000E+03 4.2682251382E+04 + 2.6976254000E+03 4.3064115725E+04 + 2.7248742000E+03 4.3449398092E+04 + 2.7523982000E+03 4.3838126892E+04 + 2.7802002000E+03 4.4230333244E+04 + 2.8082830000E+03 4.4626048150E+04 + 2.8366495000E+03 4.5025303894E+04 + 2.8653025000E+03 4.5428131232E+04 + 2.8942450000E+03 4.5834563607E+04 + 2.9234798000E+03 4.6244631529E+04 + 2.9530099000E+03 4.6658368189E+04 + 2.9828382000E+03 4.7075805253E+04 + 3.0129679000E+03 4.7496978453E+04 + 3.0434019000E+03 4.7921919199E+04 + 3.0741434000E+03 4.8350662956E+04 + 3.1051953000E+03 4.8783240879E+04 + 3.1365609000E+03 4.9219689564E+04 + 3.1682434000E+03 4.9660044075E+04 + 3.2002458000E+03 5.0104336565E+04 + 3.2325715000E+03 5.0552604608E+04 + 3.2652238000E+03 5.1004884245E+04 + 3.2982058000E+03 5.1461208614E+04 + 3.3315210000E+03 5.1921616248E+04 + 3.3651728000E+03 5.2386144152E+04 + 3.3991644000E+03 5.2854826430E+04 + 3.4334994000E+03 5.3327702562E+04 + 3.4681812000E+03 5.3804809123E+04 + 3.5032134000E+03 5.4286185293E+04 + 3.5385993000E+03 5.4771865985E+04 + 3.5743428000E+03 5.5261894199E+04 + 3.6104472000E+03 5.5756304555E+04 + 3.6469164000E+03 5.6255139743E+04 + 3.6837540000E+03 5.6758438187E+04 + 3.7209636000E+03 5.7266238166E+04 + 3.7585491000E+03 5.7778581897E+04 + 3.7965142000E+03 5.8295508710E+04 + 3.8348628000E+03 5.8817060502E+04 + 3.8735988000E+03 5.9343279009E+04 + 3.9127261000E+03 5.9874205803E+04 + 3.9522486000E+03 6.0409882294E+04 + 3.9921703000E+03 6.0950351087E+04 + 4.0324952000E+03 6.1495654621E+04 + 4.0732275000E+03 6.2045837871E+04 + 4.1143712000E+03 6.2600942938E+04 + 4.1559305000E+03 6.3161014457E+04 + 4.1979096000E+03 6.3726096888E+04 + 4.2403128000E+03 6.4296235863E+04 + 4.2831442000E+03 6.4871474150E+04 + 4.3264083000E+03 6.5451859719E+04 + 4.3701094000E+03 6.6037437672E+04 + 4.4142519000E+03 6.6628254275E+04 + 4.4588403000E+03 6.7224356951E+04 + 4.5038791000E+03 6.7825792938E+04 + 4.5493728000E+03 6.8432609291E+04 + 4.5953261000E+03 6.9044855547E+04 + 4.6417435000E+03 6.9662578389E+04 + 4.6886298000E+03 7.0285828306E+04 + 4.7359897000E+03 7.0914654264E+04 + 4.7838280000E+03 7.1549106364E+04 + 4.8321495000E+03 7.2189234514E+04 + 4.8809591000E+03 7.2835089748E+04 + 4.9302617000E+03 7.3486722905E+04 + 4.9800623000E+03 7.4144185947E+04 + 5.0303660000E+03 7.4807531949E+04 + 5.0811777000E+03 7.5476811149E+04 + 5.1325028000E+03 7.6152080168E+04 + 5.1843462000E+03 7.6833388833E+04 + 5.2367134000E+03 7.7520794657E+04 + 5.2896095000E+03 7.8214349684E+04 + 5.3430399000E+03 7.8914109683E+04 + 5.3970100000E+03 7.9620130209E+04 + 5.4515252000E+03 8.0332466600E+04 + 5.5065911000E+03 8.1051176588E+04 + 5.5622133000E+03 8.1776317683E+04 + 5.6183972000E+03 8.2507944567E+04 + 5.6751487000E+03 8.3246118210E+04 + 5.7324735000E+03 8.3990896751E+04 + 5.7903772000E+03 8.4742336802E+04 + 5.8488659000E+03 8.5500501239E+04 + 5.9079453000E+03 8.6265447513E+04 + 5.9676216000E+03 8.7037239318E+04 + 6.0279006000E+03 8.7815934935E+04 + 6.0887884000E+03 8.8601596288E+04 + 6.1502914000E+03 8.9394288928E+04 + 6.2124155000E+03 9.0194071713E+04 + 6.2751672000E+03 9.1001010991E+04 + 6.3385527000E+03 9.1815168994E+04 + 6.4025785000E+03 9.2636611566E+04 + 6.4672510000E+03 9.3465403011E+04 + 6.5325768000E+03 9.4301609944E+04 + 6.5985624000E+03 9.5145297443E+04 + 6.6652145000E+03 9.5996532886E+04 + 6.7325399000E+03 9.6855384667E+04 + 6.8005454000E+03 9.7721920912E+04 + 6.8692378000E+03 9.8596209485E+04 + 6.9386240000E+03 9.9478319255E+04 + 7.0087111000E+03 1.0036832137E+05 + 7.0795062000E+03 1.0126628668E+05 + 7.1510164000E+03 1.0217228579E+05 + 7.2232488000E+03 1.0308638902E+05 + 7.2962110000E+03 1.0400867272E+05 + 7.3699101000E+03 1.0493920665E+05 + 7.4443536000E+03 1.0587806534E+05 + 7.5195491000E+03 1.0682532429E+05 + 7.5955041000E+03 1.0778105744E+05 + 7.6722264000E+03 1.0874534222E+05 + 7.7497236000E+03 1.0971825325E+05 + 7.8280037000E+03 1.1069986987E+05 + 7.9070744000E+03 1.1169026736E+05 + 7.9869438000E+03 1.1268952572E+05 + 8.0676200000E+03 1.1369772461E+05 + 8.1491112000E+03 1.1471494467E+05 + 8.2314254000E+03 1.1574126369E+05 + 8.3145711000E+03 1.1677676542E+05 + 8.3985567000E+03 1.1782153202E+05 + 8.4833906000E+03 1.1887564534E+05 + 8.5690814000E+03 1.1993918939E+05 + 8.6556378000E+03 1.2101224909E+05 + 8.7430685000E+03 1.2209490905E+05 + 8.8313823000E+03 1.2318725476E+05 + 8.9205882000E+03 1.2428937386E+05 + 9.0106951000E+03 1.2540135244E+05 + 9.1017122000E+03 1.2652327990E+05 + 9.1936487000E+03 1.2765524535E+05 + 9.2865139000E+03 1.2879733874E+05 + 9.3803170000E+03 1.2994964847E+05 + 9.4750677000E+03 1.3111226872E+05 + 9.5707755000E+03 1.3228529084E+05 + 9.6674500000E+03 1.3346880709E+05 + 9.7651010000E+03 1.3466291177E+05 + 9.8637384000E+03 1.3586770006E+05 + 9.9633721000E+03 1.3708326677E+05 + 1.0064012000E+04 1.3830970633E+05 + 1.0165669000E+04 1.3954712500E+05 + 1.0268352000E+04 1.4079560428E+05 + 1.0372073000E+04 1.4205526302E+05 + 1.0476842000E+04 1.4332619533E+05 + 1.0582668000E+04 1.4460848287E+05 + 1.0689564000E+04 1.4590225536E+05 + 1.0797539000E+04 1.4720759368E+05 + 1.0906605000E+04 1.4852461461E+05 + 1.1016773000E+04 1.4985342243E+05 + 1.1128054000E+04 1.5119412100E+05 + 1.1240458000E+04 1.5254680174E+05 + 1.1353998000E+04 1.5391159180E+05 + 1.1468685000E+04 1.5528859380E+05 + 1.1584530000E+04 1.5667790996E+05 + 1.1701546000E+04 1.5807966607E+05 + 1.1819743000E+04 1.5949395155E+05 + 1.1939135000E+04 1.6092090324E+05 + 1.2059732000E+04 1.6236060974E+05 + 1.2181547000E+04 1.6381319505E+05 + 1.2304593000E+04 1.6527878270E+05 + 1.2428882000E+04 1.6675748384E+05 + 1.2554426000E+04 1.6824940918E+05 + 1.2681239000E+04 1.6975469276E+05 + 1.2809332000E+04 1.7127343251E+05 + 1.2938719000E+04 1.7280576152E+05 + 1.3069413000E+04 1.7435180053E+05 + 1.3201428000E+04 1.7591168162E+05 + 1.3334775000E+04 1.7748550097E+05 + 1.3469470000E+04 1.7907341331E+05 + 1.3605525000E+04 1.8067552567E+05 + 1.3742955000E+04 1.8229197997E+05 + 1.3881773000E+04 1.8392289404E+05 + 1.4021993000E+04 1.8556839704E+05 + 1.4163629000E+04 1.8722861758E+05 + 1.4306696000E+04 1.8890369553E+05 + 1.4451208000E+04 1.9059375846E+05 + 1.4597180000E+04 1.9229894518E+05 + 1.4744626000E+04 1.9401938226E+05 + 1.4893562000E+04 1.9575521911E+05 + 1.5044002000E+04 1.9750658125E+05 + 1.5195961000E+04 1.9927360537E+05 + 1.5349456000E+04 2.0105645084E+05 + 1.5504501000E+04 2.0285524160E+05 + 1.5661112000E+04 2.0467012432E+05 + 1.5819305000E+04 2.0650124506E+05 + 1.5979096000E+04 2.0834874932E+05 + 1.6140501000E+04 2.1021278207E+05 + 1.6303536000E+04 2.1209348767E+05 + 1.6468218000E+04 2.1399102147E+05 + 1.6634564000E+04 2.1590553820E+05 + 1.6802590000E+04 2.1783718051E+05 + 1.6972313000E+04 2.1978610197E+05 + 1.7143751000E+04 2.2175246702E+05 + 1.7316920000E+04 2.2373641655E+05 + 1.7491838000E+04 2.2573811380E+05 + 1.7668523000E+04 2.2775772136E+05 + 1.7846993000E+04 2.2979540119E+05 + 1.8027266000E+04 2.3185131463E+05 + 1.8209360000E+04 2.3392562239E+05 + 1.8393293000E+04 2.3601848456E+05 + 1.8579083000E+04 2.3813006059E+05 + 1.8766751000E+04 2.4026054340E+05 + 1.8956314000E+04 2.4241007977E+05 + 1.9147792000E+04 2.4457884990E+05 + 1.9341204000E+04 2.4676702199E+05 + 1.9536570000E+04 2.4897477487E+05 + 1.9733909000E+04 2.5120227539E+05 + 1.9933241000E+04 2.5344970104E+05 + 2.0134587000E+04 2.5571723987E+05 + 2.0337967000E+04 2.5800506794E+05 + 2.0543401000E+04 2.6031336066E+05 + 2.0750910000E+04 2.6264230396E+05 + 2.0960515000E+04 2.6499208303E+05 + 2.1172237000E+04 2.6736288238E+05 + 2.1386098000E+04 2.6975489695E+05 + 2.1602120000E+04 2.7216832095E+05 + 2.1820323000E+04 2.7460332551E+05 + 2.2040730000E+04 2.7706011452E+05 + 2.2263364000E+04 2.7953889111E+05 + 2.2488246000E+04 2.8203983534E+05 + 2.2715400000E+04 2.8456315992E+05 + 2.2944849000E+04 2.8710906563E+05 + 2.3176615000E+04 2.8967774140E+05 + 2.3410722000E+04 2.9226939754E+05 + 2.3647194000E+04 2.9488424357E+05 + 2.3886055000E+04 2.9752248819E+05 + 2.4127328000E+04 3.0018432823E+05 + 2.4371038000E+04 3.0286998184E+05 + 2.4617210000E+04 3.0557966630E+05 + 2.4865869000E+04 3.0831359802E+05 + 2.5117039000E+04 3.1107198164E+05 + 2.5370747000E+04 3.1385505387E+05 + 2.5627017000E+04 3.1666301765E+05 + 2.5885876000E+04 3.1949610796E+05 + 2.6147349000E+04 3.2235453701E+05 + 2.6411464000E+04 3.2523854893E+05 + 2.6678246000E+04 3.2814835419E+05 + 2.6947724000E+04 3.3108420602E+05 + 2.7219923000E+04 3.3404631314E+05 + 2.7494872000E+04 3.3703492692E+05 + 2.7772598000E+04 3.4005027607E+05 + 2.8053129000E+04 3.4309259924E+05 + 2.8336494000E+04 3.4616214498E+05 + 2.8622721000E+04 3.4925915006E+05 + 2.8911839000E+04 3.5238386114E+05 + 2.9203878000E+04 3.5553653472E+05 + 2.9498867000E+04 3.5871741550E+05 + 2.9796835000E+04 3.6192674725E+05 + 3.0097813000E+04 3.6516479431E+05 + 3.0401832000E+04 3.6843181998E+05 + 3.0708921000E+04 3.7172806509E+05 + 3.1019112000E+04 3.7505380167E+05 + 3.1332436000E+04 3.7840929001E+05 + 3.1648926000E+04 3.8179481077E+05 + 3.1968612000E+04 3.8521061147E+05 + 3.2291527000E+04 3.8865697068E+05 + 3.2617704000E+04 3.9213416590E+05 + 3.2947176000E+04 3.9564247354E+05 + 3.3279975000E+04 3.9918215830E+05 + 3.3616137000E+04 4.0275352636E+05 + 3.3955694000E+04 4.0635684024E+05 + 3.4298681000E+04 4.0999239327E+05 + 3.4645132000E+04 4.1366046703E+05 + 3.4995083000E+04 4.1736136317E+05 + 3.5348568000E+04 3.9249801946E+05 + 3.5705625000E+04 3.9681908379E+05 + 3.6066288000E+04 4.0118771150E+05 + 3.6430593000E+04 4.0560442107E+05 + 3.6798579000E+04 4.1006976866E+05 + 3.7170282000E+04 4.1458427540E+05 + 3.7545740000E+04 4.1914848802E+05 + 3.7924989000E+04 4.2376293026E+05 + 3.8308070000E+04 4.2842818806E+05 + 3.8695020000E+04 4.3314480005E+05 + 3.9085879000E+04 4.3791334280E+05 + 3.9480686000E+04 4.4273438213E+05 + 3.9879481000E+04 4.4760849744E+05 + 4.0282304000E+04 4.5253626959E+05 + 4.0689196000E+04 4.5751829314E+05 + 4.1100198000E+04 4.6255516410E+05 + 4.1515351000E+04 4.6764747998E+05 + 4.1934698000E+04 4.7279586431E+05 + 4.2358281000E+04 4.7800092990E+05 + 4.2786142000E+04 4.8326329106E+05 + 4.3218326000E+04 4.8858360058E+05 + 4.3654874000E+04 4.9396246357E+05 + 4.4095833000E+04 4.9940056063E+05 + 4.4541245000E+04 5.0489851236E+05 + 4.4991157000E+04 5.1045700264E+05 + 4.5445613000E+04 5.1607667998E+05 + 4.5904660000E+04 5.2175823162E+05 + 4.6368343000E+04 5.2750232171E+05 + 4.6836710000E+04 5.3330965327E+05 + 4.7309808000E+04 5.3918091865E+05 + 4.7787685000E+04 5.4511682434E+05 + 4.8270389000E+04 5.5111807859E+05 + 4.8757969000E+04 5.5718540384E+05 + 4.9250473000E+04 5.6331951188E+05 + 4.9747953000E+04 5.6952116612E+05 + 5.0250457000E+04 5.7579108196E+05 + 5.0758038000E+04 5.8213003903E+05 + 5.1270745000E+04 5.8853876889E+05 + 5.1788632000E+04 5.9501806746E+05 + 5.2311749000E+04 6.0156868256E+05 + 5.2840151000E+04 6.0819142654E+05 + 5.3373889000E+04 6.1488706357E+05 + 5.3913020000E+04 6.2165643505E+05 + 5.4457596000E+04 6.2850032167E+05 + 5.5007672000E+04 6.3541954375E+05 + 5.5563305000E+04 6.4241494885E+05 + 5.6124551000E+04 6.4948737403E+05 + 5.6691466000E+04 6.5663765844E+05 + 5.7264107000E+04 6.6386665591E+05 + 5.7842532000E+04 6.7117523504E+05 + 5.8426800000E+04 6.7856427923E+05 + 5.9016970000E+04 6.8603467408E+05 + 5.9613101000E+04 6.9358730739E+05 + 6.0215253000E+04 7.0122308183E+05 + 6.0823488000E+04 7.0894292771E+05 + 6.1437867000E+04 7.1674776495E+05 + 6.2058451000E+04 7.2463851573E+05 + 6.2685304000E+04 7.3261614272E+05 + 6.3318489000E+04 7.4068159823E+05 + 6.3958070000E+04 7.4883584972E+05 + 6.4604111000E+04 7.5707986699E+05 + 6.5256678000E+04 7.6541464785E+05 + 6.5915836000E+04 7.7384117976E+05 + 6.6581653000E+04 7.8236049104E+05 + 6.7254195000E+04 7.9097358695E+05 + 6.7933530000E+04 7.9968150088E+05 + 6.8619727000E+04 8.0848528161E+05 + 6.9312856000E+04 8.1738599337E+05 + 7.0012986000E+04 8.2638469018E+05 + 7.0720187000E+04 8.3548244153E+05 + 7.1434533000E+04 8.4468037109E+05 + 7.2156094000E+04 8.5397955376E+05 + 7.2884943000E+04 8.6338110579E+05 + 7.3621155000E+04 8.7288617206E+05 + 7.4364803000E+04 8.8249587441E+05 + 7.5115962000E+04 8.9221136335E+05 + 7.5874709000E+04 9.0203381814E+05 + 7.6641121000E+04 9.1196442097E+05 + 7.7415273000E+04 9.2200433102E+05 + 7.8197246000E+04 9.3215478822E+05 + 7.8987117000E+04 9.4241698364E+05 + 7.9784967000E+04 9.5279216330E+05 + 8.0590875000E+04 9.6328155029E+05 + 8.1404925000E+04 9.7388643587E+05 + 8.2227197000E+04 9.8460806236E+05 + 8.3057774000E+04 9.9544771429E+05 + 8.3896742000E+04 1.0064067186E+06 + 8.4744184000E+04 1.0174863663E+06 + 8.5600185000E+04 1.0286879777E+06 + 8.6464834000E+04 1.0400129289E+06 + 8.7338216000E+04 1.0514625469E+06 + 8.8220420000E+04 1.0630382146E+06 + 8.9111536000E+04 1.0747413312E+06 + 9.0011652000E+04 1.0865732733E+06 + 9.0920861000E+04 1.0985354868E+06 + 9.1839253000E+04 1.1106293813E+06 + 9.2766922000E+04 1.1228564230E+06 + 9.3703962000E+04 1.1352180817E+06 + 9.4650467000E+04 1.1477158305E+06 + 9.5606532000E+04 1.1603511598E+06 + 9.6572255000E+04 1.1731256032E+06 + 9.7547732000E+04 1.1860406716E+06 + 9.8533063000E+04 1.1990979326E+06 + 9.9528346000E+04 1.2122989314E+06 + 1.0053368000E+05 1.2256452301E+06 + 1.0154917000E+05 1.2391384745E+06 + 1.0257492000E+05 1.2527803011E+06 + 1.0361103000E+05 1.2665722973E+06 + 1.0465761000E+05 1.2805161877E+06 + 1.0571476000E+05 1.2946135678E+06 + 1.0678258000E+05 1.3088660370E+06 + 1.0786120000E+05 1.3232755994E+06 + 1.0895070000E+05 1.3378435958E+06 + 1.1005121000E+05 1.3525720391E+06 + 1.1116284000E+05 1.3674626796E+06 + 1.1228570000E+05 1.3825172717E+06 + 1.1341990000E+05 1.3977375746E+06 + 1.1456555000E+05 1.4131253512E+06 + 1.1572278000E+05 1.4286826381E+06 + 1.1689170000E+05 1.4444112079E+06 + 1.1807242000E+05 1.4603128374E+06 + 1.1926507000E+05 1.4763895773E+06 + 1.2046977000E+05 1.4926433487E+06 + 1.2168664000E+05 1.5090760776E+06 + 1.2291580000E+05 1.5256896944E+06 + 1.2415737000E+05 1.5424861345E+06 + 1.2541149000E+05 1.5594676088E+06 + 1.2667827000E+05 1.5766359274E+06 + 1.2795785000E+05 1.5939933115E+06 + 1.2925035000E+05 1.6115417164E+06 + 1.3055591000E+05 1.6292833740E+06 + 1.3187466000E+05 1.6472203860E+06 + 1.3320672000E+05 1.6653547228E+06 + 1.3455225000E+05 1.6836889048E+06 + 1.3591136000E+05 1.7022247771E+06 + 1.3728420000E+05 1.7209647349E+06 + 1.3867091000E+05 1.7399110430E+06 + 1.4007163000E+05 1.7590659719E+06 + 1.4148649000E+05 1.7784316607E+06 + 1.4291565000E+05 1.7980106647E+06 + 1.4435924000E+05 1.8178051346E+06 + 1.4581741000E+05 1.8378175003E+06 + 1.4729032000E+05 1.8580503358E+06 + 1.4877810000E+05 1.8785058085E+06 + 1.5028091000E+05 1.8991865043E+06 + 1.5179890000E+05 1.9200948775E+06 + 1.5333222000E+05 1.9412333889E+06 + 1.5488103000E+05 1.9626046430E+06 + 1.5644548000E+05 1.9842111128E+06 + 1.5802574000E+05 2.0060555540E+06 + 1.5962196000E+05 2.0281404525E+06 + 1.6123430000E+05 2.0504684385E+06 + 1.6286293000E+05 2.0730422876E+06 + 1.6450801000E+05 2.0958646435E+06 + 1.6616971000E+05 2.1189382955E+06 + 1.6784819000E+05 2.1422659005E+06 + 1.6954363000E+05 2.1658504005E+06 + 1.7125619000E+05 2.1896944662E+06 + 1.7298605000E+05 2.2138010536E+06 + 1.7473338000E+05 2.2381729866E+06 + 1.7649837000E+05 2.2628133754E+06 + 1.7828118000E+05 2.2877249187E+06 + 1.8008200000E+05 2.3129107415E+06 + 1.8190101000E+05 2.3383738365E+06 + 1.8373839000E+05 2.3641172037E+06 + 1.8559434000E+05 2.3901441313E+06 + 1.8746903000E+05 2.4164574945E+06 + 1.8936265000E+05 2.4430604565E+06 + 1.9127541000E+05 2.4699564697E+06 + 1.9320748000E+05 2.4971484320E+06 + 1.9515907000E+05 2.5246398120E+06 + 1.9713038000E+05 2.5524339460E+06 + 1.9912159000E+05 2.5805338963E+06 + 2.0113292000E+05 2.6089432977E+06 + 2.0316457000E+05 2.6376655114E+06 + 2.0521674000E+05 2.6667039070E+06 + 2.0728963000E+05 2.6960618622E+06 + 2.0938347000E+05 2.7257431885E+06 + 2.1149845000E+05 2.7557511395E+06 + 2.1363480000E+05 2.7860895447E+06 + 2.1579273000E+05 2.8167619589E+06 + 2.1797245000E+05 2.8477719457E+06 + 2.2017419000E+05 2.8791233623E+06 + 2.2239817000E+05 2.9108199330E+06 + 2.2464462000E+05 2.9428655341E+06 + 2.2691376000E+05 2.9752639088E+06 + 2.2920582000E+05 3.0080189522E+06 + 2.3152103000E+05 3.0411345692E+06 + 2.3385962000E+05 3.0746146745E+06 + 2.3622184000E+05 3.1084634789E+06 + 2.3860792000E+05 3.1426849170E+06 + 2.4101810000E+05 3.1772830768E+06 + 2.4345263000E+05 3.2122621998E+06 + 2.4591175000E+05 3.2476263946E+06 + 2.4839570000E+05 3.2833797796E+06 + 2.5090475000E+05 3.3195269159E+06 + 2.5343914000E+05 3.3560719433E+06 + 2.5599913000E+05 3.3930193006E+06 + 2.5858498000E+05 3.4303734373E+06 + 2.6119695000E+05 3.4681388144E+06 + 2.6383531000E+05 3.5063200483E+06 + 2.6650031000E+05 3.5449214776E+06 + 2.6919223000E+05 3.5839478860E+06 + 2.7191134000E+05 3.6234039244E+06 + 2.7465792000E+05 3.6632944003E+06 + 2.7743225000E+05 3.7036241335E+06 + 2.8023459000E+05 3.7443976644E+06 + 2.8306524000E+05 3.7856201271E+06 + 2.8592449000E+05 3.8272965230E+06 + 2.8881262000E+05 3.8694317200E+06 + 2.9172991000E+05 3.9120305979E+06 + 2.9467668000E+05 3.9550986331E+06 + 2.9765321000E+05 3.9986407309E+06 + 3.0065981000E+05 4.0426622478E+06 + 3.0369678000E+05 4.0871684070E+06 + 3.0676442000E+05 4.1321644447E+06 + 3.0986305000E+05 4.1776559038E+06 + 3.1299298000E+05 4.2236481938E+06 + 3.1615453000E+05 4.2701468850E+06 + 3.1934801000E+05 4.3171574143E+06 + 3.2257375000E+05 4.3646855265E+06 + 3.2583207000E+05 4.4127368335E+06 + 3.2912330000E+05 4.4613171084E+06 + 3.3244778000E+05 4.5104322866E+06 + 3.3580584000E+05 4.5600881705E+06 + 3.3919781000E+05 4.6102905766E+06 + 3.4262406000E+05 4.6610459285E+06 + 3.4608490000E+05 4.7123597763E+06 + 3.4958071000E+05 4.7642387223E+06 + 3.5311183000E+05 4.8166887916E+06 + 3.5667862000E+05 4.8697163212E+06 + 3.6028143000E+05 4.9233275152E+06 + 3.6392064000E+05 4.9775290397E+06 + 3.6759660000E+05 5.0323271303E+06 + 3.7130970000E+05 5.0877286349E+06 + 3.7506030000E+05 5.1437399705E+06 + 3.7884879000E+05 5.2003680182E+06 + 3.8267555000E+05 5.2576195269E+06 + 3.8654096000E+05 5.3155012619E+06 + 3.9044541000E+05 5.3740201553E+06 + 3.9438930000E+05 5.4331833064E+06 + 3.9837303000E+05 5.4929978323E+06 + 4.0239700000E+05 5.5534708677E+06 + 4.0646162000E+05 5.6146097153E+06 + 4.1056729000E+05 5.6764215455E+06 + 4.1471444000E+05 5.7389139986E+06 + 4.1890347000E+05 5.8020942813E+06 + 4.2313482000E+05 5.8659702219E+06 + 4.2740891000E+05 5.9305493663E+06 + 4.3172617000E+05 5.9958394301E+06 + 4.3608704000E+05 6.0618482994E+06 + 4.4049196000E+05 6.1285838801E+06 + 4.4494137000E+05 6.1960540976E+06 + 4.4943573000E+05 6.2642672004E+06 + 4.5397549000E+05 6.3332313059E+06 + 4.5856110000E+05 6.4029545514E+06 + 4.6319303000E+05 6.4734453987E+06 + 4.6787174000E+05 6.5447121785E+06 + 4.7259772000E+05 6.6167636994E+06 + 4.7737144000E+05 6.6896084868E+06 + 4.8219337000E+05 6.7632550873E+06 + 4.8706401000E+05 6.8377125271E+06 + 4.9198385000E+05 6.9129897021E+06 + 4.9695338000E+05 6.9890955300E+06 + 5.0197311000E+05 7.0660392573E+06 + 5.0704355000E+05 7.1438301537E+06 + 5.1216520000E+05 7.2224773580E+06 + 5.1733859000E+05 7.3019904931E+06 + 5.2256423000E+05 7.3823788978E+06 + 5.2784266000E+05 7.4636523962E+06 + 5.3317440000E+05 7.5458205286E+06 + 5.3856000000E+05 7.6288933216E+06 + 5.4400000000E+05 7.7128806723E+06 diff --git a/test/ctem.dat b/test/ctem.dat new file mode 100644 index 00000000..8bc50e17 --- /dev/null +++ b/test/ctem.dat @@ -0,0 +1,13 @@ + 107576 0 0.000000000000E+00 F 1.000000 0.000000000000E+00 + 7333915 + 4338981 + 16531264 + 8522107 + 3419218 + 8767644 + 3609462 + 8594175 + 439475588 + 1068313672 + 1099176122 + 1759235898 diff --git a/examples/regolith-transport-run-example/ctem.in b/test/ctem.in similarity index 60% rename from examples/regolith-transport-run-example/ctem.in rename to test/ctem.in index 165c1877..813fb8a1 100644 --- a/examples/regolith-transport-run-example/ctem.in +++ b/test/ctem.in @@ -1,58 +1,57 @@ ! CTEM Input file: Compatible with v. 1.1 ! IDL driver in uts -interval 1.00e7 ! Time interval between outputs (y) -numintervals 400 ! Total number of intervals +interval 3.0e9 ! Time interval between outputs (y) +numintervals 1 ! Total number of intervals restart F ! Restart a previous run impfile MintonLunarProduction.dat ! Impactor SFD rate file (col 1: Dimp (m), col 2: ! impactors > D (m**(-2) y**(-1)) -popupconsole T ! Pop up console window every output interval +popupconsole F ! Pop up console window every output interval saveshaded T ! Output shaded relief images saverego T ! Output regolith map images -savepres T ! Output simplified console display images (presentation-compatible images) -savetruelist T ! Save the true cumulative crater distribution for each interval (large file size) -sfdcompare SinusMedii-data-binned.dat ! File name for the SFD comparison file used in the console display -shadedminh -85.0 ! Minimum height for shaded relief map (m) (Default - automatic) -shadedmaxh 85.0 ! Maximum height for shaded relief map (m) (Default - automatic) -tallystart 10 ! Initial value of the tally cadence -runtype single ! Run type: options are normal / statistical +savepres F ! Output simplified console display images (presentation-compatible images) +savetruelist F ! Save the true cumulative crater distribution for each interval (large file size) +sfdcompare Robbins2014-A15-FassettCounts-binned.dat ! File name for the SFD comparison file used in the console display +!shadedminh -85.0 ! Minimum height for shaded relief map (m) (Default - automatic) +!shadedmaxh 85.0 ! Maximum height for shaded relief map (m) (Default - automatic) +runtype statistical ! Run type: options are normal / statistical ! single: craters accumulate in successive intervals ! statistical: surface is reset between intervals ! CTEM required inputs seed 9234568 ! Random number generator seed -gridsize 2000 ! Size of grid in pixels +gridsize 100 ! Size of grid in pixels numlayers 10 ! Number of perched layers -pix 3.6e0 ! Pixel size (m) +pix 10.0 ! Pixel size (m) mat rock ! Material (rock or ice) ! Bedrock scaling parameters -mu_b 0.41d0 ! Experimentally derived parameter for bedrock crater scaling law -kv_b 0.24d0 ! Experimentally derived parameter for bedrock crater scaling law -trho_b 2250.0d0 ! Target density (bedrock) (kg/m**3) -ybar_b 0.18d6 ! Bedrock strength (Pa) +mu_b 0.55e0 ! Experimentally derived parameter for bedrock crater scaling law +kv_b 0.20e0 ! Experimentally derived parameter for bedrock crater scaling law +trho_b 2250.0e0 ! Target density (bedrock) (kg/m**3) +ybar_b 0.0d6 ! Bedrock strength (Pa) ! Regolith scaling parameters -mu_r 0.41d0 ! Experimentally derived parameter for regolith crater scaling law -kv_r 0.24d0 ! Experimentally derived parameter for regolith crater scaling law -trho_r 1500.0d0 ! Target density (regolith) (kg/m**3) +mu_r 0.55e0 ! Experimentally derived parameter for regolith crater scaling law +kv_r 0.20e0 ! Experimentally derived parameter for regolith crater scaling law +trho_r 2250.0e0 ! Target density (regolith) (kg/m**3) ybar_r 0.00d6 ! Regolith strength (Pa) ! Body parameters -gaccel 1.62d0 ! Gravitational acceleration at target (m/s**2) +gaccel 1.62e0 ! Gravitational acceleration at target (m/s**2) trad 1737.35d3 ! Target radius (m) -prho 2500.0d0 ! Projectile density (kg/m**3) +prho 2500.0e0 ! Projectile density (kg/m**3) sfdfile production.dat ! Impactor SFD file (col 1: Dimp (m), col 2: ! impactors > D velfile lunar-MBA-impactor-velocities.dat ! Impactor velocity dist file ! Seismic shaking input (required if seismic shaking is set to T, otherwise ignored) doseismic F ! Perform seismic shaking calculations with each impact - Default F -seisq 2000.0d0 ! Seimsic energy attenuation quality factor, Q +seisq 2000.0e0 ! Seimsic energy attenuation quality factor, Q ! Value taken from Richardson et al. (2005) -tvel 100.d0 ! Target p-wave speed (m/s) +tvel 100.e0 ! Target p-wave speed (m/s) ! Value taken from Watkins and Kovach (1973) LPSC -tfrac 2000.d0 ! Mean free path for seismic wave scattering in target (m) +tfrac 2000.e0 ! Mean free path for seismic wave scattering in target (m) ! Value taken from Dainty et al. (1974) The Moon v. 9 p. 11 -regcoh 520.d0 ! Regolith layer cohesion (Pa) +regcoh 520.e0 ! Regolith layer cohesion (Pa) ! Value taken from Colwell et al. (2007) Rev. of Geophys. v. 45 p. RG2006 ! For upper 0-60 cm @@ -60,22 +59,28 @@ neff 5.0d-10 ! Impact energy seismic efficien ! Optional input. These have internally set default values that work reasonable well. Comment them out with -countingmodel Fassett ! Crater counter model. Default is by Caleb Fassett. deplimit 10d3 ! Depth limit for craters (m) - Default is to ignore. -maxcrat 1.00d0 ! Fraction of gridsize that maximum crater can be - Default 1.0 +maxcrat 1.0 ! Fraction of gridsize that maximum crater can be - Default 1.0 killatmaxcrater F ! Stop the run if a crater larger than the maximum is produced - Default F -basinimp 35.0d3 ! Size of impactor to switch to lunar basin scaling law - Default is to ignore +basinimp 35.0e3 ! Size of impactor to switch to lunar basin scaling law - Default is to ignore docollapse T ! Do slope collapse - Default T -dosoftening T ! Do ejecta softening - Default T +dosoftening F ! Do ejecta softening - Default T doangle T ! Vary the impact angle. Set to F to have only vertical impacts - Default T +doregotrack T ! Regolith layers track flag. Set to F for default. +soften_factor 1.6 +soften_slope 1.8 +soften_size 200.0 +discontinuous T ! Testing input. These are used to perform non-Monte Carlo tests. testflag F ! Set to T to create a single crater with user-defined impactor properties -testimp 50.0 ! Diameter of test impactor (m) -testvel 15.d3 ! Velocity of test crater (m/s) +testimp 0.3 ! Diameter of test impactor (m) +testvel 15.e3 ! Velocity of test crater (m/s) testang 90.0 ! Impact angle of test crater (deg) - Default 90.0 -testxoffset 0.0d0 ! x-axis offset of crater center from grid center (m) - Default 0.0 -testyoffset 0.0d0 ! y-axis offset of crater center from grid center (m) - Default 0.0 +testxoffset 0.0e0 ! x-axis offset of crater center from grid center (m) - Default 0.0 +testyoffset 0.0e0 ! y-axis offset of crater center from grid center (m) - Default 0.0 tallyonly F ! Tally the craters without generating any craters testtally F ! Set to T to count all non-cookie cut craters, regardless of score +! Porosity input +porosityflg F ! Porosity on/off flg. Set to F to turn the model off. Default F. diff --git a/test/ctem1.dat b/test/ctem1.dat new file mode 100644 index 00000000..8bc50e17 --- /dev/null +++ b/test/ctem1.dat @@ -0,0 +1,13 @@ + 107576 0 0.000000000000E+00 F 1.000000 0.000000000000E+00 + 7333915 + 4338981 + 16531264 + 8522107 + 3419218 + 8767644 + 3609462 + 8594175 + 439475588 + 1068313672 + 1099176122 + 1759235898 diff --git a/examples/regolith-transport-run-example/ctem_driver.pro b/test/ctem_driver.pro similarity index 89% rename from examples/regolith-transport-run-example/ctem_driver.pro rename to test/ctem_driver.pro index bba1994b..071af0f7 100644 --- a/examples/regolith-transport-run-example/ctem_driver.pro +++ b/test/ctem_driver.pro @@ -28,7 +28,7 @@ restart = "F" fracdone = 1.0d0 masstot = 0.d0 -ctem_io_read_input,infilename,interval,numintervals,gridsize,pix,seed,numlayers,sfdfile,impfile,maxcrat,ph1,shadedmaxhdefault,shadedminhdefault,shadedminh,shadedmaxh,restart,runtype,popupconsole,saveshaded,saverego,savepres,savetruelist,tallycadence +ctem_io_read_input,infilename,interval,numintervals,gridsize,pix,seed,numlayers,sfdfile,impfile,maxcrat,ph1,shadedmaxhdefault,shadedminhdefault,shadedminh,shadedmaxh,restart,runtype,popupconsole,saveshaded,saverego,savepres,savetruelist seedarr(0) = seed area = (gridsize * pix)^2 @@ -63,7 +63,7 @@ tdist = dblarr(6,distl) pdist = dblarr(6,pdistl) pdisttotal = dblarr(6,pdistl) -datformat = "(I17,1X,I12,1X,E19.12,1X,A1,1X,I12,1X,F9.6,1X,E19.12)" +datformat = "(I17,1X,I12,1X,E19.12,1X,A1,1X,F9.6,1X,E19.12)" if strmatch(restart,'F',/fold_case) then begin ; Start with a clean slate @@ -76,7 +76,7 @@ if strmatch(restart,'F',/fold_case) then begin ; Start with a clean slate if strmatch(runtype,'statistical',/fold_case) then begin ncount = 1 openw,LUN,DATFILE,/GET_LUN - printf,LUN,totalimpacts,ncount,curyear,restart,tallycadence,fracdone,masstot,format=datformat + printf,LUN,totalimpacts,ncount,curyear,restart,fracdone,masstot,format=datformat for n=0,seedn-1 do begin printf,LUN,seedarr(n),format='(I12)' endfor @@ -97,7 +97,7 @@ endif else begin ; continue an old run ;read in constants file openr,LUN,DATFILE,/GET_LUN - readf,LUN,totalimpacts,ncount,curyear,restart,tallycadence,fracdone,masstot,format=datformat + readf,LUN,totalimpacts,ncount,curyear,restart,fracdone,masstot,format=datformat seedn = 0 while ~ eof(LUN) do begin readf,LUN,iseed @@ -141,7 +141,7 @@ while (ncount le numintervals) do begin ;read in constants file openr,LUN,DATFILE,/GET_LUN - readf,LUN,totalimpacts,ncount,curyear,restart,tallycadence,fracdone,masstot,format=datformat + readf,LUN,totalimpacts,ncount,curyear,restart,fracdone,masstot,format=datformat seedn = 0 while ~ eof(LUN) do begin readf,LUN,iseed @@ -221,7 +221,7 @@ while (ncount le numintervals) do begin endelse openw,LUN,DATFILE,/GET_LUN - printf,LUN,totalimpacts,ncount,curyear,restart,tallycadence,fracdone,masstot,format=datformat + printf,LUN,totalimpacts,ncount,curyear,restart,fracdone,masstot,format=datformat for n=0,seedn-1 do begin printf,LUN,seedarr(n),format='(I12)' endfor diff --git a/test/ctem_image_age.pro b/test/ctem_image_age.pro new file mode 100755 index 00000000..aca988ad --- /dev/null +++ b/test/ctem_image_age.pro @@ -0,0 +1,33 @@ +pro ctem_image_age,ncount,gridsize,pix,regolith,regolith_image +; Generates the regolith depth map image and saves it as a jpeg output image in the 'rego' directory +; outputs dregolith, which may be scaled to use as a console image +Compile_Opt DEFINT32 +thisDevice = !D.Name +Set_Plot, 'Z' +Erase +Device, Set_Resolution=[gridsize,gridsize],Set_Pixel_Depth=24, Decomposed=0 +loadct, 11;49;11;39 +TVLCT, red, green, blue, /GET + +minref = pix * 1.0d-4 +regolith_scaled = dblarr(gridsize,gridsize) +maxreg = 37.0 ;max(regolith) +minreg = 0.0 ;min(regolith) +if minreg lt minref then minreg = minref +if maxreg lt minref then maxreg = minref + 1.0d30 +regolith_scaled = regolith > minreg +regolith_scaled = 254.0d0 * (regolith_scaled - minreg)/(maxreg - minreg);((alog(regolith_scaled) - alog(minreg)) / (alog(maxreg) - alog(minreg))) + +; save regolith display +tv, regolith_scaled, 0, 0, xsize=gridsize, ysize=gridsize, /device +regolith_image = TVRD(True=1) +Set_Plot, thisDevice + +if (file_test('agetop',/DIRECTORY) eq 0) then begin + file_mkdir,'agetop' +endif +fnum = string(ncount,format='(I6.6)') +fname = 'agetop/agetop' + fnum + '.jpg' +write_jpeg, fname, regolith_image, true=1, quality=100 + +end diff --git a/examples/regolith-transport-run-example/ctem_image_dem.pro b/test/ctem_image_dem.pro similarity index 100% rename from examples/regolith-transport-run-example/ctem_image_dem.pro rename to test/ctem_image_dem.pro diff --git a/examples/regolith-transport-run-example/ctem_image_regolith.pro b/test/ctem_image_regolith.pro similarity index 100% rename from examples/regolith-transport-run-example/ctem_image_regolith.pro rename to test/ctem_image_regolith.pro diff --git a/examples/regolith-transport-run-example/ctem_image_shaded_relief.pro b/test/ctem_image_shaded_relief.pro similarity index 98% rename from examples/regolith-transport-run-example/ctem_image_shaded_relief.pro rename to test/ctem_image_shaded_relief.pro index 73986f84..d8cd85b8 100755 --- a/examples/regolith-transport-run-example/ctem_image_shaded_relief.pro +++ b/test/ctem_image_shaded_relief.pro @@ -7,7 +7,7 @@ thisDevice = !D.Name Set_Plot, 'Z' Erase Device, Set_Resolution=[gridsize,gridsize],Set_Pixel_Depth=24, Decomposed=0 -loadct, 33 +loadct, 61;72; 17 ;33 TVLCT, red, green, blue, /GET light=[[1,1,1],[0,0,0],[-1,-1,-1]] diff --git a/examples/regolith-transport-run-example/ctem_io_read_input.pro b/test/ctem_io_read_input.pro similarity index 96% rename from examples/regolith-transport-run-example/ctem_io_read_input.pro rename to test/ctem_io_read_input.pro index 080b5b01..ea135668 100644 --- a/examples/regolith-transport-run-example/ctem_io_read_input.pro +++ b/test/ctem_io_read_input.pro @@ -1,4 +1,4 @@ -pro ctem_io_read_input,infilename,interval,numintervals,gridsize,pix,seed,numlayers,sfdfile,impfile,maxcrat,ph1,shadedmaxhdefault,shadedminhdefault,shadedminh,shadedmaxh,restart,runtype,popupconsole,saveshaded,saverego,savepres,savetruelist,tallycadence +pro ctem_io_read_input,infilename,interval,numintervals,gridsize,pix,seed,numlayers,sfdfile,impfile,maxcrat,ph1,shadedmaxhdefault,shadedminhdefault,shadedminh,shadedmaxh,restart,runtype,popupconsole,saveshaded,saverego,savepres,savetruelist Compile_Opt DEFINT32 print, 'Reading input file' openr,infile,infilename, /GET_LUN @@ -14,7 +14,6 @@ shadedmaxhdefault = 1 shadedminhdefault = 1 shadedminh = 0.d0 shademaxnh = 0.d0 -tallycadence = long64(5000) ; Set required strings to unset value @@ -49,7 +48,6 @@ while (not EOF(infile)) do begin if strmatch(substrings(0),'savetruelist',/fold_case) then reads,substrings(1),savetruelist if strmatch(substrings(0),'runtype',/fold_case) then reads,substrings(1),runtype if strmatch(substrings(0),'restart',/fold_case) then reads,substrings(1),restart - if strmatch(substrings(0),'tallystart',/fold_case) then reads,substrings(1),tallycadence if strmatch(substrings(0),'shadedminh',/fold_case) then begin reads,substrings(1),shadedminh shadedminhdefault = 0 diff --git a/examples/regolith-transport-run-example/ctem_io_read_old.pro b/test/ctem_io_read_old.pro similarity index 100% rename from examples/regolith-transport-run-example/ctem_io_read_old.pro rename to test/ctem_io_read_old.pro diff --git a/examples/regolith-transport-run-example/ctem_window_display.pro b/test/ctem_window_display.pro similarity index 100% rename from examples/regolith-transport-run-example/ctem_window_display.pro rename to test/ctem_window_display.pro diff --git a/test/output b/test/output new file mode 100644 index 00000000..963ceeec --- /dev/null +++ b/test/output @@ -0,0 +1,422 @@ +Reading input file +Starting a new run +Beginning loops + 0 Displaying results +plotting + 0 time = 0.0000000 + 0 saving window + 1 Calling FORTRAN routine + *--------------------------------------------------------------------* + * ____________________ ___ * + * / ____/_ __/ ____/ |/ / * + * / / / / / __/ / /|_/ / * + * / /___ / / / /___/ / / / * + * \____/ /_/ /_____/_/ /_/ * + * Cratered Terrain Evolution Model * + *--------------------------------------------------------------------* + Version 1.3 DEVELOPMENT + Authors: James E. Richardson + David A. Minton + *--------------------------------------------------------------------* + OpenMP parameters: + ------------------ + Number of threads = 2 + + Initializing simulation domain and determining minimum impactor size + Generating random population of craters. Fewer than: 1866510 + Minimum impactor diameter: 9.6317344999999992E-003 + Minimum crater diameter: 4.0266325684407311 + Maximum crater diameter: 1000.0000000000000 + 2991965218.5086040 1854.2795631907250 3.82010639E-03 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.82010639E-03 + 2983928829.7394543 3521.2267142091573 1.34127773E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.34127773E-02 + 2975892440.9703045 4687.2874167447135 1.65051073E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.65051073E-02 + 2967856052.2011547 5515.8938383886134 1.78418905E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.78418905E-02 + 2959819663.4320049 6322.6981771400924 1.96886398E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.96886398E-02 + 2951783274.6628551 7365.1825832560498 2.34212466E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.34212466E-02 + 2943746885.8937054 8030.9005715196354 3.72980535E-02 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.37706390E-02 2.35274136E-02 + 2935710497.1245556 8791.4485266655556 6.31973982 6.28205729 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.29636288 2.33770572E-02 + 2927674108.3554058 9376.0411543719238 6.28924370 6.23184395 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.26604509 2.31985971E-02 + 2919637719.5862560 10503.737598735926 6.22765017 6.16628504 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.20462227 2.30278857E-02 + 2911601330.8171062 11244.430753214989 6.17512751 6.11233282 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.15225792 2.28693690E-02 + 2903564942.0479565 12459.303325823137 6.11526012 6.04525614 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.09263849 2.26214323E-02 + 2895528553.2788067 13095.500249980865 6.08664465 5.99722624 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.89111792E-02 6.04527140 2.24616751E-02 + 2887492164.5096569 14149.420458128910 6.02959394 5.93386936 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.56716590E-02 5.98169136 2.22312994E-02 + 2879455775.7405071 15181.115328391601 5.97193527 5.87269402 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.96649933E-02 5.92022991 2.20403727E-02 + 2871419386.9713573 16281.492069124770 5.91763401 5.81324387 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.53396125E-02 5.86039734 2.18967870E-02 + 2863382998.2022076 16809.131144394298 5.87701368 5.77167177 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.66554186E-02 5.81857395 2.17843540E-02 + 2855346609.4330578 17516.316688079314 5.83373070 5.72541523 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.00783569E-02 5.77203989 2.16125958E-02 + 2847310220.6639080 17973.231580216503 5.79660273 5.68709993 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.09310448E-03 4.05052230E-02 5.73349667 2.15075649E-02 + 2839273831.8947582 18499.970161975776 5.75328493 5.64274836 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.91621406E-03 4.01923135E-02 5.68884754 2.13290080E-02 + 2831237443.1256084 23251.383115979708 5.82979965 5.55012846 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.173495829 3.96182351E-02 5.59555292 2.11322401E-02 + 2823201054.3564587 24168.996785694817 5.78522015 5.50331545 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.176513001 3.92945595E-02 5.54842138 2.09912956E-02 + 2815164665.5873089 24609.185795286496 5.75160313 5.46994448 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.176912129 3.90330367E-02 5.51480627 2.08515003E-02 + 2807128276.8181591 29808.645298459032 5.77685118 5.37971163 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.295137614 3.77614610E-02 5.42333364 2.06184685E-02 + 2799091888.0490093 31580.668340100696 5.74697733 5.32767773 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.22386025E-05 0.318025112 3.75213847E-02 5.37105656 2.02821773E-02 + 2791055499.2798595 32042.462677239841 5.71687794 5.29473019 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.08180913E-03 0.316438466 3.72360833E-02 5.33791828 2.02029143E-02 + 2783019110.5107098 32628.849114793586 5.68438911 5.26338720 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.32991798E-03 0.313688904 3.69633622E-02 5.30631447 2.00924594E-02 + 2774982721.7415600 36387.644743278172 5.69004011 5.20405865 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.29889625E-02 0.309530109 3.66398841E-02 5.24096251 1.99191067E-02 + 2766946332.9724102 36966.883642941153 5.66487455 5.17638397 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.73495936E-02 0.308077931 3.63599397E-02 5.21322870 1.98583975E-02 + 2758909944.2032604 37324.568055255440 5.64368105 5.15640926 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.80578980E-02 0.306546956 3.61861363E-02 5.19310474 1.97855234E-02 + 2750873555.4341106 37980.729483214898 5.61722565 5.12692118 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.36398953E-02 0.304396182 3.59899886E-02 5.16346169 1.97374877E-02 + 2742837166.6649609 38915.645927256606 5.58780622 5.09265804 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.47036142E-03 9.28715616E-02 0.303179622 3.56538929E-02 5.12899446 1.96362920E-02 + 2734800777.8958111 40010.217104655756 5.56087971 5.05907154 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.76276341E-02 9.20319408E-02 0.301066458 3.54390889E-02 5.09515953 1.95549484E-02 + 2726764389.1266613 40695.255823548803 5.56042624 5.02977610 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.95688431E-02 9.13117379E-02 0.299110234 3.52625810E-02 5.06569004 1.94828399E-02 + 2718728000.3575115 41238.651823395703 5.53668165 5.00502157 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.28141707E-02 9.08350796E-02 0.297703624 3.50855216E-02 5.04081678 1.94261521E-02 + 2710691611.5883617 41677.252863263762 5.52352285 4.98064184 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.69261888E-02 9.02782083E-02 0.295901954 3.48262787E-02 5.01623344 1.93569474E-02 + 2702655222.8192120 42177.741315304971 5.50595665 4.96299124 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.88773468E-02 8.97220746E-02 0.294917613 3.46815698E-02 4.99852180 1.92362424E-02 + 2694618834.0500622 42865.662638836293 5.47759151 4.93421698 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.08212847E-03 6.88939542E-02 8.89172927E-02 0.293488175 3.45057026E-02 4.96956015 1.91441644E-02 + 2686582445.2809124 43252.205234895053 5.46230793 4.91792965 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.43221010E-03 6.84449673E-02 8.84297937E-02 0.291980952 3.44100781E-02 4.95349407 1.91159863E-02 + 2678546056.5117626 43804.904101695909 5.43501282 4.89170027 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.61372147E-03 6.79362714E-02 8.78166184E-02 0.290370911 3.41831967E-02 4.92708302 1.90090984E-02 + 2670509667.7426128 44157.227556491191 5.41699982 4.87506628 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.00291260E-02 6.73073605E-02 8.72345343E-02 0.289049715 3.40247229E-02 4.91038752 1.89667325E-02 + 2662473278.9734631 44763.197866231349 5.39385796 4.84963799 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.57519914E-02 6.64784014E-02 8.66896436E-02 0.287340254 3.38088796E-02 4.88490343 1.88852847E-02 + 2654436890.2043133 45470.059630932636 5.37336159 4.82684612 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.11281721E-02 6.58538863E-02 8.62243250E-02 0.285734951 3.36527973E-02 4.86195612 1.88113358E-02 + 2646400501.4351635 48623.539149775519 5.37072992 4.77296162 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.24116195E-02 6.33760393E-02 6.52038679E-02 8.57672840E-02 0.284111172 3.34237143E-02 4.80773878 1.86972637E-02 + 2638364112.6660137 50628.736431940823 5.35325384 4.73198605 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.03199568E-02 6.25543520E-02 6.46295846E-02 8.49457011E-02 0.282444894 3.32322605E-02 4.76640320 1.87241100E-02 + 2630327723.8968639 50995.601296375695 5.33686638 4.71696806 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.15338762E-02 6.21913001E-02 6.41675815E-02 8.45375434E-02 0.281396091 3.30975763E-02 4.75126028 1.86820943E-02 + 2622291335.1277142 51472.944182642408 5.31965303 4.69914579 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.46026288E-02 6.17579259E-02 6.37203380E-02 8.40572640E-02 0.280486107 3.29836309E-02 4.73341370 1.86315030E-02 + 2614254946.3585644 51846.714283947549 5.30516720 4.68553877 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.58828956E-02 6.13555312E-02 6.34092093E-02 8.37229192E-02 0.279620618 3.28857899E-02 4.71970892 1.85813215E-02 + 2606218557.5894146 52217.446737976279 5.28847647 4.67039490 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.74476144E-02 6.03019707E-02 6.29251674E-02 8.32992420E-02 0.278727531 3.27620320E-02 4.70447445 1.85383279E-02 + 2598182168.8202648 52496.923424759530 5.27343035 4.65623999 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.44094204E-04 4.79888730E-02 5.99188544E-02 6.25406802E-02 8.29766393E-02 0.277742565 3.26804034E-02 4.69024515 1.84930265E-02 + 2590145780.0511150 52834.894221399627 5.25838470 4.64252615 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.42191320E-03 4.76868488E-02 5.95002919E-02 6.19593784E-02 8.24159011E-02 0.276937962 3.25611047E-02 4.67644453 1.84568409E-02 + 2582109391.2819653 53230.354551822493 5.24377632 4.62919235 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.24150284E-03 4.72899228E-02 5.91420047E-02 6.14650883E-02 8.18277225E-02 0.275981426 3.24269943E-02 4.66302729 1.83745120E-02 + 2574073002.5128155 53552.408675252700 5.23203897 4.61805487 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.73911332E-03 4.70299274E-02 5.87997623E-02 6.12486824E-02 8.15707520E-02 0.275090992 3.23484689E-02 4.65187883 1.83323100E-02 + 2566036613.7436657 53811.154806787308 5.23990870 4.60834217 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.54808627E-02 4.67146374E-02 5.85188381E-02 6.08263537E-02 8.12751278E-02 0.274453789 3.22517082E-02 4.64209509 1.82924978E-02 + 2558000224.9745159 54320.076474294343 5.22251987 4.59122849 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.82797553E-02 4.62945029E-02 5.80446906E-02 6.03800230E-02 8.06632712E-02 0.273564756 3.21050175E-02 4.62495518 1.82327628E-02 + 2549963836.2053661 54670.050215373958 5.23509502 4.59771538 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.02839192E-06 5.72924763E-02 4.59662713E-02 5.77407815E-02 5.99027090E-02 8.03596675E-02 0.272909820 3.19874771E-02 4.61075068 1.81840397E-02 + 2541927447.4362164 55044.803582734450 5.22326040 4.58639622 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.40157684E-03 5.67250699E-02 4.55939732E-02 5.74028790E-02 5.93853630E-02 8.00287277E-02 0.272045940 3.19660008E-02 4.59957218 1.81388892E-02 + 2533891058.6670666 55360.773640412939 5.20647001 4.57096529 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.85319116E-03 5.62557466E-02 4.52924110E-02 5.71146086E-02 5.90236224E-02 7.96443820E-02 0.271143079 3.18362117E-02 4.58424568 1.80611312E-02 + 2525854669.8979168 55848.730692516765 5.20002747 4.55610228 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.56552475E-02 5.57332598E-02 4.49458621E-02 5.67700304E-02 5.84612712E-02 7.92079568E-02 0.270092249 3.17135938E-02 4.56946325 1.79848969E-02 + 2517818281.1287670 56209.121195082596 5.18582058 4.54288483 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.71867330E-02 5.52434511E-02 4.46447022E-02 5.64055368E-02 5.80143519E-02 7.90131763E-02 0.269406229 3.16397883E-02 4.55631447 1.79519244E-02 + 2509781892.3596172 57052.735147126870 5.16240311 4.51700974 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.29429677E-02 5.46920374E-02 4.43050973E-02 5.60335666E-02 5.76471984E-02 7.86585733E-02 0.268370897 3.13676521E-02 4.53051758 1.78676713E-02 + 2501745503.5904675 57380.478448082133 5.15152168 4.50648546 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.50167716E-02 5.42316735E-02 4.40496393E-02 5.57953604E-02 5.72824106E-02 7.83352181E-02 0.267605156 3.12980525E-02 4.52006149 1.78459939E-02 + 2493709114.8213177 58371.725497049047 5.13524389 4.48298883 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.49644865E-02 2.53603477E-02 5.32424040E-02 4.38136607E-02 5.54642230E-02 5.68127073E-02 7.51865134E-02 0.264873862 3.10912654E-02 4.49662161 1.78127829E-02 + 2485672726.0521679 58898.329310130561 7.38223410 4.47277641 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.27473640 2.51571536E-02 5.27836978E-02 4.35945839E-02 5.52184023E-02 5.65159544E-02 7.48839825E-02 0.264018416 3.10228299E-02 4.48651886 1.77837498E-02 + 2477636337.2830181 59419.565218124444 7.35043859 4.46038818 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.25944281 2.49161385E-02 5.23413680E-02 4.32774909E-02 5.49008325E-02 5.61802313E-02 7.45479465E-02 0.263088018 3.08474787E-02 4.47313595 1.77596491E-02 + 2469599948.5138683 59686.961863414479 7.48524332 4.44965076 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.40697002 2.47445684E-02 5.20298369E-02 4.30908687E-02 5.45861274E-02 5.59357144E-02 7.42544159E-02 0.262672305 3.07615921E-02 4.46249008 1.77082401E-02 + 2461563559.7447186 60753.097639104410 7.44397974 4.42806053 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.39121103 2.44430788E-02 5.15855402E-02 4.27961424E-02 5.35054356E-02 5.55476993E-02 7.39322901E-02 0.261847049 3.05537786E-02 4.44093323 1.76245160E-02 + 2453527170.9755688 61107.229046711669 7.41050386 4.41509056 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.37338042 2.42572594E-02 5.12331687E-02 4.25884277E-02 5.32072932E-02 5.53053282E-02 7.37340003E-02 0.260727972 3.04454304E-02 4.42806005 1.75648946E-02 + 2445490782.2064190 61564.962423345671 7.38125229 4.40235329 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.04229311E-03 2.35466313 2.40624622E-02 5.08159287E-02 4.23288159E-02 5.29216975E-02 5.50066307E-02 7.34997913E-02 0.259563833 3.03908978E-02 4.41541052 1.75460391E-02 + 2437454393.4372692 61828.986477715727 7.35629463 4.39610863 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.15436181E-03 2.33585739 2.39022970E-02 5.04981242E-02 4.21264395E-02 5.27299531E-02 5.47455065E-02 7.33388811E-02 0.258781463 3.03435903E-02 4.40929365 1.75225809E-02 + 2429418004.6681194 62810.574389562520 7.32407713 4.37638235 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.74559653E-02 2.31657743 2.36365814E-02 5.00923023E-02 4.18428481E-02 5.23320772E-02 5.44518456E-02 7.28883445E-02 0.257464975 3.02130487E-02 4.38967466 1.74472108E-02 + 2421381615.8989697 63151.230783344326 7.29706049 4.36799335 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.15117317E-02 2.29835486 2.34698150E-02 4.97435592E-02 4.16045785E-02 5.20863831E-02 5.39907254E-02 7.24026412E-02 0.256812900 3.01421378E-02 4.37963915 1.73021406E-02 + 2413345227.1298199 63521.379942977066 7.28488064 4.35522461 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.34312471E-02 2.29946494 2.32716836E-02 4.93258983E-02 4.12680767E-02 5.18781394E-02 5.37170880E-02 7.21536651E-02 0.256036967 3.00458819E-02 4.36700869 1.72778312E-02 + 2405308838.3606701 63780.141404285256 7.26274824 4.34790754 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.54817307E-02 2.28434801 2.30952669E-02 4.90402021E-02 4.11475375E-02 5.17259426E-02 5.34668155E-02 7.19138682E-02 0.255517215 2.99854930E-02 4.35978985 1.72364600E-02 + 2397272449.5915203 65275.511686016951 7.23902082 4.32423544 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.45712935E-04 5.42521067E-02 2.25962806 2.29259226E-02 4.80788387E-02 4.09339666E-02 5.14820106E-02 5.30529618E-02 7.10197538E-02 0.254011661 2.98878998E-02 4.33626366 1.71382520E-02 + 2389236060.8223705 65705.253452563426 7.21862173 4.31607389 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.01185935E-02 5.39361425E-02 2.24006295 2.27763411E-02 4.77558523E-02 4.07324843E-02 5.12534119E-02 5.28124273E-02 7.08176643E-02 0.253339648 2.97542140E-02 4.32818174 1.70804523E-02 + 2381199672.0532207 66090.385619641907 7.18684959 4.30428982 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.19988099E-02 5.34112155E-02 2.22133231 2.25879159E-02 4.73642536E-02 4.04694080E-02 5.09391166E-02 5.24322130E-02 7.05206841E-02 0.252582163 2.96665672E-02 4.31652594 1.70189589E-02 + 2373163283.2840710 66319.334806399798 7.17618227 4.29859924 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.39576849E-02 5.30540012E-02 2.21631527 2.24845838E-02 4.71213870E-02 4.03146334E-02 5.06920703E-02 5.22466637E-02 7.03974813E-02 0.252014697 2.96091996E-02 4.31096458 1.70101747E-02 + 2365126894.5149212 66688.569958682448 7.15354490 4.29076672 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.66062843E-02 5.26529066E-02 2.20108151 2.23591048E-02 4.68440391E-02 4.01411802E-02 5.04555702E-02 5.20465523E-02 7.01355040E-02 0.251393169 2.95504201E-02 4.30329227 1.69863831E-02 + 2357090505.7457714 67078.434663972381 7.12901402 4.28211641 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.95315834E-02 5.21458872E-02 2.18485451 2.22030841E-02 4.65288125E-02 3.99980992E-02 5.02348281E-02 5.16886450E-02 6.97823763E-02 0.250843942 2.94937715E-02 4.29474831 1.69603266E-02 + 2349054116.9766216 67302.158994329657 7.10892105 4.27811909 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.63181408E-04 2.07212586E-02 5.17804958E-02 2.16982913 2.20764093E-02 4.62449305E-02 3.98058742E-02 5.00763692E-02 5.15842214E-02 6.95305616E-02 0.249814808 2.94679627E-02 4.29087734 1.69488173E-02 + 2341017728.2074718 68175.622916230088 7.08276844 4.26168633 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.16107538E-02 2.04277113E-02 5.14134429E-02 2.15245771 2.18897685E-02 4.59252819E-02 3.96160036E-02 4.97791693E-02 5.13258427E-02 6.93509951E-02 0.248181567 2.93164235E-02 4.27441978 1.70537774E-02 + 2332981339.4383221 68421.143935827829 7.06391859 4.25599670 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.35385320E-02 2.02508830E-02 5.11587299E-02 2.13918090 2.17561834E-02 4.56946939E-02 3.94345447E-02 4.96194065E-02 5.11515066E-02 6.91672340E-02 0.247755468 2.93124616E-02 4.26887131 1.70275494E-02 + 2324944950.6691723 68652.394903921479 7.05470943 4.24779606 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.69870888E-02 2.00998280E-02 5.08968495E-02 2.12640548 2.16538552E-02 4.54948023E-02 3.92962955E-02 4.94688973E-02 5.09352982E-02 6.90486208E-02 0.247405827 2.92912554E-02 4.26071262 1.70123857E-02 + 2316908561.9000225 69154.047364305137 7.12612104 4.23298550 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.134363264 1.98839642E-02 5.03720082E-02 2.10844016 2.14920230E-02 4.51606177E-02 3.91196273E-02 4.91156466E-02 5.06027713E-02 6.87088817E-02 0.246671245 2.92432867E-02 4.24599028 1.69576686E-02 + 2308872173.1308727 71326.567413061610 7.09517431 4.20356512 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.168354973 1.93965025E-02 4.96319346E-02 2.08023787 2.10194346E-02 4.41189483E-02 3.87432165E-02 4.88739982E-02 4.82300520E-02 6.81763887E-02 0.245633259 2.90327966E-02 4.21683788 1.68872643E-02 + 2300835784.3617229 72511.521255776839 7.06867170 4.18081808 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.186412439 1.91121940E-02 4.91354838E-02 2.06342673 2.08898261E-02 4.37667444E-02 3.86057682E-02 4.86096814E-02 4.78066504E-02 6.76434189E-02 0.243416741 2.89360937E-02 4.19408083 1.68290883E-02 + 2292799395.5925732 72689.197062979845 7.05146217 4.17643070 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.01580634E-03 0.185358644 1.89859234E-02 4.89040948E-02 2.05195475 2.07649041E-02 4.35847454E-02 3.84965613E-02 4.84888405E-02 4.77065705E-02 6.75617382E-02 0.243146956 2.88938824E-02 4.18979788 1.68006606E-02 + 2284763006.8234234 73108.599775195777 7.02582788 4.16565990 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.15274098E-03 0.183984533 1.88304503E-02 4.86280508E-02 2.03674316 2.06173640E-02 4.32970449E-02 3.82918678E-02 4.81969155E-02 4.75951582E-02 6.74248859E-02 0.242569491 2.87794303E-02 4.17900753 1.67089235E-02 + 2276726618.0542736 73367.945448803235 7.00798368 4.16003418 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.98852649E-03 0.182489306 1.87240802E-02 4.83473428E-02 2.02491117 2.04762351E-02 4.30593677E-02 3.79939638E-02 4.80779707E-02 4.73159440E-02 6.73125759E-02 0.242359608 2.87572183E-02 4.17347813 1.66922547E-02 + 2268690229.2851238 73621.762033357343 6.98814964 4.15424156 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.35846381E-03 0.181311548 1.86023694E-02 4.80845310E-02 2.01223516 2.03792285E-02 4.28831689E-02 3.78721170E-02 4.77917455E-02 4.72514480E-02 6.71633929E-02 0.242000580 2.87493095E-02 4.16781664 1.66500472E-02 + 2260653840.5159740 74045.959197974997 6.96272850 4.14225817 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.26742683E-02 0.179940179 1.84485074E-02 4.78193350E-02 1.99900150 2.02392060E-02 4.26490866E-02 3.75646651E-02 4.75637428E-02 4.70606126E-02 6.69801682E-02 0.241667047 2.86630522E-02 4.15586424 1.65930558E-02 + 2252617451.7468243 74353.425859262308 6.94150257 4.13296270 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.50508722E-02 0.178825125 1.83453970E-02 4.76159453E-02 1.98742998 2.01209635E-02 4.24739942E-02 3.74445468E-02 4.73719947E-02 4.69068587E-02 6.68676272E-02 0.241359681 2.85870116E-02 4.14653826 1.65643580E-02 + 2244581062.9776745 74526.721755745966 6.92845058 4.13085651 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.52119755E-04 1.54188890E-02 0.177589104 1.82536878E-02 4.73531447E-02 1.97787106 2.00355221E-02 4.23004031E-02 3.72795947E-02 4.72932346E-02 4.68583107E-02 6.67216852E-02 0.241130948 2.85757259E-02 4.14450073 1.65165458E-02 + 2236544674.2085247 74791.456733106650 6.91799021 4.12880087 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.82795192E-03 1.53111815E-02 0.176585540 1.81792304E-02 4.71898876E-02 1.96974599 1.99692212E-02 4.21689749E-02 3.71000431E-02 4.72363047E-02 4.67582084E-02 6.66468516E-02 0.240664825 2.85699815E-02 4.14252567 1.65103488E-02 + 2228508285.4393749 75281.917921147324 6.89788151 4.12027359 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.32444616E-03 1.51726678E-02 0.174499393 1.80459321E-02 4.69919257E-02 1.95697308 1.98659096E-02 4.19167466E-02 3.69829945E-02 4.70076203E-02 4.63322476E-02 6.64663613E-02 0.240167052 2.85123475E-02 4.13411713 1.65050346E-02 + 2220471896.6702251 75940.838175654630 6.87719774 4.10867262 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.85796153E-02 1.50574259E-02 0.173052669 1.79063492E-02 4.66193594E-02 1.94243717 1.97740663E-02 4.15921398E-02 3.68735939E-02 4.68040928E-02 4.59947847E-02 6.61688894E-02 0.238801777 2.84199603E-02 4.12266541 1.64502058E-02 + 2212435507.9010754 76176.581009531394 6.86671400 4.10572958 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.99876130E-02 1.49665866E-02 0.172320083 1.78049840E-02 4.64443453E-02 1.93539989 1.96811780E-02 4.14663404E-02 3.67822275E-02 4.66844924E-02 4.58916873E-02 6.60600960E-02 0.238639995 2.83810366E-02 4.11977386 1.64294280E-02 + 2204399119.1319256 76338.376339687384 6.85657263 4.10433531 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.12300308E-02 1.48802036E-02 0.171346545 1.77128147E-02 4.62624207E-02 1.92734873 1.96054857E-02 4.13561128E-02 3.66755426E-02 4.65923250E-02 4.58339602E-02 6.59909248E-02 0.238504633 2.83739213E-02 4.11842871 1.64302047E-02 + 2196362730.3627758 76585.453367393930 6.84218836 4.10058498 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.56009244E-04 2.24536955E-02 1.47784147E-02 0.169764906 1.75947808E-02 4.60308008E-02 1.91795039 1.95180811E-02 4.11965214E-02 3.65165286E-02 4.63249683E-02 4.57148403E-02 6.59524575E-02 0.238222957 2.83478536E-02 4.11475468 1.64104905E-02 + 2188326341.5936260 77187.839770117847 6.82774925 4.08865643 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.74809545E-02 2.22746115E-02 1.45632792E-02 0.168636277 1.74818505E-02 4.53378819E-02 1.90353799 1.93526465E-02 4.09662463E-02 3.56312282E-02 4.61061038E-02 4.55428287E-02 6.57321960E-02 0.237583071 2.82812640E-02 4.10289335 1.63472388E-02 + 2180289952.8244762 77580.900633307479 6.82786226 4.08022451 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.84697840E-02 2.21193396E-02 1.44733721E-02 0.167523623 1.74066462E-02 4.51494716E-02 1.89365113 1.92783941E-02 4.07117903E-02 3.55491750E-02 4.60511856E-02 4.54767011E-02 6.56041577E-02 0.237280697 2.82591395E-02 4.09452677 1.63313504E-02 + 2172253564.0553265 77836.226105888054 6.80952311 4.07336187 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.99820097E-02 2.19200049E-02 1.43694095E-02 0.166326076 1.73111279E-02 4.49475087E-02 1.88343978 1.91831719E-02 4.05087695E-02 3.54027487E-02 4.59261313E-02 4.53780778E-02 6.54603764E-02 0.237113550 2.82148570E-02 4.08773613 1.63034406E-02 + 2164217175.2861767 78719.037937210174 6.79743910 4.05934715 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.71604446E-02 2.17331443E-02 1.42157059E-02 0.165067673 1.70936398E-02 4.47195992E-02 1.87190306 1.90957524E-02 4.03590612E-02 3.51827666E-02 4.57338281E-02 4.51569818E-02 6.51464462E-02 0.236697748 2.81249080E-02 4.07377100 1.62776355E-02 + 2156180786.5170269 79578.707866273995 6.78295326 4.04869747 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.90463558E-02 2.15157587E-02 1.41141862E-02 0.163410187 1.69999823E-02 4.44946848E-02 1.85992479 1.90233998E-02 3.99941541E-02 3.50611918E-02 4.55309488E-02 4.49696071E-02 6.50173649E-02 0.236384079 2.80909948E-02 4.06315565 1.62195805E-02 + 2148144397.7478771 79886.367546914887 6.76990461 4.04321289 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.11105585E-04 7.35406354E-02 2.13535652E-02 1.40083870E-02 0.161910504 1.68790333E-02 4.42751981E-02 1.85063303 1.89439841E-02 3.98520865E-02 3.49561349E-02 4.54424098E-02 4.49398570E-02 6.49182200E-02 0.235645801 2.80212201E-02 4.05776834 1.62051357E-02 + 2140108008.9798214 80226.257775435268 6.75578070 4.03804159 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.93832342E-03 7.29767680E-02 2.11982131E-02 1.58505104E-02 0.160662293 1.67884044E-02 4.40358967E-02 1.84061861 1.88447889E-02 3.96578126E-02 3.48449126E-02 4.52699251E-02 4.48723324E-02 6.48106486E-02 0.235527858 2.79974416E-02 4.05268621 1.61993802E-02 + 2132071620.2118638 80895.976447117864 6.73476744 4.02611303 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.72448646E-03 7.22738951E-02 2.09162068E-02 1.57545600E-02 0.159345835 1.66457444E-02 4.37114388E-02 1.83060479 1.87673215E-02 3.94154228E-02 3.47277783E-02 4.49840687E-02 4.46960479E-02 6.46575615E-02 0.234646320 2.79522631E-02 4.04083824 1.61056258E-02 + 2124035231.4439061 81127.218785504447 6.72544670 4.02258539 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.02063678E-02 7.18562827E-02 2.08150279E-02 1.56850591E-02 0.158743784 1.65693257E-02 4.35784385E-02 1.82537079 1.87109839E-02 3.93384323E-02 3.46493050E-02 4.49399725E-02 4.46436219E-02 6.46321028E-02 0.234407753 2.79206373E-02 4.03729486 1.60836894E-02 + 2115998842.6759484 81344.826301259818 6.71577358 4.02153683 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.14831096E-02 7.14589953E-02 2.06886251E-02 1.61762368E-02 0.157787129 1.64938942E-02 4.33985591E-02 1.81760967 1.86462384E-02 3.92113291E-02 3.45583037E-02 4.48306762E-02 4.45683450E-02 6.45313039E-02 0.234050065 2.78636888E-02 4.03633690 1.60806216E-02 + 2107962453.9079907 81657.933350436229 6.70339489 4.01911306 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.36719123E-02 7.09757134E-02 2.05291472E-02 1.60416905E-02 0.156826600 1.64020676E-02 4.31342870E-02 1.80840528 1.85616240E-02 3.90959159E-02 3.43562402E-02 4.47889268E-02 4.45674174E-02 6.44291267E-02 0.233768776 2.78450735E-02 4.03394604 1.60494130E-02 + 2099926065.1400330 82240.394345454813 6.68795061 4.00884056 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.26883059E-06 2.23601721E-02 7.04423115E-02 2.04229075E-02 1.59511734E-02 0.155245274 1.63095053E-02 4.28582840E-02 1.79861450 1.84832904E-02 3.88271138E-02 3.42778862E-02 4.46753018E-02 4.40165177E-02 6.43309951E-02 0.233616456 2.77831554E-02 4.02369595 1.60343982E-02 + 2091889676.3720753 82477.254192287757 6.67619038 4.00441122 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.06064060E-03 2.21970696E-02 7.00172856E-02 2.03106571E-02 1.58155188E-02 0.154628977 1.61976013E-02 4.27242927E-02 1.79171646 1.84103046E-02 3.87291275E-02 3.42208669E-02 4.46035974E-02 4.39831764E-02 6.42439201E-02 0.233311683 2.77156774E-02 4.01931572 1.59872752E-02 + 2083853287.6041176 82648.387690243471 6.66822815 4.00271225 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.25403968E-03 2.20524333E-02 6.95675537E-02 2.02152152E-02 1.57448463E-02 0.153968811 1.61336474E-02 4.25902158E-02 1.78607082 1.83833186E-02 3.86444032E-02 3.41021493E-02 4.45836931E-02 4.39660549E-02 6.41679466E-02 0.233400285 2.77245175E-02 4.01767588 1.59822889E-02 + 2075816898.8361599 82948.438468366512 6.65622902 3.99895430 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.50863333E-03 2.19121259E-02 6.90055415E-02 2.00693887E-02 1.56396534E-02 0.153122544 1.60584096E-02 4.23971042E-02 1.77841902 1.83262229E-02 3.85044850E-02 3.40383425E-02 4.44608182E-02 4.39292602E-02 6.40988797E-02 0.233065173 2.76937392E-02 4.01400328 1.59765836E-02 + 2067780510.0682023 83206.345587092539 6.64362097 3.99415970 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.27123784E-03 2.17726119E-02 6.85194731E-02 1.98058132E-02 1.55707998E-02 0.152489737 1.60000585E-02 4.23158668E-02 1.77035916 1.82556380E-02 3.83821726E-02 3.39667313E-02 4.43267673E-02 4.38951291E-02 6.39672652E-02 0.232770786 2.76718624E-02 4.00932693 1.59531869E-02 + 2059744121.3002446 83706.745695654448 6.62981033 3.98735166 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.26433549E-02 2.14400627E-02 6.80763423E-02 1.96724590E-02 1.54912351E-02 0.151400730 1.59220975E-02 4.20991704E-02 1.76259327 1.81903522E-02 3.81400436E-02 3.39060463E-02 4.42497805E-02 4.36118953E-02 6.38637021E-02 0.232339397 2.76255328E-02 4.00261402 1.59307588E-02 + 2051707732.5322869 83893.361134252045 6.61971617 3.98461008 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.38281398E-02 2.13132054E-02 6.76209182E-02 1.95813347E-02 1.53784109E-02 0.150707558 1.58444159E-02 4.19762656E-02 1.75624645 1.81308258E-02 3.80621217E-02 3.38292718E-02 4.41179499E-02 4.35331874E-02 6.37459829E-02 0.232355252 2.76116543E-02 3.99991560 1.59176644E-02 + 2043671343.7643292 84151.341431765308 6.62358999 3.98245311 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.80422322E-03 2.56168097E-02 2.11173333E-02 6.71511143E-02 1.93617046E-02 1.53185353E-02 0.150214896 1.57814287E-02 4.18644026E-02 1.75006568 1.80513468E-02 3.79745513E-02 3.37518714E-02 4.40644845E-02 4.34847474E-02 6.36667162E-02 0.232009128 2.75691655E-02 3.99779892 1.59232337E-02 + 2035634954.9963715 84525.302206800363 6.99157190 4.35880804 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.388606906 2.54014451E-02 2.09871642E-02 6.67355061E-02 1.92208663E-02 1.52443238E-02 0.149376303 1.57168694E-02 4.17421386E-02 1.73989785 1.79757662E-02 3.77996266E-02 3.36859487E-02 4.39425558E-02 4.33631726E-02 6.34046718E-02 0.231467605 2.75137164E-02 3.99356556 1.59238949E-02 + 2027598566.2284138 84901.149347210245 6.99818897 4.34873199 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.410771132 2.52134614E-02 2.08509229E-02 6.62941113E-02 1.91261005E-02 1.51847033E-02 0.148935094 1.56617928E-02 4.16204333E-02 1.73416245 1.78982839E-02 3.77308875E-02 3.35240811E-02 4.38317917E-02 4.33057398E-02 6.33443668E-02 0.230856389 2.74708997E-02 3.98648572 1.59208775E-02 + 2019562177.4604561 85324.799249223885 6.97845554 4.33819437 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.410319597 2.49756295E-02 2.06960645E-02 6.57774583E-02 1.88448615E-02 1.51080079E-02 0.147874892 1.55516211E-02 4.14731018E-02 1.72664273 1.77911725E-02 3.75821516E-02 3.34223919E-02 4.36779819E-02 4.31324616E-02 6.32498041E-02 0.229374260 2.74238903E-02 3.97961664 1.59204211E-02 + 2011525788.6924984 85718.952898754680 6.96136999 4.32774687 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.410797745 2.47458778E-02 2.05713008E-02 6.54036477E-02 1.87386163E-02 1.50355268E-02 0.147271290 1.54678803E-02 4.13946956E-02 1.71911132 1.77213326E-02 3.74753699E-02 3.33265103E-02 4.33245189E-02 4.31201756E-02 6.31397590E-02 0.229191989 2.73989048E-02 3.97228217 1.58513989E-02 + 2003489399.9245408 85952.275523463031 6.95762873 4.32345867 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.415421814 2.45993938E-02 2.04421822E-02 6.49248138E-02 1.86661836E-02 1.49764214E-02 0.147986263 1.56682823E-02 4.13373038E-02 1.71229064 1.76617745E-02 3.73941027E-02 3.31695676E-02 4.32362854E-02 4.30890992E-02 6.30657598E-02 0.229616925 2.73798425E-02 3.97084451 1.58578046E-02 + 1995453011.1565831 86290.321743456778 6.94239044 4.31457710 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.12184386E-03 0.412952781 2.44373586E-02 2.03260425E-02 6.45834804E-02 1.85565092E-02 1.49313966E-02 0.147486687 1.56102544E-02 4.12098393E-02 1.70532095 1.76336840E-02 3.72640602E-02 3.31327356E-02 4.31702398E-02 4.30148803E-02 6.29861355E-02 0.229361728 2.73098312E-02 3.96515059 1.58291329E-02 + 1987416622.3886254 86609.274047743849 6.92749023 4.30604219 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.44429927E-03 0.409714431 2.42274720E-02 2.01967210E-02 6.40883818E-02 1.84670519E-02 1.48691013E-02 0.146995038 1.55697037E-02 4.11129408E-02 1.69935536 1.75795071E-02 3.72041166E-02 3.30404751E-02 4.31221575E-02 4.29819152E-02 6.29487336E-02 0.229052037 2.72759181E-02 3.95943141 1.58137660E-02 + 1979380233.6206677 87035.080873016908 6.91713142 4.29679489 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.36515163E-02 0.405870527 2.39996463E-02 2.00176686E-02 6.36151731E-02 1.83697212E-02 1.47799207E-02 0.146194726 1.55055178E-02 4.09827158E-02 1.69248819 1.75270643E-02 3.70895565E-02 3.30037177E-02 4.30089086E-02 4.29736935E-02 6.27900809E-02 0.228665799 2.71949787E-02 3.95360661 1.57957729E-02 + 1971343844.8527100 87709.554884307945 6.89699030 4.28098249 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.85281446E-02 0.402183115 2.37461478E-02 1.98464524E-02 6.31662235E-02 1.82178561E-02 1.46846669E-02 0.145375177 1.54122720E-02 4.06927839E-02 1.68058288 1.74008217E-02 3.68521139E-02 3.29349004E-02 4.28670086E-02 4.26901504E-02 6.25535026E-02 0.225352481 2.70497613E-02 3.94107985 1.57742072E-02 + 1963307456.0847523 88167.328841460214 6.87746000 4.26771307 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.36113833E-02 0.398328602 2.34987345E-02 1.97370350E-02 6.27403557E-02 1.81135777E-02 1.44724101E-02 0.144870743 1.53550962E-02 4.05545793E-02 1.67259121 1.73127539E-02 3.67469229E-02 3.28324959E-02 4.27161492E-02 4.26082201E-02 6.24561310E-02 0.225096077 2.69524958E-02 3.93112230 1.57428868E-02 + 1955271067.3167946 88452.282807880634 6.93914270 4.26132822 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.108939484 0.395300806 2.33162642E-02 1.96169391E-02 6.23669550E-02 1.80349462E-02 1.43935531E-02 0.145591080 1.53032364E-02 4.04372923E-02 1.66622949 1.72731187E-02 3.66595387E-02 3.27589549E-02 4.27247398E-02 4.25493605E-02 6.24367930E-02 0.225027993 2.68990751E-02 3.92755294 1.57297347E-02 + 1947234678.5488369 88647.520726817107 6.93093967 4.25861931 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.12881049E-04 0.108884864 0.392314166 2.31536739E-02 1.94819327E-02 6.19877949E-02 1.79543942E-02 1.43358270E-02 0.145042971 1.52587490E-02 4.03362662E-02 1.66215181 1.72069818E-02 3.65660526E-02 3.26875150E-02 4.26874198E-02 4.25205193E-02 6.23961911E-02 0.224902213 2.68869903E-02 3.92753315 1.57374498E-02 + 1939198289.7808793 89159.754715461080 6.91753387 4.25006247 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.50705786E-03 0.107929319 0.388999194 2.29751561E-02 1.93377212E-02 6.15803227E-02 1.78666823E-02 1.42645659E-02 0.144364759 1.51895201E-02 4.01886441E-02 1.65497732 1.71489399E-02 3.64709757E-02 3.26023810E-02 4.24056947E-02 4.23619896E-02 6.23430386E-02 0.224658057 2.68163588E-02 3.92181683 1.57300830E-02 + 1931161901.0129216 89365.109181694104 6.91392899 4.24568462 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.48886265E-02 0.107012302 0.386295319 2.27900036E-02 1.92238484E-02 6.13332056E-02 1.77869201E-02 1.42181674E-02 0.143945515 1.51621019E-02 4.00942117E-02 1.65111744 1.71165504E-02 3.64365801E-02 3.25547680E-02 4.23914678E-02 4.23258133E-02 6.22984543E-02 0.224549264 2.68119723E-02 3.91985321 1.57234650E-02 + 1923125512.2449639 90049.464954062394 6.89416409 4.23104095 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.36931723E-02 0.105968356 0.382144451 2.25646291E-02 1.90874822E-02 6.09721504E-02 1.76104978E-02 1.41011784E-02 0.143227160 1.51025029E-02 3.99500281E-02 1.64210272 1.70396287E-02 3.62425037E-02 3.24704275E-02 4.23313417E-02 4.21409905E-02 6.21383451E-02 0.224051297 2.66841296E-02 3.90885091 1.56901088E-02 + 1915089123.4770062 150008.12752568827 14.1661768 3.90710497 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.82608557 0.102601305 0.341391087 2.03116480E-02 1.81867555E-02 5.24995923E-02 1.69683397E-02 1.34295151E-02 0.137840569 1.42267896E-02 3.86216603E-02 1.48843956 1.56882312E-02 3.56615633E-02 3.11289635E-02 3.90014872E-02 3.84935103E-02 5.93436174E-02 0.219822034 2.40027960E-02 3.61734557 1.50865316E-02 + 1907052734.7090485 150331.01148211921 14.1278696 3.90592980 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.79242039 0.102245815 0.340712011 2.02839896E-02 1.81373451E-02 5.23692071E-02 1.69364717E-02 1.34121990E-02 0.137496278 1.41995586E-02 3.85836735E-02 1.48621213 1.56685989E-02 3.55980471E-02 3.11141461E-02 3.89957465E-02 3.85044999E-02 5.93748875E-02 0.219699636 2.39926353E-02 3.61681414 1.50994379E-02 + 1899016345.9410908 150878.95214962031 14.1019945 3.89980555 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.55335772E-04 7.77552080 0.101870842 0.339839429 2.02016681E-02 1.81206521E-02 5.22694550E-02 1.69354510E-02 1.33918040E-02 0.137361661 1.41973170E-02 3.85610536E-02 1.48444963 1.56580675E-02 3.55428420E-02 3.10934205E-02 3.89800034E-02 3.84658426E-02 5.92715144E-02 0.219579637 2.39615701E-02 3.61154723 1.50203612E-02 + 1890979957.1731331 151096.78442063852 14.0836401 3.90063787 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.06429814E-03 7.75494623 0.101649493 0.339495689 2.01737303E-02 1.80664044E-02 5.22436760E-02 1.69242304E-02 1.33880451E-02 0.137132734 1.41978981E-02 3.84698510E-02 1.48442161 1.56560484E-02 3.55167389E-02 3.11031844E-02 3.90023589E-02 3.84511948E-02 5.92801683E-02 0.219710305 2.39657182E-02 3.61275029 1.50301214E-02 + 1882943568.4051754 151336.48386157522 14.0596523 3.89884615 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.92365502E-03 7.73226404 0.101277009 0.339049399 2.01568585E-02 1.80489402E-02 5.22225872E-02 1.68992002E-02 1.33808693E-02 0.137132749 1.42015191E-02 3.84452753E-02 1.48355579 1.56471059E-02 3.54943015E-02 3.11005507E-02 3.90024111E-02 3.84624861E-02 5.92922755E-02 0.219757617 2.39383653E-02 3.61138630 1.50134414E-02 + 1874907179.6372178 151580.20679094549 14.0424938 3.89876151 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.06106937E-03 7.71212721 0.101096012 0.338781506 2.01469418E-02 1.80292185E-02 5.21929897E-02 1.68878864E-02 1.33814830E-02 0.137068823 1.42165031E-02 3.84531207E-02 1.48388600 1.56430677E-02 3.54809538E-02 3.10939439E-02 3.90117504E-02 3.84441465E-02 5.92851117E-02 0.219702408 2.39427984E-02 3.61154032 1.50205018E-02 + 1866870790.8692601 151751.11644284677 14.0284195 3.90014696 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.66097694E-03 7.69474745 0.101010092 0.338643938 2.01401357E-02 1.80403385E-02 5.22107035E-02 1.68818925E-02 1.33757442E-02 0.137041926 1.42209502E-02 3.84454988E-02 1.48321271 1.56458113E-02 3.54899988E-02 3.11214272E-02 3.90135460E-02 3.84403206E-02 5.92979454E-02 0.219763502 2.39371192E-02 3.61305714 1.50195640E-02 + 1858834402.1013024 151956.60282777174 14.0156488 3.90659475 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.52807320E-02 7.67387199 0.100746550 0.338167518 2.01154258E-02 1.80318467E-02 5.21973968E-02 1.68811679E-02 1.33718746E-02 0.137054563 1.42039219E-02 3.84039581E-02 1.48380399 1.56616699E-02 3.54998186E-02 3.11565343E-02 3.90112475E-02 3.84486504E-02 5.93267307E-02 0.219804585 2.39441488E-02 3.61563230 1.50336036E-02 + 1850798013.3333447 153304.47281969423 13.9841824 3.89665246 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.50704135E-02 7.63378906 0.100424424 0.337752253 2.00771354E-02 1.79861113E-02 5.20798452E-02 1.68409329E-02 1.33017329E-02 0.136942655 1.41954077E-02 3.82886678E-02 1.47579193 1.55742606E-02 3.52686606E-02 2.94627603E-02 3.90145332E-02 3.84000018E-02 5.93153164E-02 0.219481036 2.38935333E-02 3.60621524 1.50143430E-02 + 1842761624.5653870 153485.21907758727 13.9679327 3.89866400 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.13312497E-03 4.48930971E-02 7.61294985 0.100214399 0.337427318 2.00374983E-02 1.79622900E-02 5.20320907E-02 1.68289095E-02 1.32917929E-02 0.136792064 1.42022585E-02 3.82409059E-02 1.47662914 1.55981891E-02 3.52891162E-02 2.94973068E-02 3.90458517E-02 3.84847112E-02 5.93487285E-02 0.219560444 2.39136070E-02 3.60855627 1.50041161E-02 + 1834725235.7974293 153722.91241281066 13.9523754 3.89965153 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.29264270E-03 4.45337854E-02 7.59470797 0.100096181 0.337304980 2.00128295E-02 1.79490205E-02 5.20321429E-02 1.68248899E-02 1.32888993E-02 0.136740759 1.42053459E-02 3.82203087E-02 1.47643816 1.55996475E-02 3.53059061E-02 2.95004938E-02 3.90465111E-02 3.84810194E-02 5.93631603E-02 0.219811901 2.39188243E-02 3.60968685 1.50135793E-02 + 1826688847.0294716 153983.62942342032 13.9306450 3.89719558 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.72573473E-03 4.42110822E-02 7.57343197 0.100007698 0.336989760 1.99945793E-02 1.79309081E-02 5.19883223E-02 1.68150254E-02 1.32871373E-02 0.136667743 1.41924676E-02 3.82121876E-02 1.47553658 1.55839762E-02 3.52969952E-02 2.94663906E-02 3.90604995E-02 3.85360830E-02 5.93981668E-02 0.219877347 2.39038263E-02 3.60753965 1.49897207E-02 + 1818652458.2615139 154136.53626348099 13.9193897 3.89933467 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.05455463E-03 4.39373255E-02 7.55853271 9.98646021E-02 0.336783141 1.99862439E-02 1.79165192E-02 5.19747436E-02 1.68221239E-02 1.32852262E-02 0.136657432 1.41949113E-02 3.82124819E-02 1.47595799 1.55893723E-02 3.53221633E-02 2.94875484E-02 3.90722007E-02 3.85740958E-02 5.93992621E-02 0.219905868 2.39178278E-02 3.60993385 1.50068160E-02 + 1810616069.4935563 154486.17094087662 13.9023733 3.90007114 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.61878187E-02 4.35389504E-02 7.53525591 9.95740071E-02 0.336241305 1.99601781E-02 1.79072116E-02 5.19525073E-02 1.68062914E-02 1.32724112E-02 0.136681139 1.42102530E-02 3.82039919E-02 1.47523558 1.55905364E-02 3.52992602E-02 2.94756386E-02 3.90553102E-02 3.85644510E-02 5.94749339E-02 0.219767019 2.39222236E-02 3.61118436 1.50122270E-02 + 1802579680.7255986 154643.41493399115 13.8919191 3.90220308 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.77316256E-02 4.32806052E-02 7.52119684 9.94246304E-02 0.335800827 1.99356209E-02 1.78579353E-02 5.19361012E-02 1.68099329E-02 1.32672014E-02 0.136627063 1.42182019E-02 3.82186621E-02 1.47549868 1.55920070E-02 3.53051908E-02 2.94812769E-02 3.90688851E-02 3.85800563E-02 5.94858341E-02 0.219852000 2.39487998E-02 3.61378503 1.50173800E-02 + 1794543291.9576409 155203.88326026133 13.8715258 3.89781928 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.42915494E-04 2.64166798E-02 4.29589897E-02 7.49716282 9.92183760E-02 0.334724277 1.98520925E-02 1.77663360E-02 5.18851355E-02 1.67468246E-02 1.32588893E-02 0.136529416 1.41289383E-02 3.80795300E-02 1.47592211 1.55419530E-02 3.53121758E-02 2.94600222E-02 3.90547700E-02 3.85367423E-02 5.94292805E-02 0.219486624 2.38950532E-02 3.61040545 1.50136100E-02 + 1786506903.1896832 155424.78766243462 13.8562202 3.89685464 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.12497537E-03 2.62411144E-02 4.26347144E-02 7.48177004 9.91007537E-02 0.334629089 1.98354479E-02 1.77436620E-02 5.18907271E-02 1.67454612E-02 1.32479761E-02 0.136538640 1.41270366E-02 3.80766876E-02 1.47523260 1.55410152E-02 3.53004187E-02 2.94720512E-02 3.90779264E-02 3.85035500E-02 5.94412386E-02 0.219454452 2.38959435E-02 3.60958242 1.50105441E-02 + 1778470514.4217255 155769.83334930424 13.8312979 3.89226890 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.38227973E-03 2.60399953E-02 4.23299298E-02 7.46185446 9.86731574E-02 0.333831638 1.97931100E-02 1.76868159E-02 5.17845862E-02 1.67436060E-02 1.32337548E-02 0.136393115 1.41169364E-02 3.80230434E-02 1.47290826 1.55170346E-02 3.52329873E-02 2.94447839E-02 3.90542299E-02 3.83200906E-02 5.93752600E-02 0.219078928 2.37205084E-02 3.60574555 1.50134405E-02 + 1770434125.6537678 156141.39504654307 13.8144188 3.89621401 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.69837791E-02 2.57862136E-02 4.20554131E-02 7.44004154 9.83989760E-02 0.333140403 1.97315011E-02 1.76652521E-02 5.16173765E-02 1.67294648E-02 1.32307643E-02 0.135857135 1.41115906E-02 3.77337858E-02 1.47212756 1.55235790E-02 3.51109765E-02 2.94464082E-02 3.90467830E-02 3.83215770E-02 5.92765696E-02 0.219047755 2.37010121E-02 3.60472918 1.50032993E-02 + 1762397736.8858101 156407.71227301165 13.8011484 3.89427233 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.94138326E-02 2.56199706E-02 4.18389477E-02 7.42807627 9.82355475E-02 0.332728654 1.97359584E-02 1.77235864E-02 5.16118892E-02 1.67241395E-02 1.32240625E-02 0.135886982 1.41136469E-02 3.77173051E-02 1.47091305 1.55276330E-02 3.51013206E-02 2.94496417E-02 3.90442871E-02 3.83145884E-02 5.92680946E-02 0.218995288 2.36538034E-02 3.60325742 1.49732670E-02 + 1754361348.1178524 156655.07084195313 13.7788601 3.89318895 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.23859660E-02 2.54680626E-02 4.16064821E-02 7.40511131 9.80028138E-02 0.332268059 1.96841974E-02 1.77146178E-02 5.15359193E-02 1.67158227E-02 1.32255331E-02 0.135822579 1.41116912E-02 3.77229005E-02 1.47080469 1.55285550E-02 3.50644551E-02 2.94551607E-02 3.90473418E-02 3.82472910E-02 5.92971668E-02 0.218783796 2.36332435E-02 3.60264516 1.49769820E-02 + 1746324959.3498948 157015.54566207292 15.7354555 3.89421105 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.10306102E-04 1.99898911 2.52269264E-02 4.13530320E-02 7.38455963 9.79224220E-02 0.332168102 1.96834281E-02 1.77122857E-02 5.15188575E-02 1.67103726E-02 1.32267028E-02 0.135893315 1.41184321E-02 3.77253890E-02 1.47005510 1.55186281E-02 3.50497961E-02 2.94632800E-02 3.90612744E-02 3.82597968E-02 5.93191683E-02 0.218861341 2.36390829E-02 3.60382986 1.49813164E-02 + 1738288570.5819371 157309.41031702689 15.6959057 3.89465356 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.02167446E-02 1.98099697 2.50549410E-02 4.10454497E-02 7.35505056 9.77321118E-02 0.331779659 1.96408704E-02 1.76708419E-02 5.14732115E-02 1.66899022E-02 1.32120168E-02 0.135787457 1.41155785E-02 3.77369970E-02 1.46896338 1.55122774E-02 3.50344032E-02 2.94342767E-02 3.90896574E-02 3.82379964E-02 5.93176521E-02 0.218822852 2.36449074E-02 3.60466671 1.49796987E-02 + 1730252181.8139794 157448.59076785500 15.6707811 3.89549708 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.28416084E-02 1.96616995 2.48750634E-02 4.08280566E-02 7.34088564 9.76122320E-02 0.331510633 1.96247324E-02 1.76686458E-02 5.14861010E-02 1.66893676E-02 1.32063748E-02 0.135808572 1.41153038E-02 3.77189405E-02 1.46974087 1.55097013E-02 3.50556858E-02 2.94588339E-02 3.91119085E-02 3.82820219E-02 5.93427047E-02 0.218821049 2.36439370E-02 3.60578752 1.49846086E-02 + 1722215793.0460217 157644.22594343562 15.6429195 3.89537597 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.50569100E-02 1.95131636 2.47488599E-02 4.05350477E-02 7.32662487 9.74992514E-02 0.331427604 1.96085069E-02 1.76589340E-02 5.14720865E-02 1.66923590E-02 1.31945862E-02 0.135817468 1.41112125E-02 3.77010405E-02 1.46940792 1.55064613E-02 3.50211896E-02 2.94520129E-02 3.91161889E-02 3.82940620E-02 5.93391955E-02 0.218867794 2.36534588E-02 3.60581708 1.49792545E-02 + 1714179404.2780640 157891.40631959197 15.6060543 3.89234591 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.70477610E-02 1.93569875 2.45636050E-02 4.03410569E-02 7.30911398 9.71975923E-02 0.330691040 1.95700191E-02 1.76018011E-02 5.14438897E-02 1.66670345E-02 1.31904231E-02 0.135627821 1.41065503E-02 3.77088897E-02 1.46791375 1.55046200E-02 3.49788144E-02 2.94348150E-02 3.91149856E-02 3.82832885E-02 5.93579859E-02 0.218701541 2.36411374E-02 3.60357976 1.49712916E-02 + 1706143015.5101063 158084.91611573374 15.5966892 3.89298582 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.24942358E-02 1.92183912 2.44206861E-02 4.00704220E-02 7.29718161 9.70250815E-02 0.330573916 1.95556954E-02 1.75867621E-02 5.14240898E-02 1.66481398E-02 1.31881107E-02 0.135681003 1.41146211E-02 3.77413109E-02 1.46860397 1.55097907E-02 3.49933952E-02 2.94187851E-02 3.91545594E-02 3.83181386E-02 5.93802035E-02 0.218766645 2.36354824E-02 3.60438800 1.49742169E-02 + 1698106626.7421486 158234.90632782225 15.5743761 3.89356256 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.81457886E-04 3.29518951E-02 1.90871739 2.42908522E-02 3.98838855E-02 7.28682518 9.68520567E-02 0.330235362 1.95434690E-02 1.75754838E-02 5.13935462E-02 1.66421346E-02 1.31899454E-02 0.135672912 1.41112171E-02 3.76847312E-02 1.46889079 1.55120408E-02 3.49762775E-02 2.94221248E-02 3.91642936E-02 3.83203290E-02 5.93596362E-02 0.218726337 2.36446839E-02 3.60532975 1.49777364E-02 + 1690070237.9741910 158535.19348490675 15.5390329 3.89116311 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.22749303E-03 3.27101462E-02 1.89185345 2.41368376E-02 3.96676622E-02 7.26944160 9.63224694E-02 0.329876423 1.95154976E-02 1.75745077E-02 5.13519496E-02 1.66270956E-02 1.31823216E-02 0.135395691 1.41179506E-02 3.76393758E-02 1.46954477 1.55174509E-02 3.49896885E-02 2.94068158E-02 3.90978307E-02 3.83428931E-02 5.89923896E-02 0.218557045 2.36521792E-02 3.60331941 1.49745438E-02 + 1682033849.2062333 159747.58604595243 15.4761219 3.87413216 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.38026099E-02 3.23094502E-02 1.87087762 2.37794109E-02 3.93368341E-02 7.22201347 9.59957317E-02 0.327519089 1.94688495E-02 1.74590517E-02 5.11729829E-02 1.65505130E-02 1.31464610E-02 0.134529978 1.39608551E-02 3.68487723E-02 1.46721888 1.54778147E-02 3.49274948E-02 2.93771774E-02 3.89908068E-02 3.82643268E-02 5.88579141E-02 0.217259511 2.35928223E-02 3.58844686 1.49362832E-02 + 1673997460.4382756 159909.90047238124 15.4517183 3.87489581 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.47656384E-02 3.20095457E-02 1.85605013 2.36318018E-02 3.90986465E-02 7.21061039 9.59641039E-02 0.327470779 1.94579754E-02 1.74753256E-02 5.11745773E-02 1.65314451E-02 1.31517015E-02 0.134569511 1.39721120E-02 3.68690602E-02 1.46767557 1.54814143E-02 3.49398702E-02 2.93839909E-02 3.90057638E-02 3.82768251E-02 5.88964932E-02 0.217345268 2.36033127E-02 3.58936930 1.49394237E-02 + 1665961071.6703179 160135.22967255412 15.4264326 3.87373447 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.72844301E-02 3.17716599E-02 1.84242666 2.34941989E-02 3.88495326E-02 7.19893312 9.58234966E-02 0.327187538 1.94344874E-02 1.74651872E-02 5.11879139E-02 1.65405590E-02 1.31391771E-02 0.134634227 1.39573878E-02 3.68686095E-02 1.46707547 1.54481083E-02 3.49188298E-02 2.93331705E-02 3.90055887E-02 3.82657312E-02 5.89013249E-02 0.217365816 2.36137360E-02 3.58855104 1.49545977E-02 + 1657924682.9023602 160388.73808849126 15.4007235 3.87212038 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.05508801E-02 3.15484330E-02 1.82672930 2.33394485E-02 3.86665761E-02 7.18707418 9.55904797E-02 0.326637894 1.93884615E-02 1.74551122E-02 5.11474647E-02 1.65380742E-02 1.36439772E-02 0.134581506 1.39635168E-02 3.68757434E-02 1.46766949 1.54526932E-02 3.49153318E-02 2.93320436E-02 3.89990732E-02 3.82986777E-02 5.89122996E-02 0.217315331 2.36113183E-02 3.58754492 1.49416430E-02 + 1649888294.1344025 160664.48932138781 15.3727942 3.87103391 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.41316774E-06 4.24514450E-02 3.12518030E-02 1.81308353 2.31954549E-02 3.84689048E-02 7.17444944 9.52947512E-02 0.326103836 1.93552300E-02 1.74343623E-02 5.11244349E-02 1.65206827E-02 1.36231724E-02 0.134549633 1.39582967E-02 3.68759334E-02 1.46649075 1.54357050E-02 3.48805711E-02 2.93161850E-02 3.89905795E-02 3.82855311E-02 5.89195788E-02 0.217171118 2.36003045E-02 3.58700681 1.49500621E-02 + 1641851905.3664448 160987.08356587050 15.3676243 3.88921380 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.08523571E-02 4.21269871E-02 3.10222711E-02 1.79860938 2.30413694E-02 3.82610112E-02 7.16294336 9.52005982E-02 0.325845838 1.93316247E-02 1.74348354E-02 5.11015318E-02 1.65129807E-02 1.36187058E-02 0.134521529 1.39623582E-02 3.68775465E-02 1.46700382 1.54354917E-02 3.48840654E-02 2.93165036E-02 3.89913581E-02 3.82906161E-02 5.89392819E-02 0.217250794 2.36031916E-02 3.58768535 1.49584813E-02 + 1633815516.5984871 161179.53847277464 15.3387575 3.88915658 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.51708385E-02 4.18614410E-02 3.07956170E-02 1.78461766 2.29008663E-02 3.80205810E-02 7.14530706 9.51034650E-02 0.325644374 1.92974582E-02 1.73975397E-02 5.10512590E-02 1.64932087E-02 1.36092128E-02 0.134409934 1.39587335E-02 3.68790366E-02 1.46650612 1.54270222E-02 3.48555073E-02 2.93115750E-02 3.90007347E-02 3.82087752E-02 5.89654185E-02 0.217369825 2.35973261E-02 3.58804655 1.49507225E-02 + 1625779127.8305295 161355.31154419016 15.3165045 3.88959956 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.78379004E-02 4.16249372E-02 3.05761863E-02 1.77209163 2.27721632E-02 3.78537774E-02 7.13320017 9.50057879E-02 0.325507313 1.92936230E-02 1.73869189E-02 5.10051586E-02 1.64940991E-02 1.35017866E-02 0.134340942 1.39503209E-02 3.68677601E-02 1.46658576 1.54286688E-02 3.48714292E-02 2.93308366E-02 3.90067771E-02 3.82118970E-02 5.89606315E-02 0.217414692 2.36009434E-02 3.58882236 1.49570350E-02 + 1617742739.0625718 161574.96240225917 15.2928982 3.88881755 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.97044814E-02 4.13469635E-02 3.03644240E-02 1.75902355 2.26166919E-02 3.75628173E-02 7.12252140 9.48768407E-02 0.325327933 1.92892049E-02 1.73726454E-02 5.10129519E-02 1.64983217E-02 1.34903602E-02 0.134345621 1.39477048E-02 3.68573219E-02 1.46650934 1.54230986E-02 3.48714218E-02 2.93356348E-02 3.89963649E-02 3.82346027E-02 5.89253940E-02 0.217496127 2.35617738E-02 3.58840561 1.49780475E-02 + 1609706350.2946141 161790.72486183583 15.3211956 3.94190359 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.55056345E-02 4.10360992E-02 3.01547088E-02 1.74478102 2.24483497E-02 3.74114662E-02 7.11024046 9.47427601E-02 0.325103134 1.92772988E-02 1.73697360E-02 5.10088839E-02 1.64955892E-02 1.34862326E-02 0.134450406 1.39547894E-02 3.68802436E-02 1.46715367 1.54205663E-02 3.48642133E-02 2.93390322E-02 3.89627814E-02 3.82531360E-02 5.89082912E-02 0.217518732 2.35656127E-02 3.58789444 1.49691626E-02 + 1601669961.5266564 161962.02140944521 15.3024902 3.94284129 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.73000175E-02 4.07372490E-02 2.99315117E-02 1.73291481 2.23269034E-02 3.72623689E-02 7.10070181 9.46420655E-02 0.325033456 1.92670245E-02 1.73637886E-02 5.09945787E-02 1.64882373E-02 1.34871937E-02 0.134468913 1.39543749E-02 3.67516130E-02 1.46751368 1.54272486E-02 3.48722637E-02 2.93567218E-02 3.89685445E-02 3.82533260E-02 5.89026213E-02 0.217515439 2.35742088E-02 3.58950543 1.49763208E-02 + 1593633572.7586987 162163.87798105733 15.2843485 3.94172978 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.40393386E-03 8.72177035E-02 4.04992178E-02 2.97128819E-02 1.72238338 2.22328026E-02 3.70992422E-02 7.09306145 9.45347100E-02 0.324857593 1.92256570E-02 1.73650347E-02 5.09744696E-02 1.64635684E-02 1.34856263E-02 0.134410366 1.39583889E-02 3.67754251E-02 1.46768486 1.54243195E-02 3.48798931E-02 2.93493774E-02 3.89762819E-02 3.82435136E-02 5.89135624E-02 0.217468783 2.35811304E-02 3.58919597 1.49677359E-02 + 1585597183.9907410 162342.04882160752 15.2626648 3.94013214 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.08397878E-03 8.64992514E-02 4.02361155E-02 2.94817630E-02 1.71109772 2.21160762E-02 3.68745103E-02 7.08344984 9.44201499E-02 0.324549943 1.92122273E-02 1.73500702E-02 5.09466268E-02 1.64564140E-02 1.34810312E-02 0.134507060 1.39583182E-02 3.67855690E-02 1.46785200 1.54332630E-02 3.48754488E-02 2.93534286E-02 3.89985330E-02 3.82428057E-02 5.88899404E-02 0.217411041 2.35757437E-02 3.58856106 1.49664041E-02 + 1577560795.2227833 162794.42193391992 15.2142897 3.93500710 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.23955840E-02 8.53863731E-02 3.99149507E-02 2.92382445E-02 1.69547868 2.20050644E-02 3.66366394E-02 7.05022430 9.42280069E-02 0.324288338 1.91984307E-02 1.73362810E-02 5.08465879E-02 1.64491329E-02 1.34804444E-02 0.134624287 1.39594441E-02 3.67654599E-02 1.46580982 1.54031562E-02 3.48983780E-02 2.93283202E-02 3.89758982E-02 3.82822603E-02 5.88284098E-02 0.217296600 2.35491898E-02 3.58449936 1.49625745E-02 + 1569524406.4548256 163126.03846163844 15.1909676 3.93274522 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.63832661E-02 8.46179649E-02 3.97475921E-02 2.90402789E-02 1.68421233 2.19114386E-02 3.64734419E-02 7.03934669 9.41745266E-02 0.323787302 1.91884339E-02 1.73386279E-02 5.08303456E-02 1.64432768E-02 1.34546999E-02 0.134577543 1.38981612E-02 3.67493890E-02 1.46411479 1.53863113E-02 3.48453596E-02 2.93314792E-02 3.89508307E-02 3.82728726E-02 5.88230975E-02 0.217240825 2.35042479E-02 3.58339524 1.49268918E-02 + 1561488017.6868680 163297.64781329379 15.1755123 3.93248940 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.73681453E-02 8.40888172E-02 3.95467877E-02 2.88690981E-02 1.67511272 2.18520705E-02 3.62885967E-02 7.03328228 9.40421149E-02 0.323521495 1.91619229E-02 1.73281357E-02 5.08352220E-02 1.64415929E-02 1.34491138E-02 0.134550706 1.39012653E-02 3.67571600E-02 1.46393597 1.53864445E-02 3.48665938E-02 2.93312017E-02 3.89440358E-02 3.82927284E-02 5.88101856E-02 0.217288658 2.35044528E-02 3.58382416 1.49292136E-02 + 1553451628.9189103 163459.80417538169 15.1548815 3.93081331 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.01714691E-02 8.34371820E-02 3.92828174E-02 2.87149884E-02 1.66492665 2.17561591E-02 3.61567847E-02 7.02327871 9.39601138E-02 0.323142081 1.91334747E-02 1.73294377E-02 5.08229099E-02 1.64268427E-02 1.34411789E-02 0.134469673 1.38947032E-02 3.67442928E-02 1.46336365 1.53817246E-02 3.48403305E-02 2.93337591E-02 3.89241986E-02 3.82803120E-02 5.88021874E-02 0.217328399 2.34947093E-02 3.58312464 1.49164619E-02 + 1545415240.1509526 164159.43740363832 15.1026993 3.91967511 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.01511637E-02 2.17872262E-02 8.24118108E-02 3.90268415E-02 2.85113361E-02 1.64770901 2.17192136E-02 3.59882005E-02 6.99871159 9.35284868E-02 0.322937429 1.90927554E-02 1.72712300E-02 5.06055802E-02 1.64082609E-02 1.34283761E-02 0.133445889 1.38528608E-02 3.63092646E-02 1.45770085 1.53619451E-02 3.46410722E-02 2.93077473E-02 3.88417244E-02 3.78455222E-02 5.80614135E-02 0.216656983 2.34019533E-02 3.57309198 1.48924431E-02 + 1537378851.3829949 164532.85127875005 15.0707874 3.91958237 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.59744304E-02 2.16087289E-02 8.16813037E-02 3.85916196E-02 2.82816999E-02 1.63548052 2.16026884E-02 3.58311422E-02 6.97458220 9.33463573E-02 0.322955847 1.90793406E-02 1.72549393E-02 5.05704917E-02 1.64031833E-02 1.34280128E-02 0.133418277 1.38544226E-02 3.62878777E-02 1.45793712 1.53614450E-02 3.46435979E-02 2.93015894E-02 3.88378799E-02 3.78381461E-02 5.80528304E-02 0.216672763 2.34116185E-02 3.57360220 1.48959449E-02 + 1529342462.6150372 164739.55580203404 15.0520363 3.91851592 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.74827538E-02 2.14926489E-02 8.11835304E-02 3.84332165E-02 2.81366520E-02 1.62633181 2.15147156E-02 3.56984772E-02 6.96610594 9.31721404E-02 0.322613031 1.90350711E-02 1.72492117E-02 5.05562909E-02 1.64011363E-02 1.33480737E-02 0.133330315 1.38515253E-02 3.62731479E-02 1.45751965 1.53617840E-02 3.46360244E-02 2.93321870E-02 3.88268009E-02 3.78352292E-02 5.80609404E-02 0.216678217 2.34048255E-02 3.57328129 1.48893250E-02 + 1521306073.8470795 165191.39721639338 15.0254850 3.91642261 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.41787080E-02 2.12869365E-02 8.05167779E-02 3.82100195E-02 2.79699136E-02 1.61354184 2.13916562E-02 3.55219692E-02 6.95095730 9.30394605E-02 0.322203547 1.88392028E-02 1.71317868E-02 5.05478568E-02 1.63855162E-02 1.33401817E-02 0.133002341 1.38293877E-02 3.61689925E-02 1.45648110 1.53533202E-02 3.45991217E-02 2.93276459E-02 3.87893803E-02 3.76731679E-02 5.80550991E-02 0.216754034 2.33920328E-02 3.57213068 1.48682976E-02 + 1513269685.0791218 165427.57348977722 15.0067387 3.91558433 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.74138413E-02 2.11450923E-02 8.00117254E-02 3.80450822E-02 2.78103109E-02 1.60458183 2.12938171E-02 3.53908017E-02 6.93958712 9.29335952E-02 0.321948260 1.88255273E-02 1.71284005E-02 5.05202711E-02 1.63842253E-02 1.33350026E-02 0.133046404 1.38364499E-02 3.61687802E-02 1.45637000 1.53536769E-02 3.46137434E-02 2.93230340E-02 3.87920700E-02 3.77006456E-02 5.80970682E-02 0.216862217 2.34026127E-02 3.57195139 1.48677165E-02 + 1505233296.3111641 165821.56127658501 14.9716558 3.90583730 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.35314237E-02 2.09574010E-02 7.93055370E-02 3.74837108E-02 2.76358183E-02 1.59315681 2.10916921E-02 3.51811163E-02 6.92419291 9.27104130E-02 0.320986748 1.88076291E-02 1.71024147E-02 5.03121503E-02 1.63514074E-02 1.33238714E-02 0.132843241 1.37809683E-02 3.61140110E-02 1.45609903 1.53308790E-02 3.45900916E-02 2.92822197E-02 3.87786850E-02 3.76630872E-02 5.79897612E-02 0.215181872 2.33756769E-02 3.56364655 1.48485722E-02 + 1497196907.5432065 166105.21783468823 14.9463396 3.90389276 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.11654420E-04 3.60270776E-02 2.08332576E-02 7.86800757E-02 3.72808501E-02 2.75031738E-02 1.58361351 2.09957212E-02 3.50629129E-02 6.90810251 9.26175043E-02 0.320640922 1.87668987E-02 1.70884617E-02 5.02531677E-02 1.63262095E-02 1.33156888E-02 0.132642031 1.37776621E-02 3.60664465E-02 1.45651352 1.53303342E-02 3.45822498E-02 2.92999484E-02 3.87664549E-02 3.76815870E-02 5.79882003E-02 0.215260580 2.33752299E-02 3.56258559 1.48506360E-02 + 1489160518.7752488 166311.44451607234 14.9244251 3.90230250 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.09371180E-03 3.57581861E-02 2.06292942E-02 7.80186206E-02 3.70081775E-02 2.73045190E-02 1.57402885 2.08834317E-02 3.48939672E-02 6.89648628 9.25320163E-02 0.320351988 1.87481456E-02 1.70712993E-02 5.02060577E-02 1.62273142E-02 1.33114895E-02 0.132507786 1.37716196E-02 3.60488519E-02 1.45678306 1.53355040E-02 3.45969722E-02 2.92720329E-02 3.87718640E-02 3.76772098E-02 5.79757206E-02 0.215147540 2.33825389E-02 3.56175160 1.48489336E-02 + 1481124130.0072911 166649.57549765511 14.9070158 3.89873934 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.97772051E-03 3.54859531E-02 2.04604547E-02 7.74495229E-02 3.67610343E-02 2.71022655E-02 1.56643951 2.07882524E-02 3.47332284E-02 6.88741207 9.24006775E-02 0.320205033 1.87318493E-02 1.70607250E-02 5.01249358E-02 1.62216071E-02 1.32999886E-02 0.132422015 1.37697784E-02 3.60651240E-02 1.45560598 1.53295957E-02 3.45677435E-02 2.92659719E-02 3.87746431E-02 3.76424640E-02 5.79047687E-02 0.214962110 2.33723000E-02 3.55883527 1.48432674E-02 + 1473087741.2393334 166811.88056966371 14.8901472 3.89733720 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.03156297E-02 3.52369808E-02 2.03225575E-02 7.69884214E-02 3.65701169E-02 2.69551240E-02 1.55808556 2.07318887E-02 3.46206427E-02 6.87962770 9.23181400E-02 0.319944233 1.87311545E-02 1.70549098E-02 5.01192436E-02 1.62171721E-02 1.33053567E-02 0.132431507 1.37684187E-02 3.60590555E-02 1.45597756 1.53275849E-02 3.45614702E-02 2.92589385E-02 3.87961082E-02 3.76547538E-02 5.78867570E-02 0.214915752 2.33801920E-02 3.55815935 1.48251420E-02 + 1465051352.4713757 167060.15793293121 14.8671989 3.89472294 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.28415739E-02 3.49169895E-02 2.01856382E-02 7.64511600E-02 3.63538712E-02 2.67765000E-02 1.54865396 2.06282362E-02 3.44602354E-02 6.86773825 9.20923650E-02 0.319758743 1.87189542E-02 1.70439873E-02 5.01411669E-02 1.62124429E-02 1.31920800E-02 0.132290721 1.37667516E-02 3.60510126E-02 1.45634997 1.53326439E-02 3.45463566E-02 2.92076636E-02 3.87984924E-02 3.76219004E-02 5.78172244E-02 0.214844942 2.33884882E-02 3.55619335 1.48245040E-02 + 1457014963.7034180 167373.84964544544 14.8678112 3.89314485 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.72610018E-02 3.46601121E-02 2.00547390E-02 7.59269148E-02 3.61649618E-02 2.65708640E-02 1.53888667 2.05298588E-02 3.43103968E-02 6.85672235 9.29134637E-02 0.321539849 1.87126324E-02 1.70280561E-02 5.01351729E-02 1.61922481E-02 1.31816100E-02 0.132051915 1.37627916E-02 3.60429361E-02 1.45557964 1.53231602E-02 3.45350839E-02 2.91999355E-02 3.88061516E-02 3.76034565E-02 5.77460527E-02 0.214752555 2.33731419E-02 3.55342960 1.48143861E-02 + 1448978574.9354603 167604.13155026908 14.8524904 3.89396763 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.96223065E-04 4.01686803E-02 3.43411490E-02 1.99213661E-02 7.54944608E-02 3.60285491E-02 2.64082588E-02 1.53000736 2.04677209E-02 3.42362896E-02 6.84737825 9.27338302E-02 0.321391463 1.87032446E-02 1.70176905E-02 5.01384214E-02 1.62025597E-02 1.31802298E-02 0.131983981 1.37667190E-02 3.60784493E-02 1.45523155 1.53233400E-02 3.45386341E-02 2.91931219E-02 3.88451219E-02 3.76150049E-02 5.77593222E-02 0.215043783 2.33891662E-02 3.55479288 1.48153771E-02 + 1440942186.1675026 167825.46639755263 14.8351736 3.89164567 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.67394073E-03 3.98500599E-02 3.41616683E-02 1.97883938E-02 7.50458166E-02 3.58911008E-02 2.62311343E-02 1.52126253 2.03901511E-02 3.40567082E-02 6.84153938 9.26623940E-02 0.320800394 1.86805129E-02 1.69898905E-02 5.01205847E-02 1.61530469E-02 1.31694572E-02 0.131812200 1.37612075E-02 3.60581130E-02 1.45427954 1.53147941E-02 3.45185883E-02 2.92017423E-02 3.88307311E-02 3.76111344E-02 5.77427857E-02 0.214997754 2.33802870E-02 3.55338335 1.48132527E-02 + 1432905797.3995450 168057.52288035027 14.8164129 3.89153075 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.19047072E-03 3.95363308E-02 3.39237191E-02 1.96494758E-02 7.45432377E-02 3.57325859E-02 2.61180159E-02 1.51311052 2.03257874E-02 3.37311029E-02 6.83121157 9.25622955E-02 0.320351779 1.86429713E-02 1.69555992E-02 5.01136370E-02 1.61091704E-02 1.31650930E-02 0.131798565 1.37558933E-02 3.60373445E-02 1.45342243 1.53082944E-02 3.44941318E-02 2.91456189E-02 3.88177261E-02 3.75949293E-02 5.77558540E-02 0.214996547 2.33640131E-02 3.55412531 1.48228444E-02 + 1424869408.6315873 168293.22654453843 14.7969894 3.88972664 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.64251796E-03 3.92263345E-02 3.36156487E-02 1.95134506E-02 7.40708038E-02 3.55646200E-02 2.59685498E-02 1.50524080 2.01879814E-02 3.36039290E-02 6.82090425 9.23606008E-02 0.319951177 1.86253116E-02 1.69338603E-02 5.00940681E-02 1.60945076E-02 1.31566292E-02 0.131732568 1.37305828E-02 3.60189267E-02 1.45270109 1.52817117E-02 3.44636887E-02 2.91295871E-02 3.87706645E-02 3.75702456E-02 5.77121116E-02 0.214772701 2.33705547E-02 3.55315375 1.48234954E-02 + 1416833019.8636296 168558.42059654789 14.7814083 3.88754082 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.15428502E-02 3.88623029E-02 3.33745554E-02 1.94251575E-02 7.36564249E-02 3.53577733E-02 2.58303955E-02 1.49835348 2.00803820E-02 3.34651284E-02 6.81356049 9.22105536E-02 0.319632739 1.86084118E-02 1.69109106E-02 5.00221029E-02 1.60937887E-02 1.31545104E-02 0.131799191 1.37218395E-02 3.60181332E-02 1.45246506 1.52753349E-02 3.44596095E-02 2.90607512E-02 3.87026593E-02 3.75677086E-02 5.76944053E-02 0.214704528 2.33677290E-02 3.55161524 1.48139615E-02 + 1408796631.0956719 168779.15127368373 14.7581177 3.88786244 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.36139225E-02 3.83888148E-02 3.31473872E-02 1.92551930E-02 7.31167346E-02 3.51835676E-02 2.56698336E-02 1.49049473 2.00317595E-02 3.31867412E-02 6.79817343 9.21294689E-02 0.319512933 1.86002105E-02 1.69166122E-02 4.99611311E-02 1.60989221E-02 1.31405368E-02 0.131900087 1.37239238E-02 3.60256620E-02 1.45160973 1.52603816E-02 3.44586000E-02 2.90080253E-02 3.87135595E-02 3.75864059E-02 5.77006601E-02 0.214707538 2.33827122E-02 3.55259514 1.48219457E-02 + 1400760242.3277142 168954.13415603878 14.9031258 4.04486227 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.173868626 3.80806513E-02 3.29282880E-02 1.90907381E-02 7.26754069E-02 3.50831151E-02 2.55489107E-02 1.48399258 1.99894626E-02 3.31225842E-02 6.79023695 9.20570567E-02 0.319414556 1.85936224E-02 1.69302598E-02 4.99591418E-02 1.60988010E-02 1.31367473E-02 0.131945655 1.37291076E-02 3.60335708E-02 1.45186615 1.52645353E-02 3.44615579E-02 2.90106777E-02 3.87134179E-02 3.75799313E-02 5.77152446E-02 0.214729950 2.33810954E-02 3.55306435 1.48215564E-02 + 1392723853.5597565 169144.32284951390 15.0995607 4.24448824 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.212141082 0.171548858 3.78018171E-02 3.27359065E-02 1.89752076E-02 7.22770914E-02 3.48801576E-02 2.54324470E-02 1.47889531 1.99302621E-02 3.30465361E-02 6.78315592 9.18230116E-02 0.319110721 1.85586493E-02 1.69006009E-02 4.99153174E-02 1.60432644E-02 1.31327221E-02 0.131963491 1.37276584E-02 3.60279381E-02 1.45156622 1.52630042E-02 3.44635956E-02 2.90367957E-02 3.87109667E-02 3.75734083E-02 5.77466600E-02 0.214810610 2.33836733E-02 3.55415773 1.48247909E-02 + 1384687464.7917988 169350.24464551537 15.0775843 4.23980093 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.212465599 0.170386270 3.73828299E-02 3.24989036E-02 1.88368857E-02 7.17078894E-02 3.46761569E-02 2.52638943E-02 1.47119546 1.98353231E-02 3.28461379E-02 6.77221394 9.19466913E-02 0.319022447 1.85598582E-02 1.68956611E-02 4.98938709E-02 1.60445441E-02 1.31250313E-02 0.132048666 1.37337493E-02 3.60149629E-02 1.45153439 1.52726825E-02 3.44655141E-02 2.90200673E-02 3.87204066E-02 3.75716127E-02 5.76957464E-02 0.214698896 2.33804658E-02 3.55380726 1.48229115E-02 + 1376651076.0238411 169623.81688818597 15.0577612 4.23708344 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.213997200 0.169411585 3.70975807E-02 3.22826952E-02 1.87079478E-02 7.12382570E-02 3.45346741E-02 2.51347590E-02 1.46233928 1.97720435E-02 3.27471122E-02 6.76302910 9.18255746E-02 0.318752617 1.85343176E-02 1.68883651E-02 4.98782396E-02 1.60176810E-02 1.31234471E-02 0.132037163 1.37366774E-02 3.60273905E-02 1.45113027 1.52746709E-02 3.44649814E-02 2.90281978E-02 3.87297161E-02 3.75710167E-02 5.77086173E-02 0.214661852 2.33650021E-02 3.55389047 1.48239965E-02 + 1368614687.2558835 169786.63475972955 15.0467978 4.23531723 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.213457450 0.168111250 3.68160233E-02 3.21136601E-02 1.86059289E-02 7.09459260E-02 3.44372466E-02 2.50339862E-02 1.45653093 1.97187848E-02 3.26616205E-02 6.75878239 9.17644277E-02 0.318790078 1.85282752E-02 1.68873630E-02 4.98907901E-02 1.60273742E-02 1.31300902E-02 0.132120460 1.37430858E-02 3.60244252E-02 1.45195293 1.52791357E-02 3.44839022E-02 2.90362332E-02 3.87445539E-02 3.75840999E-02 5.77267967E-02 0.214684412 2.33604833E-02 3.55499935 1.48238800E-02 + 1360578298.4879258 170019.34830304183 15.0288639 4.23342562 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.214144960 0.167263612 3.65311876E-02 3.19645330E-02 1.85076520E-02 7.06167072E-02 3.43405679E-02 2.49039456E-02 1.44953346 1.96664482E-02 3.25786136E-02 6.74992514 9.15669054E-02 0.318239331 1.84768774E-02 1.68795660E-02 4.98445779E-02 1.59566663E-02 1.31291738E-02 0.132091105 1.37484148E-02 3.60094570E-02 1.45124626 1.52789019E-02 3.44695821E-02 2.90353559E-02 3.87441255E-02 3.76601070E-02 5.77222109E-02 0.214657277 2.33659279E-02 3.55593657 1.48279220E-02 + 1352541909.7199681 173569.93849337680 14.9755812 4.19202805 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.451769471 0.166125655 3.61396559E-02 3.15472223E-02 1.83183812E-02 6.93197250E-02 3.38517874E-02 2.47012861E-02 1.42690253 1.94588080E-02 3.22329178E-02 6.53323364 9.11643282E-02 0.313909858 1.81978308E-02 1.67111754E-02 4.90015410E-02 1.58086903E-02 1.30638005E-02 0.131815121 1.35762691E-02 3.58481929E-02 1.44708323 1.52180232E-02 3.44168134E-02 2.89627369E-02 3.84682789E-02 3.72756459E-02 5.72358258E-02 0.213771552 2.32491624E-02 3.52248383 1.47164138E-02 + 1344505520.9520104 173840.14832887499 14.9633770 4.19091845 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.30674499E-03 0.449976325 0.165106684 3.59428711E-02 3.14306691E-02 1.82498861E-02 6.90867007E-02 3.37817334E-02 2.46014372E-02 1.42167723 1.94296017E-02 3.21644209E-02 6.52718401 9.11248475E-02 0.313686460 1.81830674E-02 1.67107899E-02 4.89771403E-02 1.58017967E-02 1.30613977E-02 0.131842136 1.35656707E-02 3.58410627E-02 1.44752574 1.52186109E-02 3.44269872E-02 2.89640892E-02 3.84744667E-02 3.72760296E-02 5.72290644E-02 0.213763639 2.32509580E-02 3.52379751 1.47186164E-02 + 1336469132.1840527 174140.23572539931 14.9458952 4.18821716 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.39193612E-03 0.447935373 0.163983107 3.55970822E-02 3.12364027E-02 1.80882905E-02 6.86569139E-02 3.36912982E-02 2.44096052E-02 1.41555691 1.93787348E-02 3.20358537E-02 6.51844311 9.10102352E-02 0.313457996 1.81642137E-02 1.67075451E-02 4.89240848E-02 1.57855004E-02 1.30520593E-02 0.131857306 1.35611491E-02 3.58361267E-02 1.44735610 1.52142588E-02 3.44124027E-02 2.89373286E-02 3.84537168E-02 3.72760221E-02 5.72474673E-02 0.213801369 2.32527312E-02 3.52344441 1.47391576E-02 + 1328432743.4160950 174315.14813137869 14.9307470 4.18551922 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.45760293E-03 0.445038140 0.162627637 3.53952199E-02 3.10720596E-02 1.80031564E-02 6.83158487E-02 3.35598439E-02 2.43085213E-02 1.40995836 1.93241760E-02 3.19899581E-02 6.51025534 9.08647850E-02 0.313278139 1.81641132E-02 1.67015754E-02 4.89071608E-02 1.57945864E-02 1.33351060E-02 0.131863683 1.35568716E-02 3.58369276E-02 1.44725752 1.52147152E-02 3.44021991E-02 2.89306752E-02 3.84319350E-02 3.72856595E-02 5.72284721E-02 0.213789135 2.32512169E-02 3.52360845 1.47384517E-02 + 1320396354.6481373 174599.58723989726 14.9123106 4.18253088 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.12955859E-02 0.441331655 0.162050903 3.51446718E-02 3.09022311E-02 1.79236829E-02 6.79804906E-02 3.34784724E-02 2.42038406E-02 1.40403867 1.92446206E-02 3.19118984E-02 6.50270319 9.06985775E-02 0.312942535 1.81383453E-02 1.66952219E-02 4.88948449E-02 1.57799553E-02 1.33250542E-02 0.131736651 1.35461222E-02 3.58223282E-02 1.44572389 1.52086988E-02 3.43890637E-02 2.89357696E-02 3.83783989E-02 3.72797847E-02 5.72126918E-02 0.213712707 2.32543908E-02 3.52369452 1.47331562E-02 + 1312359965.8801796 175752.85767404310 14.7900629 4.15914965 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.00893104E-02 0.437884957 0.160962343 3.48598249E-02 3.06129120E-02 1.77517086E-02 6.72928467E-02 3.32704298E-02 2.40703505E-02 1.38866401 1.91292837E-02 3.18094119E-02 6.37637949 9.01711881E-02 0.310281545 1.80173796E-02 1.66477729E-02 4.87485938E-02 1.57342497E-02 1.32400254E-02 0.131648794 1.34924771E-02 3.57319601E-02 1.43756926 1.51889557E-02 3.43478732E-02 2.88381241E-02 3.78167368E-02 3.72263007E-02 5.71171679E-02 0.213165775 2.31000353E-02 3.50452352 1.46762514E-02 + 1304323577.1122220 176034.58534170847 14.7738981 4.15469360 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.29299784E-02 0.435298175 0.159967661 3.46531346E-02 3.05026080E-02 1.76990815E-02 6.71168491E-02 3.32057066E-02 2.40240768E-02 1.38395345 1.90846734E-02 3.17507274E-02 6.37117672 8.99385288E-02 0.309732497 1.79650895E-02 1.66051723E-02 4.86982539E-02 1.57217346E-02 1.32367229E-02 0.131433830 1.34757012E-02 3.57269011E-02 1.43580544 1.51773831E-02 3.42978872E-02 2.88228262E-02 3.77906673E-02 3.72232981E-02 5.71078360E-02 0.213074937 2.30962522E-02 3.50293946 1.46665713E-02 + 1296287188.3442643 176215.56777000189 14.7555208 4.15275574 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.90503463E-04 7.38081932E-02 0.432397276 0.159231901 3.43780816E-02 3.03419624E-02 1.75944436E-02 6.68278188E-02 3.30335088E-02 2.39087064E-02 1.37837148 1.90117415E-02 3.11519429E-02 6.36362743 8.98392349E-02 0.309392482 1.79431699E-02 1.65914912E-02 4.86840867E-02 1.56986136E-02 1.32324863E-02 0.131363779 1.34702679E-02 3.56365405E-02 1.43463171 1.51615962E-02 3.42708826E-02 2.87947282E-02 3.77699547E-02 3.71964686E-02 5.71034886E-02 0.212669373 2.30934992E-02 3.50373292 1.46692405E-02 + 1288250799.5763066 176400.91800295014 14.7474957 4.15081072 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.40680063E-03 7.34122917E-02 0.428980500 0.158497185 3.42137329E-02 3.01811397E-02 1.75176132E-02 6.66043013E-02 3.29552293E-02 2.38516126E-02 1.37567008 1.89892519E-02 3.10963076E-02 6.36221933 8.98017958E-02 0.309368700 1.79437809E-02 1.65950004E-02 4.86687124E-02 1.57012288E-02 1.32348975E-02 0.131380200 1.34713724E-02 3.56342830E-02 1.43449831 1.51644703E-02 3.42734680E-02 2.87922751E-02 3.77718508E-02 3.71983275E-02 5.71275502E-02 0.212673828 2.30986010E-02 3.50381827 1.46817677E-02 + 1280214410.8083489 176570.81834559856 14.7271509 4.14865398 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.81627090E-03 7.28479996E-02 0.426747352 0.157993898 3.40089910E-02 2.99601443E-02 1.74368713E-02 6.62936047E-02 3.28730494E-02 2.36807279E-02 1.36978281 1.89385209E-02 3.10283974E-02 6.35159779 8.97584036E-02 0.309138626 1.79236941E-02 1.65902972E-02 4.86427397E-02 1.57036427E-02 1.32356500E-02 0.131421044 1.34744868E-02 3.56254652E-02 1.43356788 1.51651790E-02 3.42812166E-02 2.87893340E-02 3.76787707E-02 3.72376926E-02 5.71253374E-02 0.212636188 2.31073331E-02 3.50335932 1.46820778E-02 + 1272178022.0403912 176727.28755601749 14.7167101 4.14760113 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.12042192E-03 7.23659322E-02 0.424152464 0.156960070 3.37894782E-02 2.98245791E-02 1.73585266E-02 6.60258383E-02 3.27610150E-02 2.35745385E-02 1.36562896 1.88864525E-02 3.09803076E-02 6.34779310 8.97075608E-02 0.309050858 1.79119967E-02 1.65862292E-02 4.86059859E-02 1.56962164E-02 1.32357925E-02 0.131472439 1.34773720E-02 3.56381498E-02 1.43343389 1.51686715E-02 3.42884623E-02 2.87876129E-02 3.76974531E-02 3.72549556E-02 5.71446121E-02 0.212662652 2.31250059E-02 3.50485849 1.46832736E-02 + 1264141633.2724335 177073.55114782852 14.7325802 4.15539646 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.34630550E-02 7.17601031E-02 0.420629084 0.156024933 3.34526636E-02 2.97679789E-02 1.71131361E-02 6.56652898E-02 3.26511078E-02 2.34449189E-02 1.36162949 1.88501757E-02 3.09167802E-02 6.34000635 8.96517485E-02 0.308970243 1.78998895E-02 1.65805109E-02 4.85614464E-02 1.56902689E-02 1.32219717E-02 0.131377265 1.34647386E-02 3.56324464E-02 1.43244994 1.51685523E-02 3.42635773E-02 2.87681315E-02 3.76765653E-02 3.72184925E-02 5.71073256E-02 0.212594211 2.31229141E-02 3.50310493 1.46805281E-02 + 1256105244.5044758 177232.88941973797 14.7248411 4.15120697 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.61159348E-02 7.14079961E-02 0.418056041 0.153990701 3.32686342E-02 2.96159238E-02 1.70645956E-02 6.54474050E-02 3.25765871E-02 2.33584959E-02 1.35830402 1.88178923E-02 3.08769997E-02 6.33892822 8.95945132E-02 0.308936685 1.78880766E-02 1.65841952E-02 4.85689193E-02 1.57010108E-02 1.32206427E-02 0.131447583 1.34665901E-02 3.56370360E-02 1.43285584 1.51676303E-02 3.42861935E-02 2.87742261E-02 3.76712531E-02 3.72292623E-02 5.71162812E-02 0.212563038 2.31139511E-02 3.50250292 1.46839358E-02 + 1248068855.7365181 177678.94515098966 14.6252012 4.14021635 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.05703007E-04 6.66366443E-02 7.07085282E-02 0.412423730 0.153376147 3.29541154E-02 2.93086749E-02 1.69078056E-02 6.49693310E-02 3.23053263E-02 2.32711956E-02 1.34983218 1.87406559E-02 3.08065750E-02 6.24715710 8.94470066E-02 0.307962686 1.78266689E-02 1.65668428E-02 4.84610163E-02 1.56740397E-02 1.32046016E-02 0.131175801 1.34581644E-02 3.55656072E-02 1.43106127 1.51149901E-02 3.42415124E-02 2.87533626E-02 3.76330800E-02 3.71887907E-02 5.69155551E-02 0.212441325 2.30076872E-02 3.49524236 1.46561395E-02 + 1240032466.9685605 177797.73096318703 14.6138048 4.13808441 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.50626374E-03 6.62076846E-02 7.04098269E-02 0.410342038 0.152554214 3.28376293E-02 2.92121451E-02 1.68705396E-02 6.47489950E-02 3.21838334E-02 2.31951363E-02 1.34617078 1.87132079E-02 3.07096336E-02 6.24285126 8.94197822E-02 0.307772160 1.78275071E-02 1.65618844E-02 4.84430715E-02 1.56678502E-02 1.32017937E-02 0.131195396 1.34533988E-02 3.55464257E-02 1.43080020 1.51052810E-02 3.42439190E-02 2.88015306E-02 3.76172699E-02 3.71978879E-02 5.69183677E-02 0.212455496 2.30263118E-02 3.49537873 1.46576939E-02 + 1231996078.2006028 180111.93561971077 14.5890589 4.11146259 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.59753489E-02 6.50858954E-02 6.98914826E-02 0.408532679 0.150931135 3.25459167E-02 2.89315507E-02 1.67207159E-02 6.40384704E-02 3.20439003E-02 2.30812896E-02 1.33399308 1.86700597E-02 3.06239277E-02 6.19279766 8.82237777E-02 0.304884046 1.75366979E-02 1.65130682E-02 4.68424261E-02 1.56086525E-02 1.31709212E-02 0.129435331 1.34295113E-02 3.54525223E-02 1.42141402 1.50760924E-02 3.37186195E-02 2.87256483E-02 3.75447646E-02 3.69657762E-02 5.68560325E-02 0.212380260 2.30028983E-02 3.47380161 1.46110160E-02 + 1223959689.4326451 180394.80144936751 14.6261396 4.15772963 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.141052678 6.46087453E-02 6.94400817E-02 0.405928820 0.150425747 3.23463380E-02 2.88305953E-02 1.66917127E-02 6.38530478E-02 3.19826677E-02 2.29998305E-02 1.33002603 1.86170042E-02 3.05612013E-02 6.18614960 8.80626515E-02 0.304488093 1.75166521E-02 1.64945088E-02 4.68197763E-02 1.55942636E-02 1.31655568E-02 0.129316032 1.34276533E-02 3.54500003E-02 1.42030632 1.50632290E-02 3.37144025E-02 2.87075993E-02 3.75042930E-02 3.69219854E-02 5.68658337E-02 0.212309375 2.30128225E-02 3.47327662 1.46075189E-02 + 1215923300.6646874 180549.78052021511 14.6279545 4.15643501 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.147249833 6.41973242E-02 6.91631958E-02 0.404185742 0.149342805 3.22378241E-02 2.87218504E-02 1.66405961E-02 6.37017488E-02 3.19494493E-02 2.29570344E-02 1.32760537 1.85903423E-02 3.05495616E-02 6.18540001 8.80098939E-02 0.304489315 1.75138973E-02 1.64943077E-02 4.68444973E-02 1.55905131E-02 1.31190848E-02 0.129383370 1.34323128E-02 3.54651473E-02 1.42147267 1.50736496E-02 3.37172598E-02 2.87208073E-02 3.75140496E-02 3.69485281E-02 5.68860173E-02 0.212367401 2.30284538E-02 3.47477603 1.46151111E-02 + 1207886911.8967297 180749.97727203512 14.6150713 4.15453529 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.148104042 6.37598783E-02 6.87310621E-02 0.402330637 0.148817062 3.20835672E-02 2.85798907E-02 1.65916178E-02 6.35014474E-02 3.18921879E-02 2.28714589E-02 1.32339120 1.85506456E-02 3.05106472E-02 6.17906713 8.78888443E-02 0.304454029 1.75021365E-02 1.64809804E-02 4.68582064E-02 1.55938063E-02 1.31195355E-02 0.129382551 1.34353675E-02 3.55018675E-02 1.42176557 1.50854699E-02 3.37470882E-02 2.87225880E-02 3.75198014E-02 3.69843207E-02 5.69444373E-02 0.212463200 2.30294578E-02 3.47519493 1.46161802E-02 + 1199850523.1287720 180955.11797421178 14.6051130 4.14893627 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.05618868E-06 0.148896679 6.33185729E-02 6.84138760E-02 0.399222523 0.148044169 3.18120047E-02 2.84922626E-02 1.64926872E-02 6.32516742E-02 3.18064168E-02 2.27624029E-02 1.32564473 1.85272638E-02 3.04591153E-02 6.17529726 8.78112093E-02 0.304435521 1.74935050E-02 1.64771397E-02 4.68340702E-02 1.55941658E-02 1.31156025E-02 0.129302934 1.34272641E-02 3.54883671E-02 1.42026055 1.50851114E-02 3.37141231E-02 2.87196599E-02 3.75217758E-02 3.69748399E-02 5.69285154E-02 0.212362751 2.30529960E-02 3.47345662 1.46061527E-02 + 1191814134.3608143 181171.92987068338 14.7339134 4.14642715 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.139595211 0.147866711 6.28957227E-02 6.80706427E-02 0.397473246 0.147911966 3.16778235E-02 2.83646323E-02 1.64339207E-02 6.30829632E-02 3.16601545E-02 2.27237418E-02 1.32262123 1.84850357E-02 3.04212589E-02 6.17308235 8.77617821E-02 0.304131746 1.74859650E-02 1.64510496E-02 4.68331873E-02 1.55904237E-02 1.31118950E-02 0.129350021 1.34275518E-02 3.55048776E-02 1.42028296 1.50867859E-02 3.37156057E-02 2.87280735E-02 3.75235565E-02 3.70030291E-02 5.69281094E-02 0.212300926 2.30503771E-02 3.47267699 1.46013806E-02 + 1183777745.5928566 181318.23850934103 14.7269869 4.14232111 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.147165850 0.146982461 6.24983944E-02 6.77501932E-02 0.395260483 0.145826608 3.15268114E-02 2.82630343E-02 1.63823999E-02 6.28852770E-02 3.15947831E-02 2.26640906E-02 1.31916237 1.84348300E-02 3.03869732E-02 6.17043686 8.76859203E-02 0.304062545 1.74843073E-02 1.64421666E-02 4.68131341E-02 1.55803319E-02 1.31132072E-02 0.129206628 1.34142255E-02 3.54781337E-02 1.41922605 1.50759183E-02 3.36997025E-02 2.87258606E-02 3.75187732E-02 3.69911268E-02 5.69108315E-02 0.211974546 2.30404101E-02 3.47271323 1.46084158E-02 + 1175741356.8248990 181598.23028065608 14.7484550 4.14011621 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.184428111 0.145828620 6.20276220E-02 6.74405918E-02 0.393526614 0.144835621 3.13917734E-02 2.81379521E-02 1.63309537E-02 6.26588017E-02 3.15127224E-02 2.25942209E-02 1.31524706 1.83783360E-02 3.03245261E-02 6.16379642 8.76257345E-02 0.304073870 1.74861010E-02 1.64478868E-02 4.68207821E-02 1.55853461E-02 1.31186321E-02 0.129289433 1.34213502E-02 3.54777053E-02 1.41919148 1.50833866E-02 3.36987525E-02 2.87275407E-02 3.75186689E-02 3.69954854E-02 5.69104403E-02 0.211960629 2.30413489E-02 3.47289896 1.46199269E-02 + 1167704968.0569413 181862.15600551083 14.7342291 4.13576984 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.185936183 0.144718483 6.15814850E-02 6.71175197E-02 0.391668290 0.144149482 3.12562250E-02 2.80249882E-02 1.62833240E-02 6.24453649E-02 3.14245038E-02 2.25163568E-02 1.31207347 1.83427893E-02 3.03000212E-02 6.15938807 8.74027535E-02 0.303588361 1.74430013E-02 1.64353736E-02 4.67613749E-02 1.55794220E-02 1.31170349E-02 0.129148334 1.34221381E-02 3.54735777E-02 1.41894948 1.50848543E-02 3.36825475E-02 2.87290011E-02 3.74983624E-02 3.70055102E-02 5.69320209E-02 0.211841732 2.30316389E-02 3.47124791 1.46279782E-02 + 1159668579.2889836 182089.29703465823 14.7210712 4.13433886 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.187638342 0.143522471 6.11530580E-02 6.67799637E-02 0.389911890 0.143510312 3.11247166E-02 2.78354231E-02 1.62183642E-02 6.22751117E-02 3.13770473E-02 2.24578623E-02 1.30816519 1.83187351E-02 3.02682202E-02 6.15448999 8.72881711E-02 0.303513527 1.74377840E-02 1.64316054E-02 4.67302799E-02 1.55614167E-02 1.31070912E-02 0.128811270 1.34123014E-02 3.54494043E-02 1.41800261 1.50844902E-02 3.36803868E-02 2.87156366E-02 3.74964476E-02 3.69920023E-02 5.68652973E-02 0.211815387 2.30499282E-02 3.47195315 1.46268019E-02 + 1151632190.5210259 182253.90155415772 14.7141142 4.13215065 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.188297004 0.142574623 6.07873462E-02 6.65515512E-02 0.388161868 0.143191397 3.09709962E-02 2.77817827E-02 1.61933191E-02 6.21890649E-02 3.13331448E-02 2.24194173E-02 1.30643201 1.82891507E-02 3.02389897E-02 6.15336227 8.73171166E-02 0.303568363 1.74377076E-02 1.64314844E-02 4.67181094E-02 1.55493068E-02 1.31044202E-02 0.128845870 1.34152770E-02 3.54745574E-02 1.41785955 1.50791695E-02 3.36642042E-02 2.87066437E-02 3.74977440E-02 3.69871259E-02 5.68652153E-02 0.211778253 2.30431687E-02 3.47137380 1.46210361E-02 + 1143595801.7530682 182500.27212980785 14.6956310 4.12522840 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.40597800E-03 0.186757848 0.141471371 6.03342950E-02 6.62334934E-02 0.385924250 0.141519591 3.07733361E-02 2.76838932E-02 1.61580127E-02 6.20107912E-02 3.12792957E-02 2.23156847E-02 1.30298972 1.82321556E-02 3.00938468E-02 6.14625311 8.71972591E-02 0.302757382 1.73860360E-02 1.64115168E-02 4.66932990E-02 1.54970065E-02 1.30860563E-02 0.128757596 1.34093398E-02 3.54330577E-02 1.41582465 1.50578842E-02 3.36102396E-02 2.86557116E-02 3.74488942E-02 3.69290076E-02 5.68215363E-02 0.211655751 2.30245702E-02 3.46892548 1.46107906E-02 + 1135559412.9851105 182780.63408500957 14.7035027 4.11606264 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.18797508E-02 0.184971943 0.140478492 5.99520467E-02 6.58201873E-02 0.381614566 0.136396468 3.05868629E-02 2.75655724E-02 1.61122493E-02 6.17582984E-02 3.12291272E-02 2.22181939E-02 1.29974198 1.81994438E-02 2.99980938E-02 6.13862371 8.70526433E-02 0.302425206 1.73783395E-02 1.63980164E-02 4.66324203E-02 1.54825319E-02 1.30786188E-02 0.128649861 1.33860558E-02 3.53951901E-02 1.41421461 1.50549347E-02 3.35945413E-02 2.86341775E-02 3.74060869E-02 3.69419828E-02 5.67811243E-02 0.211666569 2.30246522E-02 3.46854711 1.46112265E-02 + 1127523024.2171528 182932.24057258022 14.6954517 4.11328411 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.29009870E-02 0.183959410 0.139703855 5.96109331E-02 6.55660033E-02 0.379914999 0.135610223 3.04785576E-02 2.74560116E-02 1.60804670E-02 6.16160631E-02 3.12065184E-02 2.21446175E-02 1.29740548 1.81810502E-02 2.99814846E-02 6.13717031 8.70123357E-02 0.302439034 1.73610132E-02 1.63864288E-02 4.66407500E-02 1.54829370E-02 1.30867912E-02 0.128536910 1.33860717E-02 3.54421623E-02 1.41490197 1.50675429E-02 3.36080752E-02 2.86398754E-02 3.74127179E-02 3.69804390E-02 5.67862876E-02 0.211686984 2.30255611E-02 3.46797419 1.46084381E-02 + 1119486635.4491951 183111.33325205298 14.6875935 4.11120558 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.73421887E-02 0.182312757 0.138592184 5.92364296E-02 6.53200448E-02 0.378229290 0.135181308 3.03078853E-02 2.73570251E-02 1.60050523E-02 6.14123680E-02 3.11383344E-02 2.20618155E-02 1.29472220 1.81585755E-02 2.99033169E-02 6.13365889 8.70125294E-02 0.302418828 1.73546914E-02 1.63772497E-02 4.66430150E-02 1.54638523E-02 1.30938180E-02 0.128601402 1.33920042E-02 3.54535431E-02 1.41527414 1.50694093E-02 3.36126126E-02 2.86211558E-02 3.74147482E-02 3.69781591E-02 5.67949824E-02 0.211672351 2.30305009E-02 3.46777487 1.46005470E-02 + 1111450246.6812375 183362.57996128590 14.6673918 4.10948563 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.22771440E-02 0.180719122 0.137178436 5.87052889E-02 6.49779364E-02 0.377431035 0.135374203 3.01780328E-02 2.72403210E-02 1.59391761E-02 6.11736178E-02 3.10680866E-02 2.20139101E-02 1.28589976 1.81112215E-02 2.98530497E-02 6.12542248 8.69947448E-02 0.302282900 1.73462965E-02 1.63710471E-02 4.65665944E-02 1.54297687E-02 1.30962012E-02 0.128342763 1.33701405E-02 3.54079083E-02 1.41426742 1.50492555E-02 3.35504003E-02 2.86198407E-02 3.74206007E-02 3.68630737E-02 5.68027347E-02 0.211668923 2.30230372E-02 3.46675181 1.46032851E-02 + 1103413857.9132798 183499.38024970904 14.6629696 4.10824156 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.31370491E-02 0.179099724 0.136337817 5.83695248E-02 6.47180453E-02 0.376135588 0.134761423 3.00849937E-02 2.71571148E-02 1.59093440E-02 6.10432327E-02 3.09782978E-02 2.19875686E-02 1.28463125 1.81000568E-02 2.98406426E-02 6.12567377 8.70185047E-02 0.302328795 1.73470918E-02 1.63632873E-02 4.65860479E-02 1.54474154E-02 1.30990939E-02 0.128416345 1.33744022E-02 3.54354084E-02 1.41475248 1.50493104E-02 3.35642658E-02 2.86207050E-02 3.74184884E-02 3.68680991E-02 5.68040498E-02 0.211661801 2.30119489E-02 3.46723509 1.46030746E-02 + 1095377469.1453221 186991.28125431866 14.6684446 4.07035780 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.12892925E-03 0.171385333 0.177829728 0.135175288 5.73058464E-02 6.39457554E-02 0.374448597 0.134362787 2.99136583E-02 2.69743372E-02 1.53044760E-02 6.02017157E-02 3.07625588E-02 2.17520874E-02 1.26905346 1.79845188E-02 2.95457020E-02 6.08793259 8.68267566E-02 0.298178375 1.71700716E-02 1.63353551E-02 4.64552306E-02 1.54092498E-02 1.28470743E-02 0.128230125 1.27386954E-02 3.53018939E-02 1.39889991 1.49932764E-02 3.31506953E-02 2.84579787E-02 3.71113010E-02 3.65403406E-02 5.65853752E-02 0.210662261 2.24721041E-02 3.43488503 1.41863376E-02 + 1087341080.3773644 187150.64572425457 14.6624832 4.06858540 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.28552432E-03 0.170499697 0.176417887 0.134431288 5.70274182E-02 6.36038780E-02 0.373197466 0.133458823 2.98255123E-02 2.69206036E-02 1.52846631E-02 6.00955412E-02 3.07389367E-02 2.17264760E-02 1.26740241 1.79434251E-02 2.95417253E-02 6.08802748 8.67618099E-02 0.298158973 1.71708222E-02 1.63392331E-02 4.64731455E-02 1.54136131E-02 1.28485532E-02 0.128248140 1.27411634E-02 3.52871865E-02 1.39928472 1.49978111E-02 3.31562795E-02 2.84478012E-02 3.70946415E-02 3.65333557E-02 5.66108897E-02 0.210755825 2.24696249E-02 3.43507957 1.41823506E-02 + 1079304691.6094067 187358.01371904562 14.6523113 4.06680918 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.08398478E-02 0.169199377 0.175008386 0.133661702 5.67310899E-02 6.33813441E-02 0.370766103 0.132720694 2.96023190E-02 2.68826932E-02 1.52592855E-02 5.99517748E-02 3.06126624E-02 2.16483679E-02 1.26517904 1.79182608E-02 2.94710826E-02 6.08365345 8.67563784E-02 0.298184097 1.71621498E-02 1.63309276E-02 4.64648977E-02 1.54150808E-02 1.28560122E-02 0.128247961 1.27441389E-02 3.52884755E-02 1.39970922 1.50066437E-02 3.31540257E-02 2.84362007E-02 3.70956473E-02 3.65255438E-02 5.66279814E-02 0.210839719 2.24841312E-02 3.43630576 1.41857602E-02 + 1071268302.8412656 187530.14857194506 14.6485071 4.06488180 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.51280370E-02 0.168355405 0.173910365 0.133062631 5.64495996E-02 6.30376711E-02 0.369501173 0.132071987 2.95302644E-02 2.68071853E-02 1.52447503E-02 5.98691218E-02 3.05856988E-02 2.16240063E-02 1.26324487 1.79146677E-02 2.94463634E-02 6.08310938 8.67254809E-02 0.298162013 1.71637125E-02 1.63133368E-02 4.64617871E-02 1.54206008E-02 1.28566604E-02 0.128291696 1.27447443E-02 3.52915004E-02 1.39972544 1.50108896E-02 3.31637487E-02 2.84568090E-02 3.70892473E-02 3.65207531E-02 5.66142499E-02 0.210908055 2.24869512E-02 3.43602037 1.41859613E-02 + 1063231914.0727118 188771.09844179155 14.6281633 4.04972744 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.19222522E-02 0.166971311 0.172627330 0.128111124 5.59658967E-02 6.26600534E-02 0.368386388 0.132157311 2.92853117E-02 2.66618691E-02 1.51722655E-02 5.94844259E-02 3.04458514E-02 2.15228982E-02 1.25574076 1.78885423E-02 2.93612666E-02 6.05886984 8.61919671E-02 0.297039568 1.70642138E-02 1.62712224E-02 4.60803881E-02 1.53803760E-02 1.28512504E-02 0.127632186 1.27152726E-02 3.51912975E-02 1.39211357 1.49768190E-02 3.29629816E-02 2.84129120E-02 3.68841924E-02 3.64866965E-02 5.65585047E-02 0.210880473 2.24698689E-02 3.42259169 1.41722560E-02 + 1055195525.3041581 188967.29667463669 14.6243858 4.04843235 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.32185563E-02 0.166045964 0.171415195 0.127461031 5.57154082E-02 6.24790974E-02 0.367077023 0.131604090 2.92181354E-02 2.66177654E-02 1.51766986E-02 5.93942590E-02 3.03836968E-02 2.15088855E-02 1.25489950 1.78924929E-02 2.93664206E-02 6.05874205 8.61881673E-02 0.296939790 1.70637276E-02 1.62642393E-02 4.60502170E-02 1.53714083E-02 1.28517691E-02 0.127630413 1.27088549E-02 3.51998843E-02 1.39304972 1.49879027E-02 3.30124013E-02 2.84308344E-02 3.68939936E-02 3.65601741E-02 5.65701872E-02 0.210893169 2.24782769E-02 3.42285299 1.41713722E-02 + 1047159136.5356044 189120.32621141727 14.6174459 4.04718447 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.98222441E-03 6.43984526E-02 0.164902270 0.170417786 0.126920938 5.54278344E-02 6.22659996E-02 0.365623355 0.131273374 2.91405004E-02 2.65463237E-02 1.51390601E-02 5.92544340E-02 3.03380229E-02 2.14698929E-02 1.25269532 1.78751014E-02 2.93668639E-02 6.05698967 8.61393511E-02 0.296767920 1.70618948E-02 1.62616745E-02 4.60238941E-02 1.53655568E-02 1.28428182E-02 0.127619624 1.27034532E-02 3.51967625E-02 1.39239311 1.49860559E-02 3.29956599E-02 2.84234490E-02 3.68931070E-02 3.65532264E-02 5.65311238E-02 0.210833609 2.24649645E-02 3.42318487 1.41744576E-02 + 1039122747.7670506 190361.20121332401 14.5944662 4.03682327 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.44801359E-02 6.36954531E-02 0.158963621 0.169054314 0.125737011 5.48522621E-02 6.19027913E-02 0.365340173 0.131251588 2.90334299E-02 2.63294373E-02 1.48748839E-02 5.88662960E-02 3.02486029E-02 2.12817900E-02 1.24469995 1.78316068E-02 2.92476472E-02 6.04197788 8.56730416E-02 0.295429111 1.70293339E-02 1.62264276E-02 4.59355265E-02 1.53235747E-02 1.26427449E-02 0.127306923 1.25700347E-02 3.50951999E-02 1.38457251 1.49122700E-02 3.27902623E-02 2.83387415E-02 3.67070809E-02 3.63079943E-02 5.64119220E-02 0.210267603 2.22460683E-02 3.41487813 1.41312508E-02 + 1031086358.9984969 190526.67335683911 14.5919418 4.03768826 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.72226387E-02 6.33728281E-02 0.158181801 0.167689502 0.125086814 5.45936599E-02 6.17391802E-02 0.364169151 0.130937070 2.89755408E-02 2.62782034E-02 1.48627274E-02 5.88276833E-02 3.02042458E-02 2.12695636E-02 1.24403119 1.78277232E-02 2.92747170E-02 6.04167032 8.56748000E-02 0.295482069 1.70308519E-02 1.62266251E-02 4.59280498E-02 1.53200459E-02 1.26426080E-02 0.127302229 1.25823561E-02 3.51096019E-02 1.38495111 1.49169769E-02 3.28062400E-02 2.83513423E-02 3.67201418E-02 3.63286547E-02 5.64172864E-02 0.210302234 2.22499259E-02 3.41525173 1.41315907E-02 + 1023049970.2299432 190736.61915179700 14.5851755 4.03599977 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.97997685E-02 6.29777908E-02 0.157210514 0.166554943 0.124444418 5.43388389E-02 6.14101626E-02 0.362973064 0.130793154 2.88354233E-02 2.62100473E-02 1.48429340E-02 5.87323047E-02 3.01599689E-02 2.12256946E-02 1.24226201 1.78112686E-02 2.92411968E-02 6.04095554 8.56576189E-02 0.295510173 1.70293804E-02 1.62216425E-02 4.59080525E-02 1.53230596E-02 1.26392208E-02 0.127191201 1.25760138E-02 3.50043252E-02 1.38457620 1.49187231E-02 3.27948108E-02 2.83521134E-02 3.67045999E-02 3.63086388E-02 5.63966185E-02 0.210223019 2.22473666E-02 3.41468573 1.41264163E-02 + 1015013581.4613894 190894.17208512998 14.5755558 4.03353453 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.45977747E-02 6.25372902E-02 0.156366929 0.165249527 0.123754054 5.41190393E-02 6.09393083E-02 0.362125486 0.130151480 2.87638381E-02 2.61639748E-02 1.47945601E-02 5.85898980E-02 3.01251840E-02 2.11869460E-02 1.24015915 1.77953038E-02 2.92372108E-02 6.03485727 8.56288522E-02 0.295432746 1.70231014E-02 1.62422750E-02 4.59169447E-02 1.53234275E-02 1.26408776E-02 0.127254263 1.25794746E-02 3.50130238E-02 1.38500309 1.49194654E-02 3.28010730E-02 2.83558462E-02 3.67079452E-02 3.63269970E-02 5.63980974E-02 0.210242361 2.22474933E-02 3.41386223 1.41218165E-02 + 1006977192.6928357 191036.69034247255 14.5698223 4.03312731 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.59258780E-02 6.22142777E-02 0.155459404 0.164268076 0.123214476 5.38911931E-02 6.07994124E-02 0.361044914 0.129537478 2.86855604E-02 2.60829329E-02 1.47591420E-02 5.85013814E-02 3.01249512E-02 2.11644322E-02 1.23814774 1.77697018E-02 2.92219948E-02 6.03346634 8.56134668E-02 0.295375526 1.70206688E-02 1.62430797E-02 4.59122658E-02 1.53171830E-02 1.26400273E-02 0.127318203 1.25869764E-02 3.50212306E-02 1.38537681 1.49204517E-02 3.28027084E-02 2.83530187E-02 3.67092639E-02 3.63175645E-02 5.63982576E-02 0.210241958 2.22521611E-02 3.41499758 1.41261127E-02 + 998940803.92428195 191254.86147095874 14.5566072 4.03010130 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.79221247E-04 4.82590385E-02 6.18768446E-02 0.154609472 0.163145989 0.122655451 5.35951704E-02 6.05965815E-02 0.359255940 0.129109338 2.85856239E-02 2.60100812E-02 1.47326961E-02 5.83677478E-02 3.00729629E-02 2.11346187E-02 1.23620284 1.77426003E-02 2.91808229E-02 6.02688026 8.55326504E-02 0.295172840 1.70159452E-02 1.62341073E-02 4.59006950E-02 1.53185744E-02 1.26378201E-02 0.127291888 1.25690866E-02 3.50214280E-02 1.38586915 1.49251269E-02 3.28066088E-02 2.83595324E-02 3.67067419E-02 3.63099091E-02 5.64056374E-02 0.210217670 2.22424045E-02 3.41364479 1.41310580E-02 + 990904415.15572822 191423.44387150949 14.5593815 4.03333807 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.57238918E-03 4.79270145E-02 6.14391491E-02 0.153797820 0.162239775 0.122022711 5.33579625E-02 6.03341199E-02 0.358682394 0.128895387 2.85240281E-02 2.59669963E-02 1.48285562E-02 6.05005957E-02 3.00919060E-02 2.11025942E-02 1.23455036 1.77300405E-02 2.91547589E-02 6.02631426 8.55131820E-02 0.295255721 1.70228183E-02 1.62258204E-02 4.58973497E-02 1.53180705E-02 1.26450695E-02 0.127299339 1.25656649E-02 3.50219943E-02 1.38682616 1.49207590E-02 3.28028910E-02 2.83649191E-02 3.66927199E-02 3.63066457E-02 5.63919768E-02 0.210201010 2.22471002E-02 3.41569662 1.41332923E-02 + 982868026.38717449 191832.89593757247 14.5424776 4.02977657 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.09436000E-02 4.76049818E-02 6.09426051E-02 0.153304115 0.160928398 0.121134378 5.31321466E-02 6.01298399E-02 0.358398885 0.128735855 2.83578839E-02 2.59365123E-02 1.46945408E-02 6.01456389E-02 3.00211739E-02 2.10545547E-02 1.23231447 1.77098960E-02 2.91272718E-02 6.01658583 8.55462998E-02 0.295295030 1.70115363E-02 1.62265655E-02 4.57645170E-02 1.53078958E-02 1.26317972E-02 0.127353400 1.25623653E-02 3.50057855E-02 1.38420403 1.49114607E-02 3.28020826E-02 2.83038244E-02 3.66699472E-02 3.62925753E-02 5.63883707E-02 0.210011482 2.22286303E-02 3.41262937 1.41282817E-02 + 974831637.61862075 191989.60201354994 14.5387812 4.02844048 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.23968832E-02 4.72820140E-02 6.05268180E-02 0.152626306 0.160201326 0.120647430 5.28620966E-02 6.10593446E-02 0.357355773 0.128441811 2.82737985E-02 2.58705486E-02 1.46808298E-02 6.00478053E-02 2.99963076E-02 2.10271217E-02 1.23133779 1.77161936E-02 2.91135870E-02 6.01638556 8.55596811E-02 0.295361280 1.70115680E-02 1.62176359E-02 4.57591116E-02 1.53045189E-02 1.26358001E-02 0.127302438 1.25699714E-02 3.50035504E-02 1.38408196 1.49125615E-02 3.28059271E-02 2.83084027E-02 3.66767533E-02 3.62965986E-02 5.63613512E-02 0.210012093 2.22181361E-02 3.41240025 1.41302655E-02 + 966795248.85006702 192280.98515375145 14.5213985 4.02079439 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.58066880E-02 4.69246581E-02 6.01935424E-02 0.151743203 0.159071743 0.120007992 5.24993390E-02 6.07565716E-02 0.354227304 0.125272617 2.82018371E-02 2.57845931E-02 1.46594662E-02 5.98935373E-02 2.99549103E-02 2.09616721E-02 1.22956109 1.76966190E-02 2.90571023E-02 6.01170540 8.54541659E-02 0.295281351 1.69988871E-02 1.62092503E-02 4.57246266E-02 1.53063536E-02 1.26335314E-02 0.127276793 1.25676738E-02 3.49796563E-02 1.38324845 1.49004338E-02 3.27894352E-02 2.82908808E-02 3.66661698E-02 3.62807550E-02 5.63400201E-02 0.209784865 2.22133547E-02 3.41035271 1.41211357E-02 + 958758860.08151329 192504.57610212822 14.5160513 4.01958466 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.80125386E-02 4.64748181E-02 5.98344617E-02 0.150849774 0.158299565 0.119748436 5.23221493E-02 6.06511757E-02 0.353682637 0.124920078 2.81615201E-02 2.57271938E-02 1.46360006E-02 5.97854517E-02 2.99114231E-02 2.09245905E-02 1.22897112 1.77019089E-02 2.90317647E-02 6.00975561 8.54002610E-02 0.294999689 1.69921592E-02 1.62058733E-02 4.57119532E-02 1.53071126E-02 1.26260100E-02 0.127301291 1.25674549E-02 3.49646583E-02 1.38289332 1.48842689E-02 3.28024998E-02 2.82811262E-02 3.66696455E-02 3.62796597E-02 5.63525185E-02 0.209772080 2.22035609E-02 3.41031146 1.41218379E-02 + 950722471.31295955 192724.49361943555 14.5151377 4.02536631 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.71898098E-02 4.61104475E-02 5.95366023E-02 0.150192320 0.157390445 0.119192638 5.20638488E-02 6.04057983E-02 0.352335572 0.124788247 2.80861203E-02 2.56266296E-02 1.46135660E-02 5.96496649E-02 2.98748929E-02 2.08884291E-02 1.22674274 1.76527351E-02 2.90153064E-02 6.00635433 8.53751600E-02 0.294954389 1.69941615E-02 1.62192341E-02 4.57097962E-02 1.53033584E-02 1.26256356E-02 0.127262518 1.25724394E-02 3.49585265E-02 1.38319075 1.48912026E-02 3.28163318E-02 2.82833092E-02 3.66719216E-02 3.62786315E-02 5.63589856E-02 0.209562764 2.22187582E-02 3.41105986 1.41212810E-02 + 942686082.54440582 192872.94666752487 14.5101566 4.02392626 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.45832903E-03 2.71794926E-02 4.58251387E-02 5.91966286E-02 0.149423763 0.156659737 0.118713416 5.18789031E-02 6.02553189E-02 0.351821214 0.124744505 2.80480832E-02 2.55655982E-02 1.46067906E-02 5.95955104E-02 2.98634190E-02 2.08791085E-02 1.22572601 1.76332109E-02 2.89944746E-02 6.00488138 8.53724480E-02 0.294868797 1.69904195E-02 1.62207987E-02 4.57188822E-02 1.53018497E-02 1.26248877E-02 0.127385482 1.25739202E-02 3.49842161E-02 1.38361025 1.48958322E-02 3.28147337E-02 2.82846224E-02 3.66832614E-02 3.62792872E-02 5.63437156E-02 0.209601179 2.22188625E-02 3.41031504 1.41183706E-02 + 934649693.77585208 193126.25648331104 14.4964790 4.02106714 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.44469415E-03 2.69463994E-02 4.55613509E-02 5.86809590E-02 0.148700938 0.155898318 0.118056946 5.17496988E-02 6.00339882E-02 0.350371897 0.123377480 2.79050805E-02 2.55407710E-02 1.45831183E-02 5.94590828E-02 2.98148002E-02 2.08054427E-02 1.22398686 1.76130608E-02 2.89684832E-02 5.99807215 8.52721184E-02 0.294688255 1.69725623E-02 1.62091237E-02 4.56426181E-02 1.52976364E-02 1.26168532E-02 0.127415776 1.25650968E-02 3.49733792E-02 1.38272119 1.48886489E-02 3.28092687E-02 2.82794815E-02 3.66808325E-02 3.62762213E-02 5.63538596E-02 0.209575549 2.22285725E-02 3.41031456 1.41265439E-02 + 926613305.00729835 193339.50697059039 14.4960423 4.02011824 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.35920076E-02 2.66435668E-02 4.52052690E-02 5.83838373E-02 0.148044273 0.154623702 0.118111521 5.23840785E-02 6.00098222E-02 0.349430948 0.123073973 2.78789327E-02 2.55117137E-02 1.45494081E-02 5.93345575E-02 2.96931434E-02 2.07653940E-02 1.22232044 1.75894648E-02 2.88989861E-02 5.99434090 8.53156447E-02 0.294652015 1.69836655E-02 1.62127074E-02 4.56365831E-02 1.53007321E-02 1.26199974E-02 0.127363294 1.25647662E-02 3.49490568E-02 1.38254631 1.48811927E-02 3.28007191E-02 2.81942822E-02 3.66951749E-02 3.62829790E-02 5.63449673E-02 0.209598988 2.22332031E-02 3.41035390 1.41276773E-02 + 918576916.23874462 193548.47012942901 14.4917126 4.01946354 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.53146209E-02 2.64637358E-02 4.49312516E-02 5.80166057E-02 0.147342831 0.153915867 0.117588140 5.21701574E-02 5.98448031E-02 0.348464280 0.123182632 2.78067719E-02 2.54836436E-02 1.45321796E-02 5.92450574E-02 2.96499562E-02 2.07471028E-02 1.22095263 1.75810512E-02 2.89172102E-02 5.99415016 8.52386877E-02 0.294597745 1.69700868E-02 1.62073337E-02 4.55997400E-02 1.52943740E-02 1.26026710E-02 0.127294123 1.25731463E-02 3.49552073E-02 1.38235497 1.48750413E-02 3.27869244E-02 2.81949118E-02 3.67049091E-02 3.63022238E-02 5.63678667E-02 0.209608167 2.22270060E-02 3.41053486 1.41200889E-02 + 910540527.47019088 193705.25235166898 14.5004139 4.01812840 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.04489434E-02 2.62863655E-02 4.46858965E-02 5.77734672E-02 0.146666899 0.153135315 0.117257155 5.20670377E-02 5.97522035E-02 0.347512960 0.122021832 2.77596470E-02 2.54216772E-02 1.45166432E-02 5.91917709E-02 2.95829903E-02 2.07227077E-02 1.22048533 1.75668169E-02 2.89436113E-02 5.99282360 8.52661729E-02 0.294595808 1.69694219E-02 1.61958970E-02 4.55944464E-02 1.52908685E-02 1.26043102E-02 0.127307966 1.25693865E-02 3.49648669E-02 1.38228893 1.48744928E-02 3.27915736E-02 2.81803273E-02 3.67007107E-02 3.62855978E-02 5.63687310E-02 0.209629372 2.22222023E-02 3.41096330 1.41273914E-02 + 902504138.70163715 193894.98962503579 14.4920778 4.01522493 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.25760171E-02 2.60772817E-02 4.44436148E-02 5.74377924E-02 0.145955727 0.152425990 0.116842903 5.18895797E-02 5.96038438E-02 0.346715033 0.121377632 2.77215671E-02 2.53714230E-02 1.44919828E-02 5.91673888E-02 2.95663364E-02 2.06804797E-02 1.21879041 1.75581090E-02 2.89400946E-02 5.99082851 8.52102190E-02 0.294301540 1.69491526E-02 1.61960926E-02 4.55614887E-02 1.53053897E-02 1.26041155E-02 0.127316877 1.25673469E-02 3.49362642E-02 1.38213897 1.48751577E-02 3.27901207E-02 2.81728078E-02 3.66977230E-02 3.62289809E-02 5.63463122E-02 0.209560528 2.22176500E-02 3.40951538 1.41246915E-02 + 894467749.93308342 194060.09389022776 14.4883499 4.01434374 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.25476252E-03 3.26550491E-02 2.58830134E-02 4.41369154E-02 5.70934117E-02 0.145384893 0.151498482 0.116319075 5.17243259E-02 5.94184771E-02 0.345800728 0.120728523 2.76418235E-02 2.53030937E-02 1.44676995E-02 5.90817556E-02 2.93362495E-02 2.06358414E-02 1.21764183 1.75452679E-02 2.89188810E-02 5.99090099 8.52107778E-02 0.294332057 1.69589054E-02 1.62028391E-02 4.55792733E-02 1.53086260E-02 1.26036135E-02 0.127373800 1.25687970E-02 3.49422097E-02 1.38226175 1.48727112E-02 3.27871963E-02 2.81911902E-02 3.67179886E-02 3.62669192E-02 5.63706495E-02 0.209779695 2.22191159E-02 3.41030264 1.41255967E-02 + 886431361.16452968 194405.12953338257 14.4795933 4.01304770 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.81447531E-03 3.24049555E-02 2.56402213E-02 4.38991748E-02 5.68246208E-02 0.144828945 0.150556043 0.115750067 5.14375679E-02 5.92549480E-02 0.344843715 0.120632835 2.75639705E-02 2.52043400E-02 1.44300582E-02 5.89014031E-02 2.92999893E-02 2.05908194E-02 1.21512187 1.75296888E-02 2.88631991E-02 5.98819685 8.51527527E-02 0.294181377 1.69423241E-02 1.61922760E-02 4.55649048E-02 1.53033789E-02 1.25990603E-02 0.127224877 1.25645353E-02 3.48477550E-02 1.38126516 1.48774302E-02 3.27936113E-02 2.81839073E-02 3.67067680E-02 3.62666845E-02 5.63602522E-02 0.209735632 2.22171452E-02 3.40989733 1.41261751E-02 + 878394972.39597595 194546.82618755719 14.4759035 4.01271868 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.24343520E-03 3.21906321E-02 2.54741888E-02 4.36726585E-02 5.64969145E-02 0.144213170 0.149777710 0.115429386 5.12830056E-02 5.91401793E-02 0.344196945 0.120014340 2.75577307E-02 2.51646005E-02 1.44172786E-02 5.88378645E-02 2.92896125E-02 2.05602609E-02 1.21383071 1.75239146E-02 2.88396981E-02 5.98805475 8.51528049E-02 0.294178933 1.69426203E-02 1.61895715E-02 4.55611274E-02 1.52913863E-02 1.25978263E-02 0.127093017 1.25607420E-02 3.48318443E-02 1.38150251 1.48754641E-02 3.27950679E-02 2.81840581E-02 3.67078930E-02 3.62530313E-02 5.63770942E-02 0.209686682 2.22195443E-02 3.41056490 1.41288945E-02 + 870358583.62742221 194973.69123389325 16.0789280 4.00769949 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.62586832 3.18952836E-02 2.52754875E-02 4.33145314E-02 5.61893769E-02 0.143428817 0.148734123 0.115004957 5.10533564E-02 5.89020140E-02 0.342581898 0.118969180 2.74718255E-02 2.50948127E-02 1.43872015E-02 5.87204546E-02 2.92598754E-02 2.05363110E-02 1.21261799 1.74594689E-02 2.87974663E-02 5.98364019 8.50957558E-02 0.293876737 1.69309303E-02 1.61848702E-02 4.55140956E-02 1.53007656E-02 1.25879366E-02 0.127036050 1.25539359E-02 3.48134972E-02 1.38046789 1.48622571E-02 3.27649936E-02 2.81654950E-02 3.66907604E-02 3.62149924E-02 5.63251153E-02 0.209576577 2.22074036E-02 3.40844059 1.41154239E-02 + 862322194.85886848 195328.01533470242 16.0428410 3.99955297 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.61735249 3.16239111E-02 2.50932500E-02 4.30532694E-02 5.59263006E-02 0.142424718 0.147797421 0.114390589 5.08563779E-02 5.87432645E-02 0.339955419 0.118645556 2.72909179E-02 2.50554606E-02 1.43552003E-02 5.85506149E-02 2.92311963E-02 2.04166714E-02 1.21043408 1.74244810E-02 2.86664423E-02 5.97511578 8.49759057E-02 0.293431550 1.68942809E-02 1.61504243E-02 4.54793572E-02 1.52622899E-02 1.25764115E-02 0.126844272 1.25394203E-02 3.47736292E-02 1.37768257 1.48386862E-02 3.27080525E-02 2.81159263E-02 3.66655961E-02 3.61954942E-02 5.62243462E-02 0.209318340 2.21753605E-02 3.40348172 1.41031118E-02 + 854285806.09031475 196788.48676329371 15.9812460 3.98463416 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.63528836 3.11959721E-02 2.48023011E-02 4.23069187E-02 5.55424578E-02 0.139915109 0.147208750 0.113900647 5.04411608E-02 5.84152974E-02 0.338184297 0.118529148 2.71688644E-02 2.49348599E-02 1.41964946E-02 5.83107285E-02 2.91151833E-02 2.02829074E-02 1.20103133 1.73193049E-02 2.85437442E-02 5.95347929 8.43890458E-02 0.290885061 1.67656634E-02 1.60306543E-02 4.53383513E-02 1.51296556E-02 1.25258695E-02 0.126741990 1.24331368E-02 3.46446186E-02 1.36649692 1.47252688E-02 3.25808264E-02 2.79575102E-02 3.64356041E-02 3.60553078E-02 5.60721904E-02 0.208649755 2.20424384E-02 3.38154626 1.36850150E-02 + 846249417.32176101 197341.28419513995 16.1005535 3.97620225 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.144975439 1.63528430 3.09135262E-02 2.46069282E-02 4.20182794E-02 5.52274361E-02 0.139145479 0.146543890 0.113445185 5.02381548E-02 5.82643002E-02 0.337005138 0.118053786 2.71096881E-02 2.48228107E-02 1.41637549E-02 5.83337247E-02 2.91035343E-02 2.02500224E-02 1.19773340 1.73027776E-02 2.85168700E-02 5.94617510 8.42451453E-02 0.290386289 1.67642049E-02 1.59947220E-02 4.51039821E-02 1.51157677E-02 1.25131803E-02 0.126649901 1.23977605E-02 3.45993936E-02 1.36506808 1.47098051E-02 3.25551182E-02 2.79271603E-02 3.64116281E-02 3.59803140E-02 5.59838265E-02 0.208508536 2.20167320E-02 3.37470722 1.36811957E-02 + 838213028.55320728 197582.11853422274 16.0827007 3.97582793 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.146892488 1.62257254 3.06549054E-02 2.44231466E-02 4.18084301E-02 5.50414845E-02 0.138597414 0.145701513 0.113070644 5.01146317E-02 5.80309555E-02 0.336497158 0.117794812 2.70502958E-02 2.47410033E-02 1.41336964E-02 5.82390130E-02 2.90783420E-02 2.02214215E-02 1.19544697 1.72815770E-02 2.84377951E-02 5.94553852 8.42124298E-02 0.290232629 1.67644862E-02 1.59920156E-02 4.50804494E-02 1.50988270E-02 1.25112711E-02 0.126640871 1.23865986E-02 3.45826969E-02 1.36484182 1.47121046E-02 3.25407498E-02 2.79314555E-02 3.64002176E-02 3.59714031E-02 5.59745431E-02 0.208500385 2.20188573E-02 3.37525702 1.36818942E-02 + 830176639.78465354 197759.38207562073 16.0645599 3.97419024 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.147275358 1.61106133 3.04665100E-02 2.42889710E-02 4.16356213E-02 5.47934733E-02 0.138091102 0.145194203 0.112830997 5.00295274E-02 5.79486415E-02 0.335665882 0.117658056 2.70221382E-02 2.46892683E-02 1.41207734E-02 5.81596978E-02 2.90886555E-02 2.01988127E-02 1.19421828 1.72805395E-02 2.84084380E-02 5.94384909 8.42163265E-02 0.290243685 1.67713650E-02 1.59988012E-02 4.50945161E-02 1.50864422E-02 1.25067048E-02 0.126514822 1.23798186E-02 3.45667265E-02 1.36478710 1.47160506E-02 3.25378701E-02 2.79227700E-02 3.64154279E-02 3.59656215E-02 5.59624508E-02 0.208471388 2.20196042E-02 3.37472534 1.36833489E-02 + 822140251.01609981 197920.86744702442 16.0479851 3.97363281 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.147713661 1.60061347 3.02986205E-02 2.41909288E-02 4.14364897E-02 5.46362661E-02 0.137803838 0.144787684 0.112545192 4.99174707E-02 5.78895472E-02 0.335009277 0.117507406 2.69872472E-02 2.46642642E-02 1.41116874E-02 5.81338927E-02 2.90526580E-02 2.01869067E-02 1.19324362 1.72586981E-02 2.83809323E-02 5.94090652 8.40828419E-02 0.290043980 1.67610124E-02 1.60001423E-02 4.50803041E-02 1.50822354E-02 1.25064049E-02 0.126530096 1.23789590E-02 3.45677659E-02 1.36479700 1.47129064E-02 3.25375386E-02 2.79267654E-02 3.64128500E-02 3.59587297E-02 5.59609458E-02 0.208552375 2.20224261E-02 3.37511349 1.36835985E-02 + 814103862.24754608 198117.85859174698 16.0400982 3.97274637 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.157334775 1.59016502 3.00880987E-02 2.40598097E-02 4.12720703E-02 5.44988401E-02 0.137431577 0.144288152 0.112364404 4.98500615E-02 5.78419939E-02 0.333605140 0.117139272 2.69230306E-02 2.46450994E-02 1.40990550E-02 5.80559857E-02 2.89705135E-02 2.01724693E-02 1.19166648 1.72347333E-02 2.83458121E-02 5.93972874 8.40283856E-02 0.289898336 1.67498998E-02 1.59950592E-02 4.50765677E-02 1.50713585E-02 1.25005534E-02 0.126454696 1.23656970E-02 3.45423333E-02 1.36410666 1.46994740E-02 3.25174406E-02 2.79165730E-02 3.64034250E-02 3.59308496E-02 5.59754707E-02 0.208510920 2.20403075E-02 3.37584448 1.36898179E-02 + 806067473.47899234 198461.71487497166 16.0134296 3.96774721 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.170096502 1.57336807 2.96610650E-02 2.38155108E-02 4.10638191E-02 5.41663580E-02 0.136816621 0.143412232 0.111921050 4.96312492E-02 5.76092936E-02 0.332722455 0.117214911 2.68001501E-02 2.45830640E-02 1.40567133E-02 5.79191335E-02 2.89391857E-02 2.01129168E-02 1.18941689 1.72063001E-02 2.83161886E-02 5.93124819 8.39451477E-02 0.289588422 1.67274047E-02 1.59829836E-02 4.50131260E-02 1.50473388E-02 1.25756329E-02 0.126509070 1.23590976E-02 3.45442891E-02 1.36186695 1.46868769E-02 3.25131267E-02 2.79093087E-02 3.63688730E-02 3.59350070E-02 5.59782535E-02 0.208347633 2.19898112E-02 3.37177682 1.36681413E-02 + 798031084.71043861 198584.30649251927 16.0000515 3.96645308 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.12591811E-04 0.169829786 1.56327021 2.94867456E-02 2.36594845E-02 4.07502241E-02 5.39938472E-02 0.136379987 0.142912060 0.111723267 4.95198667E-02 5.75752780E-02 0.332175672 0.116993420 2.67447550E-02 2.45692208E-02 1.40487943E-02 5.78629747E-02 2.89342701E-02 2.01099142E-02 1.18953025 1.72110591E-02 2.83203907E-02 5.93111706 8.39682743E-02 0.289609671 1.67318769E-02 1.59833804E-02 4.50037681E-02 1.50456121E-02 1.25637222E-02 0.126472220 1.23568978E-02 3.45693976E-02 1.36200297 1.46831358E-02 3.25114504E-02 2.79080700E-02 3.63689736E-02 3.59373018E-02 5.59941195E-02 0.208438307 2.19881162E-02 3.37131333 1.36697581E-02 + 789994695.94188488 198726.04976089575 15.9891539 3.96645999 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.20106046E-03 0.168731928 1.55318677 2.93155797E-02 2.35289708E-02 4.05656956E-02 5.37896790E-02 0.136050001 0.142465964 0.111447059 4.94283140E-02 5.74931353E-02 0.331455350 0.116799414 2.67122183E-02 2.45442726E-02 1.40359988E-02 5.78217171E-02 2.89473012E-02 2.00801454E-02 1.18892789 1.72089580E-02 2.83195022E-02 5.92990351 8.39746669E-02 0.289729238 1.67366285E-02 1.59893874E-02 4.50317860E-02 1.50488764E-02 1.25707248E-02 0.126544073 1.23638781E-02 3.45676206E-02 1.36290991 1.46876639E-02 3.25421207E-02 2.79287584E-02 3.63774151E-02 3.59434858E-02 5.60014918E-02 0.208449736 2.20006388E-02 3.37212753 1.36693437E-02 + 781958307.17333114 198873.40298514374 15.9758463 3.96664619 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.58730401E-03 0.167484760 1.54035640 2.91243680E-02 2.33587697E-02 4.03828956E-02 5.36085702E-02 0.135605186 0.141801119 0.111179650 4.93410379E-02 5.73158376E-02 0.330736876 0.116571538 2.66697016E-02 2.45133750E-02 1.40302675E-02 5.77866398E-02 2.89894957E-02 2.00453661E-02 1.18889201 1.72068533E-02 2.83208247E-02 5.93041372 8.39482546E-02 0.289869875 1.67458709E-02 1.59955304E-02 4.50328030E-02 1.50507661E-02 1.25709204E-02 0.126500621 1.23599125E-02 3.45547833E-02 1.36298001 1.46892145E-02 3.25453095E-02 2.79368609E-02 3.63781713E-02 3.59381735E-02 5.60446568E-02 0.208508223 2.20088512E-02 3.37319350 1.36707863E-02 + 773921918.40477741 198969.34047801778 15.9677858 3.96579456 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.48249549E-03 0.166304171 1.53134704 2.89383475E-02 2.32594460E-02 4.02364358E-02 5.34582362E-02 0.135270774 0.141365662 0.110973738 4.92264964E-02 5.72583452E-02 0.330042839 0.116616286 2.66610980E-02 2.45015267E-02 1.40226102E-02 5.77774979E-02 2.89911013E-02 2.00315956E-02 1.18862164 1.72043089E-02 2.83270273E-02 5.93166065 8.39702934E-02 0.289951086 1.67499073E-02 1.59986932E-02 4.50274684E-02 1.50562916E-02 1.25709698E-02 0.126461118 1.23604815E-02 3.45539488E-02 1.36324453 1.46898860E-02 3.25704180E-02 2.79403310E-02 3.63916010E-02 3.59663852E-02 5.60499057E-02 0.208491340 2.20065378E-02 3.37248445 1.36692617E-02 + 765885529.63622367 199143.05187716859 15.9620171 3.97681570 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.59440227E-02 0.165071264 1.51892614 2.87573468E-02 2.31423583E-02 4.00391743E-02 5.31468540E-02 0.134913087 0.140535206 0.121074930 4.93736751E-02 5.72972633E-02 0.330441952 0.116627760 2.67563332E-02 2.44844612E-02 1.40139721E-02 5.76996431E-02 2.89675668E-02 2.00261772E-02 1.18736506 1.71794947E-02 2.82971170E-02 5.92693710 8.39890838E-02 0.289924890 1.67612080E-02 1.59871206E-02 4.49886173E-02 1.50707308E-02 1.25665860E-02 0.126500279 1.23491250E-02 3.45615745E-02 1.36348522 1.46847116E-02 3.25639918E-02 2.79400032E-02 3.63818929E-02 3.59495617E-02 5.60257994E-02 0.208478346 2.19964087E-02 3.37112689 1.36683863E-02 + 757849140.86766994 199739.29539729640 15.8814154 3.97984409 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.29418045E-02 0.163829014 1.49813604 2.84870360E-02 2.28657220E-02 3.97106372E-02 5.24184667E-02 0.134484932 0.139697477 0.120671108 4.91110645E-02 5.57163879E-02 0.328783363 0.115890764 2.66487245E-02 2.43949797E-02 1.39597207E-02 5.73198237E-02 2.89505962E-02 1.99718531E-02 1.18070686 1.71437971E-02 2.81901322E-02 5.84539557 8.38803723E-02 0.288211852 1.66501552E-02 1.59503315E-02 4.49140854E-02 1.50528764E-02 1.25379302E-02 0.126422629 1.23364208E-02 3.45152207E-02 1.36028218 1.46711301E-02 3.25676315E-02 2.79179029E-02 3.61330099E-02 3.59390341E-02 5.60165159E-02 0.208426073 2.19520051E-02 3.36795115 1.36593916E-02 + 749812752.09911621 199920.76119153653 15.8628731 3.97850466 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.79885020E-05 6.47255927E-02 0.162494287 1.48663950 2.83305999E-02 2.27344744E-02 3.95110883E-02 5.22544049E-02 0.133972913 0.139005259 0.120462112 4.90150750E-02 5.56232184E-02 0.328318447 0.115750894 2.66269464E-02 2.43432466E-02 1.39455097E-02 5.72640896E-02 2.88567189E-02 1.99534371E-02 1.17940795 1.71395484E-02 2.81739663E-02 5.84355259 8.38594437E-02 0.287965298 1.66324358E-02 1.59411319E-02 4.49001864E-02 1.50507623E-02 1.25349825E-02 0.126407191 1.23302285E-02 3.45199779E-02 1.35978556 1.46632874E-02 3.25760506E-02 2.79070251E-02 3.61002125E-02 3.59226651E-02 5.59576713E-02 0.208440840 2.19481755E-02 3.36761975 1.36603890E-02 + 741776363.33056247 200178.40466439177 15.8478231 3.97936749 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.20678097E-03 6.41304329E-02 0.161154673 1.47709417 2.81563289E-02 2.26133019E-02 3.93884555E-02 5.20408414E-02 0.133298784 0.138688147 0.120178886 4.89231944E-02 5.56110665E-02 0.327935815 0.115851142 2.65766867E-02 2.43326984E-02 1.39262397E-02 5.72297275E-02 2.88433246E-02 1.99299939E-02 1.17914093 1.71401463E-02 2.81553939E-02 5.84028149 8.38293582E-02 0.288012683 1.66401379E-02 1.59430038E-02 4.48931567E-02 1.50497844E-02 1.25275161E-02 0.126405194 1.23296808E-02 3.45159844E-02 1.35861778 1.46555472E-02 3.25553641E-02 2.78970525E-02 3.60994227E-02 3.59025635E-02 5.58877699E-02 0.208472759 2.19584741E-02 3.36616349 1.36387134E-02 + 733739974.56200874 200420.16762929369 15.8307247 3.97517037 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.43205570E-02 6.37588948E-02 0.159822747 1.46804404 2.79940329E-02 2.24964637E-02 3.89117040E-02 5.19396253E-02 0.132852405 0.138136342 0.119909510 4.87950705E-02 5.54882362E-02 0.327681541 0.115665138 2.65721176E-02 2.42539588E-02 1.39052030E-02 5.71552180E-02 2.88271867E-02 1.99176986E-02 1.17725098 1.71301905E-02 2.80893799E-02 5.83608484 8.37722495E-02 0.287896037 1.66332349E-02 1.59093831E-02 4.48618941E-02 1.50322644E-02 1.25176022E-02 0.126072586 1.23082837E-02 3.44264992E-02 1.35714149 1.46340923E-02 3.24419849E-02 2.78785899E-02 3.60774547E-02 3.56483534E-02 5.58160134E-02 0.208342731 2.18619406E-02 3.36281633 1.36319874E-02 + 725703585.79345500 200611.70163802622 15.8460836 3.97429466 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.89566780E-02 6.32181466E-02 0.158874497 1.48369718 2.79085860E-02 2.23811623E-02 3.87791619E-02 5.15861325E-02 0.132535025 0.137644857 0.119746335 4.87147793E-02 5.54690920E-02 0.327632368 0.115587063 2.65727602E-02 2.42341179E-02 1.38114551E-02 5.71128279E-02 2.88075991E-02 1.99072994E-02 1.17652524 1.71258301E-02 2.80926954E-02 5.83597803 8.38021040E-02 0.287998438 1.66380499E-02 1.59127396E-02 4.48765606E-02 1.50254294E-02 1.25176664E-02 0.126067087 1.23083172E-02 3.44241187E-02 1.35704005 1.46310087E-02 3.24274600E-02 2.78732479E-02 3.60728242E-02 3.56405936E-02 5.57930171E-02 0.208367497 2.18561180E-02 3.36228371 1.36293210E-02 + 717667197.02490127 200809.13539072493 15.8344631 3.97365212 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.30079331E-02 6.28319904E-02 0.157987416 1.47483838 2.77801156E-02 2.23017633E-02 3.86751145E-02 5.14061265E-02 0.132293910 0.137151107 0.119433336 4.85847704E-02 5.54289147E-02 0.327094465 0.114906497 2.65476294E-02 2.42059901E-02 1.37944445E-02 5.70289046E-02 2.87550725E-02 1.99128333E-02 1.17548490 1.71252191E-02 2.80916709E-02 5.83367968 8.38575438E-02 0.287996322 1.66343711E-02 1.59145575E-02 4.48757261E-02 1.50242085E-02 1.25188855E-02 0.126066685 1.23091694E-02 3.44250910E-02 1.35727048 1.46329589E-02 3.24282572E-02 2.78737564E-02 3.60750556E-02 3.56667973E-02 5.57871982E-02 0.208387002 2.18655635E-02 3.36287665 1.36293517E-02 + 709630808.25634754 201051.87333495959 15.8292379 3.97716546 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.02777269E-02 6.23233281E-02 0.156686008 1.46448016 2.75740400E-02 2.21601371E-02 3.84735055E-02 5.11865169E-02 0.131696954 0.136557177 0.118923478 4.84136753E-02 5.52944057E-02 0.326040477 0.114168614 2.64639854E-02 2.41891611E-02 1.37623856E-02 5.69677874E-02 2.87599172E-02 1.98915452E-02 1.17409456 1.70886591E-02 2.80831121E-02 5.83079863 8.38464424E-02 0.287848920 1.66303217E-02 1.59233883E-02 4.48243544E-02 1.50272436E-02 1.25130890E-02 0.125987157 1.23083396E-02 3.44289765E-02 1.35693908 1.46305971E-02 3.24057005E-02 2.78491452E-02 3.60663645E-02 3.56557854E-02 5.57732768E-02 0.208357528 2.18699183E-02 3.36236930 1.36268958E-02 + 701594419.48779380 201329.93152491373 15.8114872 3.97496319 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.35033776E-02 6.19998500E-02 0.155436024 1.45555222 2.73638573E-02 2.20632628E-02 3.83512489E-02 5.10084294E-02 0.131142750 0.136091828 0.118765786 4.82651442E-02 5.52446246E-02 0.325469226 0.114089578 2.64224596E-02 2.41622645E-02 1.37437657E-02 5.69326803E-02 2.87427362E-02 1.98699459E-02 1.17247045 1.70736518E-02 2.80726086E-02 5.82923079 8.36490765E-02 0.287477404 1.66159309E-02 1.59072187E-02 4.47660610E-02 1.50123155E-02 1.25059346E-02 0.125829488 1.23003758E-02 3.43825258E-02 1.35456562 1.45977773E-02 3.23283374E-02 2.78240386E-02 3.60494480E-02 3.56184244E-02 5.56673072E-02 0.208300963 2.18670797E-02 3.36152482 1.36267124E-02 + 693558030.71924007 201517.80770772821 15.8024273 3.97334385 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.14342303E-03 4.33754250E-02 6.16980121E-02 0.154638380 1.44954145 2.72377469E-02 2.19903160E-02 3.82276736E-02 5.09435162E-02 0.130976200 0.135873064 0.118737869 4.81832400E-02 5.51943071E-02 0.325188339 0.112858415 2.63992492E-02 2.41630524E-02 1.37406737E-02 5.69011457E-02 2.87158862E-02 1.98480897E-02 1.17223167 1.70554854E-02 2.80832853E-02 5.82898855 8.36414322E-02 0.287549943 1.66161153E-02 1.59115642E-02 4.47678305E-02 1.50065366E-02 1.25055909E-02 0.125775576 1.23005752E-02 3.43489200E-02 1.35462689 1.46046067E-02 3.23091708E-02 2.78208684E-02 3.60480137E-02 3.55997458E-02 5.56684881E-02 0.208327010 2.18684003E-02 3.36157155 1.36262393E-02 + 685521641.95068634 201773.89772672608 15.7863522 3.97158670 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.25115617E-03 4.29548919E-02 6.12504333E-02 0.153287515 1.44200563 2.70635467E-02 2.18886156E-02 3.80672961E-02 5.08286506E-02 0.130304530 0.135624871 0.118401773 4.80464287E-02 5.50472103E-02 0.324719816 0.112500131 2.63426397E-02 2.40875706E-02 1.37399537E-02 5.68274930E-02 2.86773536E-02 1.98125057E-02 1.17061841 1.70325916E-02 2.80461609E-02 5.82483435 8.36595446E-02 0.287439913 1.66122373E-02 1.59058683E-02 4.47385982E-02 1.50153982E-02 1.25043131E-02 0.125657171 1.23005649E-02 3.43133323E-02 1.35392249 1.45976329E-02 3.22809182E-02 2.78298017E-02 3.60502563E-02 3.56043242E-02 5.56862615E-02 0.208283290 2.18663830E-02 3.36119390 1.36257131E-02 + 677485253.18213260 201934.64410137563 15.7748051 3.96983743 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.57719094E-03 4.26618010E-02 6.08609691E-02 0.152357936 1.43456054 2.69243568E-02 2.18094159E-02 3.79524119E-02 5.07952981E-02 0.130001083 0.135240778 0.118277207 4.79394980E-02 5.49659058E-02 0.323983163 0.112083778 2.62892544E-02 2.40678601E-02 1.37291746E-02 5.67740873E-02 2.86420789E-02 1.97829995E-02 1.17022133 1.70314293E-02 2.80333702E-02 5.82447386 8.36698934E-02 0.287494302 1.66053195E-02 1.59210768E-02 4.47335392E-02 1.50121385E-02 1.25063537E-02 0.125646472 1.23006832E-02 3.42966244E-02 1.35397661 1.45994294E-02 3.22814733E-02 2.78386902E-02 3.60583961E-02 3.55883054E-02 5.56806996E-02 0.208274260 2.18624249E-02 3.36079669 1.36249103E-02 + 669448864.41357887 202176.70639865665 15.7653208 3.97187233 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.67464782E-02 4.23042476E-02 6.04028441E-02 0.151166245 1.42650712 2.67826114E-02 2.16752160E-02 3.78825702E-02 5.09867631E-02 0.129656300 0.134894863 0.118049793 4.78103720E-02 5.48605286E-02 0.323210746 0.111692116 2.62629986E-02 2.39764620E-02 1.37308016E-02 5.66885434E-02 2.86049359E-02 1.97875611E-02 1.16811037 1.70064680E-02 2.79975440E-02 5.82402658 8.36861804E-02 0.287503868 1.65896416E-02 1.58972386E-02 4.47048023E-02 1.50070023E-02 1.25140306E-02 0.125356078 1.22930193E-02 3.37689146E-02 1.35322118 1.45988176E-02 3.21693160E-02 2.78413389E-02 3.60699557E-02 3.53799053E-02 5.55699281E-02 0.208146706 2.18510926E-02 3.35869551 1.36361700E-02 + 661412475.64502513 202296.82696179021 15.7455721 3.97055912 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.13004034E-02 4.19852883E-02 6.00003377E-02 0.150303915 1.41661990 2.66050231E-02 2.14989111E-02 3.77319418E-02 5.08470796E-02 0.129438818 0.134274438 0.117721312 4.76884544E-02 5.48525974E-02 0.321672380 0.111534119 2.62113363E-02 2.39578448E-02 1.36809601E-02 5.65935038E-02 2.85751298E-02 1.97604150E-02 1.16679990 1.70008559E-02 2.79793870E-02 5.81771088 8.36542994E-02 0.287424237 1.65883172E-02 1.59063861E-02 4.46903631E-02 1.50041860E-02 1.25104822E-02 0.125305325 1.22913690E-02 3.37640233E-02 1.35263550 1.45957293E-02 3.21592651E-02 2.78772842E-02 3.60999964E-02 3.53608131E-02 5.55815175E-02 0.208109513 2.18496975E-02 3.35818338 1.36368098E-02 + 653376086.87647140 202488.12076220816 15.7341671 3.96860814 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.27421112E-02 4.16645333E-02 5.96003756E-02 0.149190962 1.40839696 2.64744814E-02 2.13944409E-02 3.75810452E-02 5.06824590E-02 0.129159883 0.133797020 0.117540926 4.75916602E-02 5.48024811E-02 0.321324885 0.111440569 2.61746198E-02 2.39417162E-02 1.36848427E-02 5.65973669E-02 2.85733752E-02 1.97247453E-02 1.16569340 1.69831458E-02 2.79765315E-02 5.81942558 8.36301222E-02 0.287354738 1.65872723E-02 1.59076899E-02 4.47012894E-02 1.49749620E-02 1.25145940E-02 0.125303745 1.22963162E-02 3.37722823E-02 1.35285318 1.46016385E-02 3.21801566E-02 2.78891400E-02 3.61045413E-02 3.53657044E-02 5.55806570E-02 0.208021566 2.18180474E-02 3.35691547 1.36341853E-02 + 645339698.10791767 202636.43764417819 15.7266874 3.96864629 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.46027751E-04 2.29755733E-02 4.13697958E-02 5.92274293E-02 0.148369998 1.40164018 2.63685286E-02 2.13310681E-02 3.75020169E-02 5.05839735E-02 0.128880680 0.133543089 0.117425255 4.75399382E-02 5.47961965E-02 0.321236581 0.111635663 2.61545423E-02 2.39267088E-02 1.36787612E-02 5.66023327E-02 2.85783950E-02 1.97234061E-02 1.16527426 1.69792697E-02 2.79822219E-02 5.82019472 8.36462602E-02 0.287395060 1.65868290E-02 1.59094390E-02 4.46981750E-02 1.49756763E-02 1.25165563E-02 0.125333548 1.23015791E-02 3.37766521E-02 1.35280764 1.46044753E-02 3.21836881E-02 2.78894920E-02 3.60984541E-02 3.53646241E-02 5.55781424E-02 0.208029389 2.18175966E-02 3.35706449 1.36435544E-02 + 637303309.33936393 202762.68405127971 15.7043343 3.95743823 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.48483988E-03 2.28188690E-02 4.11227793E-02 5.89005314E-02 0.147522375 1.39492631 2.62653157E-02 2.12419387E-02 3.74302901E-02 5.04999906E-02 0.128719151 0.133160770 0.108924419 4.72643487E-02 5.45988344E-02 0.318125933 0.112012453 2.59809289E-02 2.38971766E-02 1.36735188E-02 5.65573461E-02 2.84939054E-02 1.97102185E-02 1.16504240 1.69756375E-02 2.79951897E-02 5.81819439 8.35862756E-02 0.287301391 1.65844131E-02 1.59088317E-02 4.46985550E-02 1.49758402E-02 1.25133265E-02 0.125390351 1.22927614E-02 3.37795317E-02 1.35300767 1.46079054E-02 3.21878642E-02 2.78822035E-02 3.60916145E-02 3.53640653E-02 5.55655546E-02 0.207933605 2.18221806E-02 3.35665941 1.36435926E-02 + 629266920.57081020 202930.54773470445 15.7781553 3.95652771 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.84978920E-02 2.26396043E-02 4.08123955E-02 5.85290827E-02 0.146583423 1.38780463 2.61452701E-02 2.11349800E-02 3.73124070E-02 5.03715314E-02 0.128238589 0.132852525 0.108712293 4.71857786E-02 5.45859560E-02 0.317698270 0.111649372 2.59410795E-02 2.38592159E-02 1.36671225E-02 5.65250441E-02 2.84782536E-02 1.97023116E-02 1.16411161 1.69605613E-02 2.79940255E-02 5.81820679 8.36060718E-02 0.287331313 1.65870413E-02 1.59080997E-02 4.46863808E-02 1.49774663E-02 1.25136813E-02 0.125437915 1.22916093E-02 3.37893814E-02 1.35306454 1.46028157E-02 3.21944803E-02 2.78880168E-02 3.60901579E-02 3.53688560E-02 5.55476546E-02 0.207906529 2.18213648E-02 3.35669541 1.36464974E-02 + 621230531.80225646 203095.89264860706 15.8222752 3.95522237 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.144750118 2.24963967E-02 4.05576229E-02 5.81007488E-02 0.145793110 1.38137841 2.60243975E-02 2.10584383E-02 3.69860902E-02 5.02476878E-02 0.127941072 0.132569045 0.108551487 4.70892303E-02 5.45425527E-02 0.317059070 0.111552775 2.58907899E-02 2.38441061E-02 1.36637846E-02 5.64840212E-02 2.84787230E-02 1.96953788E-02 1.16406286 1.69517193E-02 2.79747713E-02 5.81747723 8.35329592E-02 0.287136704 1.65568292E-02 1.58959273E-02 4.46568802E-02 1.49330664E-02 1.25125479E-02 0.125450715 1.22911641E-02 3.37894261E-02 1.35285556 1.45994602E-02 3.21940333E-02 2.79063042E-02 3.60956304E-02 3.53688411E-02 5.55477887E-02 0.207856119 2.18333360E-02 3.35640073 1.36399213E-02 + 613194143.03370273 203268.56218653714 15.8141146 3.95437121 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.145991117 2.23328006E-02 4.02768925E-02 5.78146987E-02 0.144948453 1.37611330 2.59357225E-02 2.09883470E-02 3.68748680E-02 5.00244834E-02 0.127644330 0.132404342 0.108390160 4.70548607E-02 5.45214638E-02 0.316887558 0.111547641 2.58870833E-02 2.38210708E-02 1.36589939E-02 5.64800985E-02 2.84735747E-02 1.97000708E-02 1.16406667 1.69429276E-02 2.79766805E-02 5.81692934 8.35292116E-02 0.287135571 1.65551957E-02 1.58859007E-02 4.46587466E-02 1.49310064E-02 1.25101581E-02 0.125372484 1.22848004E-02 3.38051468E-02 1.35269904 1.45966625E-02 3.21889259E-02 2.79078446E-02 3.61035876E-02 3.53654996E-02 5.55379838E-02 0.207865238 2.18286961E-02 3.35604072 1.36244670E-02 + 605157754.26514900 203435.10893381038 15.7984610 3.95398331 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.147273511 2.21841782E-02 3.99163999E-02 5.74723221E-02 0.143922418 1.36894071 2.58101020E-02 2.08889246E-02 3.67218927E-02 4.98748384E-02 0.127432451 0.131965905 0.108113714 4.69895005E-02 5.44769689E-02 0.316596001 0.111514241 2.58503836E-02 2.37958077E-02 1.36508420E-02 5.64209968E-02 2.84400284E-02 1.96821634E-02 1.16296530 1.68953575E-02 2.79769599E-02 5.81305790 8.35850537E-02 0.287255079 1.65556092E-02 1.58806276E-02 4.46372181E-02 1.48354778E-02 1.25077646E-02 0.124891080 1.22709032E-02 3.37957479E-02 1.35232162 1.45905772E-02 3.21621336E-02 2.78960168E-02 3.60999592E-02 3.53166871E-02 5.55458963E-02 0.207917288 2.18317639E-02 3.35610223 1.36335613E-02 + 597121365.49659526 203585.82793303541 15.7865458 3.95289969 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.40299019E-03 0.147311106 2.20167879E-02 3.96678336E-02 5.71675003E-02 0.143210098 1.36359143 2.57049948E-02 2.08196472E-02 3.66057158E-02 4.97666113E-02 0.127174944 0.131789356 0.107987806 4.69309315E-02 5.43235429E-02 0.315937698 0.111647576 2.57902555E-02 2.37708483E-02 1.36461686E-02 5.62843457E-02 2.84216125E-02 1.96752977E-02 1.16192317 1.68885328E-02 2.79684812E-02 5.81051302 8.35245848E-02 0.287031025 1.65454391E-02 1.58782750E-02 4.46245223E-02 1.48321623E-02 1.25048216E-02 0.124854900 1.22654075E-02 3.38080004E-02 1.35195553 1.45888822E-02 3.21572162E-02 2.78941263E-02 3.60985063E-02 3.53019126E-02 5.55487350E-02 0.207938343 2.18330603E-02 3.35578871 1.36324670E-02 + 589084976.72804153 203745.93385531267 15.7761011 3.95227385 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.07790237E-03 0.146303177 2.18373518E-02 3.94121930E-02 5.69027178E-02 0.142461330 1.35724866 2.55869012E-02 2.07635332E-02 3.65253575E-02 4.96366695E-02 0.126996413 0.131406441 0.107783385 4.68840860E-02 5.42741269E-02 0.316014051 0.111519463 2.57905256E-02 2.37778928E-02 1.35919703E-02 5.62313050E-02 2.84097027E-02 1.96655393E-02 1.16146207 1.68890189E-02 2.79563107E-02 5.80929422 8.35015103E-02 0.287076563 1.65469702E-02 1.58826578E-02 4.46421653E-02 1.48328124E-02 1.24401050E-02 0.124852218 1.22655844E-02 3.38061005E-02 1.35191560 1.45874498E-02 3.21513973E-02 2.78940517E-02 3.61239649E-02 3.53001766E-02 5.55696413E-02 0.207941756 2.18314528E-02 3.35560036 1.36357397E-02 + 581048587.95948780 203909.91124773398 15.7666492 3.95072794 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.65461006E-03 0.145226046 2.16519199E-02 3.91435362E-02 5.65851294E-02 0.141689166 1.35140526 2.54933015E-02 2.06929501E-02 3.64373736E-02 4.95171621E-02 0.126786977 0.131189749 0.107697435 4.68581766E-02 5.42818792E-02 0.315559417 0.111181021 2.57752500E-02 2.37551723E-02 1.35989087E-02 5.62307723E-02 2.83959024E-02 1.96658354E-02 1.16141391 1.68853104E-02 2.79427692E-02 5.80911779 8.34948719E-02 0.287126750 1.65554658E-02 1.58813410E-02 4.46282476E-02 1.48335630E-02 1.24403620E-02 0.124801151 1.22643327E-02 3.38147879E-02 1.35188317 1.45910885E-02 3.21546942E-02 2.78942399E-02 3.61184478E-02 3.53069231E-02 5.55657521E-02 0.207966089 2.18285918E-02 3.35503459 1.36328461E-02 + 573012199.19093406 204156.63254152212 15.7556171 3.94890618 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.04650504E-03 0.144091472 2.14698371E-02 3.88994031E-02 5.62016666E-02 0.140975788 1.34480739 2.53382213E-02 2.06085350E-02 3.62955332E-02 4.91769351E-02 0.126547456 0.130730271 0.107369781 4.67645787E-02 5.42546399E-02 0.314416498 0.110114790 2.57209949E-02 2.37325635E-02 1.35962488E-02 5.61786182E-02 2.83856038E-02 1.96346864E-02 1.16106260 1.68795511E-02 2.79578622E-02 5.80804920 8.35011676E-02 0.287339985 1.65538378E-02 1.58841871E-02 4.46317121E-02 1.48394601E-02 1.24413930E-02 0.124838024 1.22667057E-02 3.38298418E-02 1.35193384 1.45906340E-02 3.21615860E-02 2.78938394E-02 3.61151956E-02 3.53026576E-02 5.55876382E-02 0.207922995 2.18303017E-02 3.35520792 1.36356400E-02 + 564975810.42238033 205331.74140986640 15.7175751 3.93381381 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.10853066E-02 0.143088877 2.12318264E-02 3.84894423E-02 5.54631166E-02 0.139871120 1.33612859 2.51238625E-02 2.04927307E-02 3.61036770E-02 4.88936491E-02 0.125471070 0.130276918 0.106964603 4.65874411E-02 5.39932959E-02 0.312512010 0.108219348 2.55917534E-02 2.36571804E-02 1.35427415E-02 5.59852831E-02 2.81490125E-02 1.95401069E-02 1.15382290 1.67806130E-02 2.78306063E-02 5.78481388 8.30868036E-02 0.285962313 1.65444762E-02 1.58655718E-02 4.41196822E-02 1.48155913E-02 1.23980092E-02 0.124616534 1.20056840E-02 3.37363780E-02 1.34585989 1.45560894E-02 3.21388654E-02 2.78771129E-02 3.58993635E-02 3.52187417E-02 5.52982278E-02 0.207654059 2.17920821E-02 3.34480333 1.36162899E-02 + 556939421.65382659 205508.00978506124 15.6981554 3.93240690 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.46347781E-02 0.141773179 2.10537091E-02 3.81746329E-02 5.51727563E-02 0.138828993 1.32741630 2.49712355E-02 2.03866754E-02 3.59198116E-02 4.87157665E-02 0.124745965 0.129878879 0.106526300 4.64424007E-02 5.39259762E-02 0.312109768 0.108443655 2.55628135E-02 2.36210339E-02 1.35077732E-02 5.59106059E-02 2.81546526E-02 1.95217058E-02 1.15228808 1.67689454E-02 2.78081279E-02 5.78008652 8.30206797E-02 0.285761833 1.65273622E-02 1.58529449E-02 4.40928638E-02 1.48066198E-02 1.23907039E-02 0.124599427 1.20052183E-02 3.37500758E-02 1.34533072 1.45451510E-02 3.21246237E-02 2.78694499E-02 3.58923674E-02 3.52005251E-02 5.52910045E-02 0.207609996 2.17887480E-02 3.34375095 1.35929463E-02 + 548903032.88527286 205801.05632143168 15.6852903 3.92764759 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.11057045E-04 4.95182127E-02 0.140860185 2.09311415E-02 3.78166772E-02 5.49290814E-02 0.137955695 1.32323229 2.48654578E-02 2.03104597E-02 3.58338542E-02 4.86553311E-02 0.124607727 0.129703268 0.106426887 4.63736206E-02 5.38830534E-02 0.311857462 0.108474493 2.55316012E-02 2.36204639E-02 1.34936953E-02 5.58745861E-02 2.81391237E-02 1.95055772E-02 1.15109742 1.67611912E-02 2.78027505E-02 5.77783489 8.28479826E-02 0.285455823 1.64945647E-02 1.58548746E-02 4.40760776E-02 1.47983693E-02 1.23739457E-02 0.124507099 1.19988648E-02 3.37239020E-02 1.34388781 1.45202233E-02 3.21120359E-02 2.78578233E-02 3.58579233E-02 3.51709425E-02 5.52694239E-02 0.207515806 2.17883736E-02 3.33958483 1.35853998E-02 + 540866644.11671913 206056.40787180202 15.6759501 3.92631865 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.52082844E-03 4.91815917E-02 0.139732406 2.07771081E-02 3.75732556E-02 5.46632260E-02 0.137359381 1.31724119 2.47781239E-02 2.01136619E-02 3.57544683E-02 4.84913997E-02 0.124462634 0.129288286 0.106239982 4.63540964E-02 5.38348742E-02 0.311670274 0.108381987 2.55214367E-02 2.36224160E-02 1.34737557E-02 5.58206886E-02 2.81341467E-02 1.95079576E-02 1.15100515 1.67523343E-02 2.78004091E-02 5.77679968 8.28896165E-02 0.285531759 1.64988097E-02 1.58708915E-02 4.40643765E-02 1.47946225E-02 1.23754945E-02 0.124482520 1.19979009E-02 3.37038040E-02 1.34374928 1.45185310E-02 3.20991315E-02 2.78356560E-02 3.58581729E-02 3.51429917E-02 5.52456975E-02 0.207461357 2.17750035E-02 3.33861136 1.35861756E-02 + 532830255.34831524 206293.83586217967 15.6551704 3.92439675 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.47373078E-03 4.89064083E-02 0.138434187 2.06262693E-02 3.73521671E-02 5.41787967E-02 0.136598155 1.30909538 2.46366318E-02 2.06119381E-02 3.56918536E-02 4.83482890E-02 0.124113515 0.128844053 0.106029429 4.62547429E-02 5.37288450E-02 0.311060995 0.107944138 2.55075041E-02 2.35808026E-02 1.34535320E-02 5.56777343E-02 2.80753709E-02 1.94897577E-02 1.14896846 1.67110357E-02 2.77683139E-02 5.77005768 8.28498751E-02 0.285402387 1.64912045E-02 1.58697162E-02 4.40622829E-02 1.47973746E-02 1.23724649E-02 0.124483205 1.19964583E-02 3.37055251E-02 1.34340680 1.45108774E-02 3.20994332E-02 2.78366879E-02 3.58304344E-02 3.51442806E-02 5.52570820E-02 0.207467079 2.17780247E-02 3.33800578 1.35839283E-02 + 524793866.58005953 206428.39075171039 15.6495485 3.92416358 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.14579707E-03 4.84774634E-02 0.137530357 2.05058400E-02 3.71668786E-02 5.39913885E-02 0.135925680 1.30440128 2.45240554E-02 2.05547865E-02 3.55996788E-02 4.82506305E-02 0.123897202 0.128642678 0.105845459 4.61139455E-02 5.36969118E-02 0.310930848 0.108000703 2.55014580E-02 2.35609934E-02 1.34530179E-02 5.56449629E-02 2.80762650E-02 1.94969196E-02 1.14926755 1.67170539E-02 2.77657304E-02 5.77102375 8.28485340E-02 0.285531640 1.64933410E-02 1.58726629E-02 4.41042483E-02 1.47960940E-02 1.23744188E-02 0.124376655 1.19909626E-02 3.36879380E-02 1.34333026 1.45072518E-02 3.20897326E-02 2.78283488E-02 3.58423069E-02 3.51481512E-02 5.53023331E-02 0.207492486 2.17770282E-02 3.33785725 1.35849109E-02 + 516757477.81180382 206589.08636610143 15.6428194 3.92397022 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.15502384E-03 4.82118092E-02 0.136739388 2.03835610E-02 3.69872637E-02 5.37797287E-02 0.135453343 1.30047154 2.44691037E-02 2.04918440E-02 3.55543420E-02 4.80813161E-02 0.123806126 0.128439441 0.105742753 4.60799001E-02 5.36835790E-02 0.310871363 0.107952811 2.54881606E-02 2.35601515E-02 1.34506878E-02 5.56580834E-02 2.80691590E-02 1.94883980E-02 1.14922237 1.67226065E-02 2.77673434E-02 5.77037525 8.28420967E-02 0.285543352 1.64931472E-02 1.58757903E-02 4.40976135E-02 1.47976344E-02 1.23714078E-02 0.124356225 1.19897090E-02 3.36864442E-02 1.34308422 1.45014953E-02 3.20911892E-02 2.78319959E-02 3.58367041E-02 3.51491719E-02 5.53072765E-02 0.207465693 2.17835028E-02 3.33797264 1.35851698E-02 + 508721089.04354811 207030.81608873824 15.6224546 3.91759539 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.06298288E-02 4.77412604E-02 0.135773689 2.02563442E-02 3.66770923E-02 5.33193611E-02 0.134519756 1.29445708 2.43360940E-02 2.04335675E-02 3.54501940E-02 4.79751006E-02 0.123401992 0.128081903 0.105514623 4.60035577E-02 5.28922491E-02 0.310554206 0.108005650 2.54740845E-02 2.35257261E-02 1.34406053E-02 5.56365587E-02 2.80566867E-02 1.94820371E-02 1.14690793 1.66899022E-02 2.77636722E-02 5.76376247 8.25524256E-02 0.284890294 1.64463930E-02 1.58557296E-02 4.40334938E-02 1.47917727E-02 1.23571642E-02 0.124333076 1.19736157E-02 3.36803123E-02 1.33948576 1.44958245E-02 3.20837647E-02 2.78159287E-02 3.56025510E-02 3.51175927E-02 5.51967025E-02 0.207334444 2.17816755E-02 3.33229923 1.35660879E-02 + 500684700.27529240 207205.86665557433 15.6055641 3.91487622 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.27980800E-02 4.73258235E-02 0.134902418 2.01451052E-02 3.64860594E-02 5.31265400E-02 0.134042621 1.28892982 2.42610462E-02 2.03653239E-02 3.53820883E-02 4.78900261E-02 0.123219244 0.127650812 0.105316952 4.59541269E-02 5.29144108E-02 0.309401274 0.107949331 2.54495125E-02 2.34877691E-02 1.34348767E-02 5.55695295E-02 2.80341692E-02 1.94686539E-02 1.14567590 1.66800208E-02 2.77607385E-02 5.75957680 8.24674889E-02 0.284618318 1.64412539E-02 1.58558562E-02 4.40153331E-02 1.47868795E-02 1.23538235E-02 0.124349579 1.19574331E-02 3.36715057E-02 1.33855522 1.44962789E-02 3.20901684E-02 2.78063789E-02 3.55895422E-02 3.51104066E-02 5.51133379E-02 0.207235202 2.17699800E-02 3.33051825 1.35650486E-02 + 492648311.50703669 207321.19104537493 15.5986729 3.91415405 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.63765138E-04 2.27436647E-02 4.70594727E-02 0.134297356 2.00191252E-02 3.63572426E-02 5.29198423E-02 0.133514777 1.28441477 2.41912529E-02 2.03138757E-02 3.53148542E-02 4.78193760E-02 0.123023584 0.127448082 0.105176255 4.58892845E-02 5.28529584E-02 0.309460938 0.108270012 2.54429244E-02 2.34741196E-02 1.34255262E-02 5.55376709E-02 2.80287787E-02 1.94542333E-02 1.14513469 1.66771617E-02 2.77441852E-02 5.75982380 8.24981555E-02 0.284639060 1.64478123E-02 1.58592965E-02 4.40577641E-02 1.47883939E-02 1.23561835E-02 0.124406911 1.19599607E-02 3.36834602E-02 1.33892107 1.44922240E-02 3.20935324E-02 2.77937911E-02 3.55868004E-02 3.51034664E-02 5.50990216E-02 0.207224444 2.17443164E-02 3.32955670 1.35632465E-02 + 484611922.73878098 207553.31797052425 15.5875673 3.91114140 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 9.04081669E-03 2.25888286E-02 4.67465706E-02 0.133286387 1.98541712E-02 3.61435376E-02 5.25380410E-02 0.132770941 1.27856231 2.40833517E-02 2.02413220E-02 3.52258198E-02 4.77834232E-02 0.122509472 0.126968607 0.104848109 4.57393266E-02 5.28338291E-02 0.308818609 0.107583568 2.53951121E-02 2.34515760E-02 1.34077789E-02 5.54651767E-02 2.80003119E-02 1.94255728E-02 1.14424217 1.66659020E-02 2.77478863E-02 5.75724936 8.23961869E-02 0.284403950 1.64318364E-02 1.58548895E-02 4.39931080E-02 1.47795901E-02 1.23406332E-02 0.124263957 1.19447336E-02 3.36699374E-02 1.33758521 1.44771151E-02 3.20499502E-02 2.77802460E-02 3.55821922E-02 3.50884423E-02 5.50965369E-02 0.207045287 2.17520203E-02 3.32827163 1.35403406E-02 + 476575533.97052526 207764.87893783371 15.5761328 3.90981197 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.95705015E-02 2.23816931E-02 4.63875830E-02 0.134407401 1.97202545E-02 3.58567722E-02 5.20568751E-02 0.131974384 1.27280974 2.40026172E-02 2.01560743E-02 3.51371281E-02 4.76407111E-02 0.122245170 0.126643673 0.104632862 4.56444249E-02 5.25626950E-02 0.308228374 0.107705042 2.53422055E-02 2.34390683E-02 1.34007437E-02 5.54004498E-02 2.79713105E-02 1.93975903E-02 1.14223433 1.66484229E-02 2.77424250E-02 5.74923229 8.22170228E-02 0.284029245 1.63994413E-02 1.58275981E-02 4.39413413E-02 1.47178620E-02 1.23348720E-02 0.123949885 1.19347526E-02 3.36337984E-02 1.33694720 1.44656878E-02 3.20050381E-02 2.77469084E-02 3.56367752E-02 3.50561477E-02 5.47563806E-02 0.206976146 2.18567327E-02 3.32759619 1.35312807E-02 + 468539145.20226955 207990.94321010693 15.6309109 3.91026950 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.74992087E-02 2.22491939E-02 4.61213291E-02 0.133310705 1.95747074E-02 3.56533565E-02 5.17742336E-02 0.131272361 1.26639831 2.38798987E-02 2.00783759E-02 3.50250304E-02 4.74538766E-02 0.121937595 0.126309067 0.104399733 4.55619879E-02 5.24829887E-02 0.308168262 0.107934415 2.53331047E-02 2.34457422E-02 1.33982599E-02 5.53951561E-02 2.79681794E-02 1.93718672E-02 1.14122725 1.66363828E-02 2.77343709E-02 5.74746084 8.21862295E-02 0.284011155 1.64055470E-02 1.58273410E-02 4.39230017E-02 1.47248115E-02 1.23345228E-02 0.123944513 1.19313151E-02 3.36335450E-02 1.33684349 1.44628230E-02 3.20042819E-02 2.77448539E-02 3.56246941E-02 3.50490734E-02 5.47573008E-02 0.206983298 2.18568314E-02 3.32807088 1.35350479E-02 + 460502756.43401384 208254.56369291589 15.6656141 3.90971470 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.131013691 2.21205335E-02 4.59204465E-02 0.132408440 1.94912739E-02 3.53887193E-02 5.15695661E-02 0.130452499 1.26157999 2.37712059E-02 1.99988950E-02 3.46614979E-02 4.73449230E-02 0.121536724 0.125999510 0.104222752 4.54875752E-02 5.24948686E-02 0.308051318 0.107885167 2.53257491E-02 2.34267768E-02 1.33963628E-02 5.53991236E-02 2.79735513E-02 1.93595979E-02 1.14161646 1.66305043E-02 2.77454555E-02 5.74806881 8.21938664E-02 0.283972502 1.63973588E-02 1.58270281E-02 4.39157672E-02 1.47217074E-02 1.23328064E-02 0.123955488 1.19323768E-02 3.36371474E-02 1.33642459 1.44515540E-02 3.20047922E-02 2.77373698E-02 3.56130153E-02 3.50530557E-02 5.47482446E-02 0.206975400 2.18576416E-02 3.32798147 1.35372085E-02 + 452466367.66575813 208454.61062517000 15.7530165 3.90802622 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.230383396 2.19760090E-02 4.56138067E-02 0.131224290 1.93957519E-02 3.51749621E-02 5.13897575E-02 0.129897952 1.25801384 2.36852560E-02 1.99171174E-02 3.45786363E-02 4.72617671E-02 0.121222846 0.125539154 0.104026318 4.54478376E-02 5.24105579E-02 0.308027357 0.108020760 2.53234338E-02 2.34066639E-02 1.33855343E-02 5.52727394E-02 2.77407765E-02 1.93658248E-02 1.14059663 1.66273359E-02 2.77369525E-02 5.74802446 8.21642727E-02 0.283929408 1.64011978E-02 1.58244893E-02 4.39050160E-02 1.47166811E-02 1.23304268E-02 0.123897560 1.19246664E-02 3.36345099E-02 1.33542120 1.44413607E-02 3.19798775E-02 2.77169216E-02 3.56082991E-02 3.50483805E-02 5.47404625E-02 0.206772849 2.18334645E-02 3.32650471 1.35323983E-02 + 444429978.89750242 208744.90874672780 15.7294178 3.90478063 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.33613732E-03 0.228315338 2.17068829E-02 4.52945530E-02 0.130438015 1.92666426E-02 3.49381901E-02 5.10884784E-02 0.129087076 1.25209379 2.35586148E-02 1.98349301E-02 3.44742760E-02 4.71977107E-02 0.120984949 0.125377342 0.103784695 4.53702025E-02 5.22317998E-02 0.307529032 0.107976042 2.52347905E-02 2.32793335E-02 1.33544821E-02 5.51228300E-02 2.76984796E-02 1.93342343E-02 1.13885701 1.66030545E-02 2.77175941E-02 5.74023914 8.21317360E-02 0.283805966 1.63855217E-02 1.58231501E-02 4.38667163E-02 1.46879731E-02 1.23164123E-02 0.123492815 1.19102942E-02 3.35805006E-02 1.33369660 1.44148814E-02 3.18972804E-02 2.76992954E-02 3.56010124E-02 3.50382887E-02 5.47431409E-02 0.206665725 2.17984878E-02 3.32401109 1.35256071E-02 + 436393590.12924671 208913.04866890333 15.7176924 3.90409756 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 6.58921711E-03 0.226375178 2.15439945E-02 4.47217673E-02 0.129208818 1.91705544E-02 3.47595885E-02 5.08444272E-02 0.128613070 1.24704361 2.35010646E-02 1.97928678E-02 3.43958661E-02 4.71667424E-02 0.120835185 0.125090644 0.103648715 4.53239493E-02 5.21907620E-02 0.307380557 0.108085237 2.52204631E-02 2.32694130E-02 1.33418273E-02 5.51116131E-02 2.76785418E-02 1.93167999E-02 1.13839054 1.65738668E-02 2.76925005E-02 5.73844481 8.20974335E-02 0.283599973 1.63765289E-02 1.58179253E-02 4.38382365E-02 1.46837775E-02 1.23142842E-02 0.123460203 1.19036818E-02 3.35756950E-02 1.33363187 1.44179221E-02 3.18931937E-02 2.77027488E-02 3.55957039E-02 3.50253582E-02 5.47195747E-02 0.206728771 2.18057204E-02 3.32366133 1.35220336E-02 + 428357201.36099100 209070.40928130582 15.7051611 3.90307236 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.31761397E-03 0.224602774 2.13942956E-02 4.45006862E-02 0.128445432 1.90720912E-02 3.46110463E-02 5.03194220E-02 0.128134638 1.24072540 2.34226808E-02 1.97358523E-02 3.43208984E-02 4.70222495E-02 0.120577797 0.124944784 0.103375383 4.52898443E-02 5.21545447E-02 0.306882977 0.107889518 2.52069421E-02 2.32617520E-02 1.33418310E-02 5.50874956E-02 2.76677236E-02 1.93284433E-02 1.13792753 1.65743344E-02 2.76844203E-02 5.73769045 8.20973516E-02 0.283518344 1.63792092E-02 1.58144943E-02 4.38559949E-02 1.46772433E-02 1.23106325E-02 0.123457484 1.19027849E-02 3.35704014E-02 1.33328640 1.44161461E-02 3.18898559E-02 2.77059525E-02 3.55854072E-02 3.50265950E-02 5.47401570E-02 0.206730172 2.18013301E-02 3.32336664 1.35187749E-02 + 420320812.59273529 209271.35562323881 15.6903791 3.90108466 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.12926401E-02 0.223070905 2.12601051E-02 4.42806147E-02 0.127683312 1.89693682E-02 3.44234332E-02 5.01426980E-02 0.127488583 1.23644161 2.33264454E-02 1.96548607E-02 3.42453532E-02 4.68839705E-02 0.120310761 0.124790512 0.103169538 4.52089459E-02 5.21170571E-02 0.306654751 0.108128041 2.52245944E-02 2.32448597E-02 1.33256745E-02 5.50624058E-02 2.76521016E-02 1.93242263E-02 1.13739872 1.65619813E-02 2.76646558E-02 5.73242378 8.21070448E-02 0.283297569 1.63734984E-02 1.58171952E-02 4.37998995E-02 1.46767143E-02 1.23082642E-02 0.123331845 1.18978256E-02 3.35587785E-02 1.33275926 1.44044990E-02 3.18728313E-02 2.76995078E-02 3.55823338E-02 3.50288786E-02 5.47041111E-02 0.206635848 2.17988286E-02 3.32177925 1.35190031E-02 + 412284423.82447958 209498.60936305032 15.6787472 3.90027475 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.46142449E-02 0.221018553 2.11098883E-02 4.40441035E-02 0.126522303 1.88553631E-02 3.42431031E-02 5.00187129E-02 0.127102077 1.23168623 2.32613944E-02 1.96095556E-02 3.41849886E-02 4.67733964E-02 0.120141633 0.124309152 0.102949068 4.51361425E-02 5.19248173E-02 0.306333929 0.108151630 2.51952633E-02 2.31888294E-02 1.33219641E-02 5.50203696E-02 2.75988486E-02 1.93175673E-02 1.13690662 1.65498238E-02 2.76159868E-02 5.72917128 8.21300894E-02 0.283353180 1.63808707E-02 1.58237275E-02 4.38037775E-02 1.46709550E-02 1.23089179E-02 0.123319708 1.18990475E-02 3.35563831E-02 1.33307958 1.44064147E-02 3.18798497E-02 2.76995171E-02 3.55790779E-02 3.50236110E-02 5.46804555E-02 0.206721857 2.17962209E-02 3.32123828 1.35180326E-02 + 404248035.05622387 209656.97705970603 15.6724882 3.90007663 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.63064972E-02 0.219225243 2.09486969E-02 4.38429192E-02 0.125799954 1.87519677E-02 3.41425054E-02 4.98743840E-02 0.126556456 1.22790253 2.31657736E-02 1.95595436E-02 3.40816230E-02 4.67193834E-02 0.119927965 0.124100752 0.102825709 4.50753942E-02 5.19046672E-02 0.306189209 0.108210817 2.51852851E-02 2.31325086E-02 1.33242654E-02 5.49907908E-02 2.75891609E-02 1.93254054E-02 1.13631809 1.65414996E-02 2.76029576E-02 5.72949171 8.21338594E-02 0.283481419 1.63904019E-02 1.58259664E-02 4.38149683E-02 1.46761574E-02 1.23129981E-02 0.123340487 1.19001940E-02 3.35685685E-02 1.33383596 1.44110750E-02 3.18797790E-02 2.77021863E-02 3.55735794E-02 3.50369401E-02 5.47180809E-02 0.206680074 2.17971746E-02 3.32127237 1.35217207E-02 + 396211646.28796816 209925.10454611058 15.6510286 3.89530087 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.51343353E-03 1.79390516E-02 0.217193767 2.07911115E-02 4.35673147E-02 0.124733731 1.86417438E-02 3.39150280E-02 4.96033654E-02 0.125997350 1.22089660 2.30453685E-02 1.94325186E-02 3.40121314E-02 4.66006882E-02 0.119755380 0.123686209 0.102642097 4.50114049E-02 5.17494902E-02 0.305428475 0.107003838 2.51542535E-02 2.30903346E-02 1.33099193E-02 5.49279451E-02 2.76008639E-02 1.93193257E-02 1.13458145 1.65330227E-02 2.75939517E-02 5.72577667 8.20193440E-02 0.283202708 1.63798667E-02 1.58183035E-02 4.37644981E-02 1.46691287E-02 1.23077966E-02 0.123271145 1.18930591E-02 3.35571505E-02 1.33305991 1.44005874E-02 3.18744071E-02 2.76950430E-02 3.55568305E-02 3.50305215E-02 5.47039285E-02 0.206590071 2.17856485E-02 3.31888723 1.35123441E-02 + 388175257.51971245 210079.47554281296 15.6417971 3.89513779 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.83611512E-03 1.78113282E-02 0.215721115 2.06355229E-02 4.34176102E-02 0.124242611 1.85430441E-02 3.37433107E-02 4.93963063E-02 0.125313893 1.21632087 2.29733195E-02 1.93758998E-02 3.39313075E-02 4.64352742E-02 0.119417600 0.123556651 0.102429435 4.49279994E-02 5.17101027E-02 0.305028558 0.106971651 2.51430124E-02 2.30904836E-02 1.33084496E-02 5.49218655E-02 2.75955442E-02 1.93222146E-02 1.13433552 1.65317114E-02 2.76297741E-02 5.72433138 8.20055231E-02 0.283161342 1.63818505E-02 1.58042256E-02 4.37373221E-02 1.46641396E-02 1.23060355E-02 0.123185486 1.18934652E-02 3.35494280E-02 1.33274901 1.44028729E-02 3.18633765E-02 2.76959930E-02 3.55630219E-02 3.50234993E-02 5.47078885E-02 0.206573620 2.17882432E-02 3.31927919 1.35128824E-02 + 380138868.75145674 210254.31391497958 15.6331120 3.89329934 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 5.31312777E-03 1.76688228E-02 0.214543000 2.05285922E-02 4.32207957E-02 0.124949798 1.84676219E-02 3.36493514E-02 4.92974743E-02 0.124651104 1.21378148 2.29197834E-02 1.93506628E-02 3.39013040E-02 4.63533215E-02 0.119273014 0.123382233 0.102339610 4.48776446E-02 5.16916141E-02 0.304372728 0.106649652 2.50906721E-02 2.30741631E-02 1.32989874E-02 5.48871085E-02 2.75633391E-02 1.92897115E-02 1.13331258 1.65199284E-02 2.76282914E-02 5.72280741 8.19751993E-02 0.283122063 1.63826328E-02 1.58055536E-02 4.37265597E-02 1.46604776E-02 1.23050660E-02 0.123186417 1.18932109E-02 3.35453823E-02 1.33233345 1.43944668E-02 3.18422131E-02 2.76861098E-02 3.55598964E-02 3.50135043E-02 5.46996631E-02 0.206544042 2.17764974E-02 3.31849456 1.35098333E-02 + 372102479.98320103 210611.82432020936 15.6241589 3.89295387 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.81318655E-03 1.75132025E-02 0.212353796 2.03604605E-02 4.28834707E-02 0.124118879 1.83155816E-02 3.35004404E-02 4.89893667E-02 0.124098502 1.20741856 2.28611212E-02 2.19208524E-02 3.40067782E-02 4.61939983E-02 0.119014800 0.122838758 0.102202117 4.47852910E-02 5.15461490E-02 0.303820044 0.106699996 2.50648092E-02 2.30735447E-02 1.32946251E-02 5.48910312E-02 2.75655575E-02 1.92967858E-02 1.13280296 1.65160354E-02 2.76268441E-02 5.72161388 8.19682404E-02 0.283154726 1.63839739E-02 1.58082023E-02 4.37311530E-02 1.46578541E-02 1.23085631E-02 0.123213179 1.18949991E-02 3.35269533E-02 1.33235955 1.43930949E-02 3.18387449E-02 2.76875850E-02 3.55595946E-02 3.49992923E-02 5.46997823E-02 0.206516415 2.17763279E-02 3.31816983 1.35107264E-02 + 364066091.21494532 210818.59914369087 15.6085749 3.88817096 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.09359408E-02 1.73794795E-02 0.210706338 2.02566478E-02 4.26452234E-02 0.123542473 1.82215478E-02 3.33342478E-02 4.88187112E-02 0.123549663 1.20382166 2.27353983E-02 2.18508448E-02 3.39328945E-02 4.59837317E-02 0.118938558 0.122809276 0.102008864 4.47091162E-02 5.15317731E-02 0.302841902 0.105843194 2.49754712E-02 2.30410099E-02 1.32822944E-02 5.48302196E-02 2.75571886E-02 1.92630496E-02 1.13202620 1.65007655E-02 2.76047476E-02 5.71849442 8.19187313E-02 0.283290893 1.64032914E-02 1.58116370E-02 4.37041745E-02 1.46639766E-02 1.23257991E-02 0.123247176 1.19003234E-02 3.35165821E-02 1.33166873 1.43820727E-02 3.18179876E-02 2.76820157E-02 3.55557874E-02 3.49553637E-02 5.46752401E-02 0.206437945 2.17693690E-02 3.31537056 1.35029750E-02 + 356029702.44668961 210974.45578814691 15.6016541 3.88752699 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.24985501E-02 1.72368009E-02 0.209282428 2.01517306E-02 4.24025133E-02 0.123007864 1.81215908E-02 3.31972912E-02 4.86777723E-02 0.123108707 1.19982994 2.26645861E-02 2.17235144E-02 3.38759609E-02 4.58717197E-02 0.118760578 0.122627206 0.101916097 4.46802676E-02 5.15013970E-02 0.302250475 0.105847023 2.49475725E-02 2.30424087E-02 1.32808229E-02 5.48111387E-02 2.75261719E-02 1.92519836E-02 1.13147199 1.64917782E-02 2.76000891E-02 5.71899939 8.19103345E-02 0.283364922 1.64012797E-02 1.58602372E-02 4.37014475E-02 1.46614881E-02 1.23270946E-02 0.123235658 1.19003523E-02 3.35161686E-02 1.33200192 1.43834269E-02 3.18269059E-02 2.76762489E-02 3.55601311E-02 3.49540040E-02 5.46905771E-02 0.206422195 2.17846632E-02 3.31531715 1.35007035E-02 + 347993313.67843390 211170.49610817365 15.5890760 3.88635206 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.98550071E-04 1.45403827E-02 1.70985311E-02 0.207727730 2.00142730E-02 4.21736464E-02 0.122507051 1.80341750E-02 3.30598913E-02 4.85487916E-02 0.122608334 1.19611025 2.26362441E-02 2.16712300E-02 3.37789021E-02 4.57067303E-02 0.118585996 0.122380607 0.101749755 4.46632244E-02 5.14516383E-02 0.301967323 0.105083480 2.48919819E-02 2.30111610E-02 1.32602016E-02 5.47436662E-02 2.75113452E-02 1.92398075E-02 1.13031006 1.64809190E-02 2.75615901E-02 5.71480989 8.19155201E-02 0.283398688 1.64015274E-02 1.58674400E-02 4.37189005E-02 1.46628553E-02 1.23238759E-02 0.123243414 1.18989581E-02 3.35177965E-02 1.33160806 1.43819731E-02 3.18162628E-02 2.76564565E-02 3.55627574E-02 3.49579528E-02 5.46948723E-02 0.206415251 2.17873827E-02 3.31532741 1.34995719E-02 + 339956924.91017818 211415.80081783814 15.5794849 3.88321972 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.06210963E-03 1.44279115E-02 1.70063730E-02 0.208527923 1.99043155E-02 4.20073196E-02 0.121428981 1.79141816E-02 3.28999460E-02 4.84306589E-02 0.122363091 1.19242573 2.25342382E-02 2.16067359E-02 3.37179713E-02 4.56792340E-02 0.118439540 0.122332104 0.101729609 4.46152315E-02 5.14357686E-02 0.301995128 0.105319537 2.48644296E-02 2.29935292E-02 1.32456869E-02 5.47156185E-02 2.75011305E-02 1.92316957E-02 1.12826741 1.64698232E-02 2.75294241E-02 5.71294975 8.17615911E-02 0.282986104 1.63942333E-02 1.58570502E-02 4.36412245E-02 1.46510098E-02 1.23197092E-02 0.123173304 1.18903071E-02 3.35058905E-02 1.33176315 1.43813509E-02 3.18124965E-02 2.76506208E-02 3.55550759E-02 3.49360332E-02 5.46371378E-02 0.206222802 2.17739958E-02 3.31250429 1.34959919E-02 + 331920536.14192247 211555.27730901958 15.5729818 3.88313603 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 7.24266237E-03 1.43122021E-02 1.69006903E-02 0.207128853 1.98144112E-02 4.18672338E-02 0.120807067 1.78384278E-02 3.27491313E-02 4.82687689E-02 0.121957347 1.18916345 2.24935729E-02 2.15624925E-02 3.36692892E-02 4.55762669E-02 0.118274152 0.122117825 0.101574212 4.45766188E-02 5.16309477E-02 0.301951289 0.105248101 2.48575211E-02 2.29609404E-02 1.32441260E-02 5.47264367E-02 2.75032520E-02 1.92291811E-02 1.12771201 1.64591856E-02 2.75373310E-02 5.71068907 8.16695020E-02 0.282863498 1.63848270E-02 1.58560667E-02 4.36623804E-02 1.46559933E-02 1.23227518E-02 0.123121172 1.18912887E-02 3.34904343E-02 1.33210707 1.43896136E-02 3.18182930E-02 2.76862178E-02 3.56047042E-02 3.49395536E-02 5.46367913E-02 0.206246525 2.17733271E-02 3.31272244 1.34960925E-02 + 323884147.37366676 211816.20193444603 15.5629120 3.88078976 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.36086242E-02 1.41740069E-02 1.67617016E-02 0.205528617 1.96756795E-02 4.16302197E-02 0.119925849 1.77263711E-02 3.25396769E-02 4.81118709E-02 0.121289238 1.18510973 2.24153679E-02 2.15012915E-02 3.35724689E-02 4.54524644E-02 0.118037798 0.121899545 0.101464845 4.44654562E-02 5.15916310E-02 0.301249892 0.105179355 2.48028748E-02 2.28734538E-02 1.32361809E-02 5.45986220E-02 2.74713282E-02 1.91882085E-02 1.12594020 1.64475590E-02 2.75194775E-02 5.70956182 8.16476122E-02 0.282744437 1.63747296E-02 1.58399679E-02 4.35931310E-02 1.46431103E-02 1.23220226E-02 0.122890629 1.18739633E-02 3.31627801E-02 1.33170331 1.43867321E-02 3.17877866E-02 2.76784301E-02 3.55908237E-02 3.49402986E-02 5.45969605E-02 0.206204191 2.17498019E-02 3.31113434 1.34947095E-02 + 315847758.60541105 212322.05350222153 15.5404224 3.87565017 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.24686563E-02 1.40319774E-02 1.66319162E-02 0.203539103 1.95183828E-02 4.13509607E-02 0.119251505 1.74882077E-02 3.23665589E-02 4.78934608E-02 0.122631557 1.17995119 2.23092027E-02 2.14223824E-02 3.34187187E-02 4.53099236E-02 0.117650256 0.121479116 0.101179555 4.43899743E-02 5.15485369E-02 0.300752014 0.104858220 2.46690679E-02 2.27407645E-02 1.31938383E-02 5.43651208E-02 2.73865443E-02 1.91166028E-02 1.12251401 1.62900202E-02 2.73908339E-02 5.70058107 8.15923363E-02 0.282395035 1.63444784E-02 1.57698486E-02 4.35789302E-02 1.46338083E-02 1.23126470E-02 0.122538082 1.18288631E-02 3.30508947E-02 1.32925487 1.43613908E-02 3.16548124E-02 2.76105851E-02 3.55731547E-02 3.49214263E-02 5.45793734E-02 0.206088692 2.17389129E-02 3.30741668 1.34880897E-02 + 307811369.83715534 212663.20829362626 15.5185022 3.87301970 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.12346630E-02 1.39120268E-02 1.65000092E-02 0.201286256 1.93127450E-02 4.11120094E-02 0.118308194 1.73391309E-02 3.22170258E-02 4.76743579E-02 0.122343935 1.17332149 2.22701542E-02 2.13377103E-02 3.32967006E-02 4.51145507E-02 0.117481150 0.120759681 0.101078577 4.42480259E-02 5.14882468E-02 0.298111588 0.104766332 2.46457625E-02 2.26760544E-02 1.31791262E-02 5.42759001E-02 2.73302123E-02 1.91002395E-02 1.12086689 1.62664670E-02 2.73594465E-02 5.69035387 8.15016255E-02 0.281960368 1.63412560E-02 1.57604553E-02 4.35222015E-02 1.46120582E-02 1.23344548E-02 0.122609571 1.18123051E-02 3.30386683E-02 1.32926679 1.43602500E-02 3.16435955E-02 2.76074801E-02 3.55162360E-02 3.48450132E-02 5.45868762E-02 0.205614775 2.17389911E-02 3.30577397 1.34871881E-02 + 299774981.06889963 212809.54841553533 15.5146370 3.87168384 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 4.85907331E-05 3.49039957E-02 1.38142612E-02 1.63884535E-02 0.199963614 1.92220826E-02 4.09778766E-02 0.117513359 1.72737036E-02 3.21008153E-02 4.75390963E-02 0.121873952 1.17046285 2.22135540E-02 2.12892648E-02 3.32597382E-02 4.50656861E-02 0.117381163 0.120506465 0.100897819 4.41829152E-02 5.14649861E-02 0.297863275 0.104911298 2.46196818E-02 2.26630270E-02 1.31756226E-02 5.42734601E-02 2.73159426E-02 1.90788023E-02 1.12060666 1.62584167E-02 2.73571312E-02 5.69159174 8.15604031E-02 0.281998247 1.63441524E-02 1.57651640E-02 4.35395949E-02 1.46267181E-02 1.23362662E-02 0.122581661 1.18143717E-02 3.30393538E-02 1.32913327 1.43615687E-02 3.16371620E-02 2.76059546E-02 3.55150923E-02 3.48275974E-02 5.45459799E-02 0.205432966 2.17371974E-02 3.30469155 1.34844091E-02 + 291738592.30064392 213271.12585343613 15.4850769 3.86497974 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 8.34817253E-03 3.45577039E-02 1.37234256E-02 1.61972940E-02 0.198364913 1.90918352E-02 4.08181176E-02 0.117088348 1.71713382E-02 3.18951271E-02 4.73095961E-02 0.121120244 1.16469324 2.20024530E-02 2.12306436E-02 3.31463106E-02 4.49479297E-02 0.117103130 0.120092198 0.100792415 4.40462343E-02 5.13890050E-02 0.297624946 0.104883723 2.45672874E-02 2.26291548E-02 1.31547637E-02 5.41764684E-02 2.72828713E-02 1.90436449E-02 1.11797154 1.62325948E-02 2.72423904E-02 5.68131590 8.14971328E-02 0.281324029 1.63250919E-02 1.57527849E-02 4.34815288E-02 1.46125965E-02 1.23139294E-02 0.122453868 1.17936470E-02 3.29774059E-02 1.32441854 1.42941764E-02 3.15274522E-02 2.68622581E-02 3.54540646E-02 3.47915553E-02 5.44873811E-02 0.205327928 2.17334367E-02 3.29892325 1.34695889E-02 + 283702203.53238821 213510.21249617921 15.4625893 3.86138487 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.24868397E-02 3.43115963E-02 1.36315636E-02 1.60875693E-02 0.196974874 1.90056544E-02 4.06737961E-02 0.116650499 1.70918349E-02 3.17333825E-02 4.70752604E-02 0.120709680 1.15952945 2.19537634E-02 2.11572610E-02 3.30610797E-02 4.48656827E-02 0.116718650 0.119746454 0.100301728 4.39300910E-02 5.13401292E-02 0.297556549 0.104768761 2.45356876E-02 2.26116888E-02 1.31302597E-02 5.40868193E-02 2.72663161E-02 1.90143399E-02 1.11575091 1.62229706E-02 2.72002649E-02 5.67417717 8.13307241E-02 0.280836165 1.62339807E-02 1.57395676E-02 4.34437953E-02 1.43539282E-02 1.23064369E-02 0.122360885 1.17848637E-02 3.29627991E-02 1.32208776 1.42839579E-02 3.14833894E-02 2.68551409E-02 3.54385041E-02 3.47893089E-02 5.45048006E-02 0.205025464 2.17867512E-02 3.29617238 1.34511543E-02 + 275665814.76413250 213686.05749814620 15.4499741 3.85912728 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.52117256E-02 3.40774842E-02 1.35294301E-02 1.59637127E-02 0.195431814 1.88828614E-02 4.04995419E-02 0.115998216 1.70191471E-02 3.16105075E-02 4.69567403E-02 0.120255053 1.15611148 2.18627024E-02 2.10915487E-02 3.30151208E-02 4.47379239E-02 0.116563775 0.119525157 0.100145258 4.38541062E-02 5.13039492E-02 0.297028899 0.104489446 2.44905222E-02 2.25571357E-02 1.31166773E-02 5.38647212E-02 2.72708386E-02 1.90073587E-02 1.11507559 1.62108764E-02 2.71766856E-02 5.67059469 8.13204199E-02 0.280794084 1.62256006E-02 1.57346409E-02 4.34347019E-02 1.43502606E-02 1.23042911E-02 0.122339234 1.17819197E-02 3.29474397E-02 1.32154918 1.42832790E-02 3.14484648E-02 2.68560629E-02 3.54349241E-02 3.47493477E-02 5.44913858E-02 0.205030531 2.17827689E-02 3.29513621 1.34479832E-02 + 267629425.99586183 213835.77135256148 15.4406757 3.85784221 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 1.76019240E-02 3.38512957E-02 1.34355845E-02 1.58872250E-02 0.194128588 1.88048407E-02 4.03251909E-02 0.115395024 1.69654638E-02 3.14865857E-02 4.68369946E-02 0.120010786 1.15316129 2.18059458E-02 2.10627504E-02 3.29464711E-02 4.46575284E-02 0.116492018 0.119292393 0.100022130 4.38369699E-02 5.12889996E-02 0.296826392 0.104621850 2.44743172E-02 2.25529838E-02 1.31135322E-02 5.38500361E-02 2.72597689E-02 1.89975016E-02 1.11470950 1.60937086E-02 2.71705315E-02 5.66791344 8.13272595E-02 0.280640721 1.62116736E-02 1.57048944E-02 4.34147418E-02 1.43482713E-02 1.22996503E-02 0.122272633 1.17759407E-02 3.29358540E-02 1.32129109 1.42763369E-02 3.14446017E-02 2.68418714E-02 3.54283787E-02 3.47447842E-02 5.44694141E-02 0.204999909 2.17765067E-02 3.29414845 1.34427696E-02 + 259593037.22745711 214473.12536261810 15.4131193 3.84547472 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 2.77268086E-02 3.35747860E-02 1.33065572E-02 1.57320537E-02 0.192897797 1.86831150E-02 4.00687046E-02 0.113856524 1.68589838E-02 3.13620977E-02 4.66752909E-02 0.119567640 1.14870000 2.16451939E-02 2.11062301E-02 3.28628831E-02 4.45130542E-02 0.116390429 0.119054250 9.98484194E-02 4.37416174E-02 5.12407087E-02 0.295382351 0.104165375 2.43271925E-02 2.24903189E-02 1.30927842E-02 5.37191667E-02 2.72209756E-02 1.89308599E-02 1.11330473 1.60487238E-02 2.71516722E-02 5.65783930 8.10560882E-02 0.279894233 1.61996167E-02 1.57048088E-02 4.32870500E-02 1.43410359E-02 1.22648273E-02 0.122126803 1.17363986E-02 3.28633338E-02 1.32029784 1.42478338E-02 3.14194709E-02 2.67811771E-02 3.53944078E-02 3.43946293E-02 5.42885214E-02 0.204243839 2.17385031E-02 3.28433609 1.34146661E-02 + 251556648.45905238 214674.76967180928 15.3995419 3.84317780 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 3.10361572E-02 3.32600288E-02 1.32078091E-02 1.56319011E-02 0.191731095 1.85931940E-02 3.99419069E-02 0.113070868 1.67941768E-02 3.12340017E-02 4.65701483E-02 0.119225614 1.14555097 2.15771981E-02 2.10542232E-02 3.27888578E-02 4.43953909E-02 0.116232000 0.118694089 9.96822417E-02 4.37036194E-02 5.11401519E-02 0.294811308 0.104146525 2.42614467E-02 2.24233735E-02 1.30747249E-02 5.36303483E-02 2.72057634E-02 1.89182665E-02 1.11199605 1.60352644E-02 2.71370485E-02 5.65533590 8.09941664E-02 0.279763877 1.61995720E-02 1.57058015E-02 4.32600118E-02 1.43285701E-02 1.22552980E-02 0.121869765 1.17210299E-02 3.26059721E-02 1.31848788 1.42449113E-02 3.13490257E-02 2.67740916E-02 3.53833772E-02 3.43325734E-02 5.40769286E-02 0.204132557 2.16064304E-02 3.28294730 1.34102972E-02 + 243520259.69064766 214839.78948938698 15.3955479 3.84346652 0.00000000 0.00000000 0.00000000 0.00000000 1.15994830E-03 3.20465229E-02 3.30559015E-02 1.31071461E-02 1.55540872E-02 0.190746799 1.85268130E-02 3.98480520E-02 0.112485297 1.67231243E-02 3.11116558E-02 4.64396514E-02 0.118962556 1.14260042 2.15598885E-02 2.10115798E-02 3.27573419E-02 4.42761853E-02 0.116122782 0.118487224 9.95552018E-02 4.36634645E-02 5.10971807E-02 0.294999987 0.104187876 2.42719296E-02 2.24281773E-02 1.30727971E-02 5.36347628E-02 2.72103176E-02 1.89235732E-02 1.11223352 1.60381123E-02 2.71353032E-02 5.65527487 8.08842629E-02 0.279698998 1.62023492E-02 1.57032181E-02 4.32687141E-02 1.43292407E-02 1.22560142E-02 0.121887155 1.17221577E-02 3.26172970E-02 1.31828201 1.42442426E-02 3.13431658E-02 2.67772991E-02 3.53800282E-02 3.43406387E-02 5.40856346E-02 0.204065338 2.15841848E-02 3.28315449 1.34100700E-02 + 235483870.92224294 215003.71863162171 15.3844547 3.84114027 0.00000000 0.00000000 0.00000000 0.00000000 4.08141036E-03 3.17940041E-02 3.27586047E-02 1.30104534E-02 1.54486429E-02 0.189538270 1.84120536E-02 3.97102460E-02 0.112109289 1.66636147E-02 3.09625268E-02 4.63360585E-02 0.118504755 1.13940513 2.15004701E-02 2.09731571E-02 3.26830707E-02 4.42209840E-02 0.115851022 0.118423723 9.94642824E-02 4.36056741E-02 5.10435477E-02 0.294831574 0.104253270 2.42620409E-02 2.24136747E-02 1.30589074E-02 5.36256172E-02 2.72113122E-02 1.88924614E-02 1.11134684 1.60267763E-02 2.71251518E-02 5.65365076 8.08450654E-02 0.279364258 1.61842927E-02 1.56960376E-02 4.32444923E-02 1.43241137E-02 1.22204032E-02 0.121852957 1.17198974E-02 3.26068699E-02 1.31730449 1.42403953E-02 3.13079357E-02 2.67610829E-02 3.53669003E-02 3.43397707E-02 5.39793149E-02 0.203589529 2.15699431E-02 3.28132844 1.34094600E-02 + 227447482.15383822 215257.13679618269 15.3700304 3.83856368 0.00000000 0.00000000 0.00000000 0.00000000 7.73507403E-03 3.15772966E-02 3.25202644E-02 1.29350200E-02 1.53280180E-02 0.188360691 1.83137823E-02 3.95186953E-02 0.111595534 1.65776815E-02 3.07611227E-02 4.61091362E-02 0.117873169 1.13473821 2.14653667E-02 2.09471006E-02 3.25902142E-02 4.41629887E-02 0.115335487 0.118358612 9.94444042E-02 4.35051322E-02 5.10037877E-02 0.294779718 0.104258798 2.42366716E-02 2.23962907E-02 1.30448258E-02 5.35425805E-02 2.71957591E-02 1.88425612E-02 1.10990095 1.60178319E-02 2.71133203E-02 5.65068388 8.08414370E-02 0.279081255 1.61793586E-02 1.56929158E-02 4.32257168E-02 1.43196220E-02 1.22123268E-02 0.121820115 1.17144315E-02 3.25822979E-02 1.31592381 1.42330714E-02 3.12956236E-02 2.67545041E-02 3.53355780E-02 3.43333967E-02 5.39513044E-02 0.203462914 2.15639807E-02 3.27933455 1.34040257E-02 + 219411093.38543350 215546.04187338508 15.3756037 3.83724070 0.00000000 0.00000000 0.00000000 0.00000000 2.90574748E-02 3.11023332E-02 3.23074162E-02 1.28652537E-02 1.52054140E-02 0.186994255 1.82141345E-02 3.93749923E-02 0.111899242 1.65169351E-02 3.06460653E-02 4.60335985E-02 0.117486253 1.13052559 2.13831346E-02 2.08942425E-02 3.24889347E-02 4.41477895E-02 0.115333520 0.117821373 9.93066728E-02 4.34381030E-02 5.09194508E-02 0.294310451 0.103986017 2.42099110E-02 2.23699342E-02 1.30305374E-02 5.34636527E-02 2.71445699E-02 1.88145824E-02 1.10904932 1.59863606E-02 2.69824024E-02 5.64747906 8.08230340E-02 0.279100388 1.61703546E-02 1.56652126E-02 4.31985222E-02 1.43184401E-02 1.22063011E-02 0.121879481 1.17107900E-02 3.25827189E-02 1.31461859 1.42071582E-02 3.12573463E-02 2.65777186E-02 3.53311412E-02 3.43402661E-02 5.39624244E-02 0.203255579 2.15595979E-02 3.27864337 1.34060634E-02 + 211374704.61702877 215697.52503820841 15.3668900 3.83595109 0.00000000 0.00000000 0.00000000 0.00000000 3.03750671E-02 3.08216400E-02 3.20991464E-02 1.28111774E-02 1.51231745E-02 0.186267838 1.81425139E-02 3.92615162E-02 0.111628972 1.64729785E-02 3.05471756E-02 4.59553562E-02 0.117107943 1.12916613 2.13431548E-02 2.08771415E-02 3.24501656E-02 4.41163369E-02 0.115183324 0.117806718 9.92520973E-02 4.33984920E-02 5.09113595E-02 0.294176519 0.103836440 2.41981633E-02 2.23694127E-02 1.30315991E-02 5.34850135E-02 2.71487180E-02 1.88154411E-02 1.10864592 1.59832742E-02 2.69816238E-02 5.64449453 8.07275474E-02 0.278866380 1.61569715E-02 1.56585127E-02 4.32225466E-02 1.43090431E-02 1.22031756E-02 0.121835962 1.17043443E-02 3.25869098E-02 1.31380224 1.42047610E-02 3.12349163E-02 2.65726671E-02 3.53255644E-02 3.43340635E-02 5.39612360E-02 0.203122154 2.15481948E-02 3.27783132 1.33959204E-02 + 203338315.84862405 215851.59497190558 15.3635530 3.83569956 0.00000000 0.00000000 0.00000000 0.00000000 3.18463631E-02 3.06508020E-02 3.19584347E-02 1.27253244E-02 1.50422025E-02 0.185232833 1.80645138E-02 3.91718000E-02 0.111329444 1.64155960E-02 3.04661654E-02 4.59194556E-02 0.116858788 1.12681901 2.13247612E-02 2.08273046E-02 3.24168652E-02 4.40728627E-02 0.115152106 0.117784999 9.92003679E-02 4.33701910E-02 5.09129874E-02 0.294294655 0.103916049 2.42068339E-02 2.23731920E-02 1.30212931E-02 5.35024405E-02 2.71570068E-02 1.88200120E-02 1.10871255 1.59806125E-02 2.69867983E-02 5.64426565 8.07556659E-02 0.278892577 1.61556173E-02 1.56605635E-02 4.32128645E-02 1.43054863E-02 1.22042187E-02 0.121848255 1.17015801E-02 3.25949416E-02 1.31417656 1.42029766E-02 3.12493816E-02 2.65706759E-02 3.53451557E-02 3.43578830E-02 5.39707914E-02 0.203178570 2.15442386E-02 3.27743506 1.33927055E-02 + 195301927.08021933 216051.82727068668 15.3577604 3.83566380 0.00000000 0.00000000 0.00000000 1.55349530E-03 3.19553465E-02 3.04211807E-02 3.17328759E-02 1.26402443E-02 1.49270864E-02 0.184101179 1.81003306E-02 3.90802957E-02 0.110916540 1.63567811E-02 3.03776264E-02 4.58262675E-02 0.116670214 1.12452114 2.12810598E-02 2.07935255E-02 3.23809460E-02 4.40523736E-02 0.115103297 0.117561214 9.90976691E-02 4.33775894E-02 5.08683138E-02 0.294435799 0.103869997 2.42035724E-02 2.23733671E-02 1.29766101E-02 5.34672551E-02 2.71795243E-02 1.88216418E-02 1.10867500 1.59814637E-02 2.69870330E-02 5.64224768 8.07712600E-02 0.278940767 1.61561966E-02 1.56652816E-02 4.32217494E-02 1.43071301E-02 1.22038117E-02 0.121838406 1.17035499E-02 3.26007307E-02 1.31424975 1.42039228E-02 3.12543251E-02 2.65712328E-02 3.53482515E-02 3.43619809E-02 5.39864078E-02 0.203159615 2.15435401E-02 3.27736259 1.33933900E-02 + 187265538.31181461 216499.44566274114 15.3314066 3.82545567 0.00000000 0.00000000 0.00000000 8.97933356E-03 3.16360928E-02 3.01635209E-02 3.14889960E-02 1.25582311E-02 1.48496134E-02 0.183259726 1.80187915E-02 3.89399603E-02 0.110627130 1.62922367E-02 3.02000158E-02 4.56474014E-02 0.116041340 1.12043428 2.12298501E-02 2.07388364E-02 3.22851948E-02 4.40161340E-02 0.114589036 0.117558397 9.90559980E-02 4.32752334E-02 5.08382022E-02 0.294264764 0.103956297 2.42087226E-02 2.23315973E-02 1.28551116E-02 5.14259376E-02 2.71012019E-02 1.87365878E-02 1.10606349 1.59462336E-02 2.69427523E-02 5.63548994 8.12184960E-02 0.279233545 1.61447059E-02 1.56631153E-02 4.31933254E-02 1.43008353E-02 1.22424569E-02 0.121795729 1.16988271E-02 3.25419568E-02 1.30967128 1.41829411E-02 3.11365668E-02 2.65553854E-02 3.53120603E-02 3.43147740E-02 5.36287315E-02 0.202656820 2.15345472E-02 3.26899576 1.33369854E-02 + 179229149.54340988 216670.63802434952 15.3212910 3.82444572 0.00000000 0.00000000 0.00000000 1.17973639E-02 3.13650444E-02 2.98905466E-02 3.12680863E-02 1.25058107E-02 1.47821205E-02 0.182295829 1.78615171E-02 3.87889855E-02 0.110223122 1.62429418E-02 3.00659593E-02 4.54893373E-02 0.115716629 1.11645913 2.11743098E-02 2.06422769E-02 3.22337598E-02 4.39372472E-02 0.114493400 0.117334336 9.89097282E-02 4.32337709E-02 5.08153401E-02 0.294056088 0.103842817 2.42079813E-02 2.22830735E-02 1.28453383E-02 5.13720550E-02 2.70825140E-02 1.87224168E-02 1.10557353 1.59678888E-02 2.69358046E-02 5.63339567 8.11331943E-02 0.279001474 1.61226299E-02 1.56575274E-02 4.31692749E-02 1.42785292E-02 1.22159272E-02 0.121667378 1.16873588E-02 3.24040316E-02 1.30897665 1.41803762E-02 3.11243385E-02 2.65504308E-02 3.53101008E-02 3.43079083E-02 5.36064357E-02 0.202606544 2.15291809E-02 3.26861930 1.33352000E-02 + 171192760.77500516 217094.07404512272 15.3086758 3.81806064 0.00000000 0.00000000 0.00000000 2.13034637E-02 3.11014988E-02 2.96928119E-02 3.10040824E-02 1.24373455E-02 1.46639096E-02 0.179404989 1.78039167E-02 3.86609510E-02 0.109409377 1.63260140E-02 2.98468322E-02 4.54269946E-02 0.115439780 1.11195421 2.11470593E-02 2.07063276E-02 3.22081223E-02 4.40293550E-02 0.113984987 0.117393322 9.88808721E-02 4.38482985E-02 5.08034900E-02 0.294098496 0.103910290 2.41946913E-02 2.22758073E-02 1.28237000E-02 5.13835251E-02 2.70547364E-02 1.87238287E-02 1.10391557 1.59722101E-02 2.69213449E-02 5.63405991 8.08309317E-02 0.278683126 1.61202494E-02 1.56569108E-02 4.31246385E-02 1.42722558E-02 1.22136399E-02 0.121711671 1.16872117E-02 3.24193984E-02 1.30665529 1.41598908E-02 3.10626924E-02 2.65579931E-02 3.52949984E-02 3.43068875E-02 5.35266250E-02 0.200457782 2.14106720E-02 3.26238847 1.33251818E-02 + 163156372.00660044 217315.10558031392 15.2963629 3.81626916 0.00000000 0.00000000 0.00000000 2.43349522E-02 3.08331717E-02 2.94595920E-02 3.07626985E-02 1.23633267E-02 1.45996958E-02 0.178577542 1.77388564E-02 3.85292843E-02 0.108648703 1.62727274E-02 2.97431070E-02 4.52717617E-02 0.115108676 1.10889935 2.11050157E-02 2.06825435E-02 3.21577229E-02 4.39446121E-02 0.113779172 0.117246792 9.88140181E-02 4.38209400E-02 5.07838763E-02 0.294064581 0.103907503 2.41833348E-02 2.22662967E-02 1.28117511E-02 5.13679087E-02 2.70263143E-02 1.87127348E-02 1.10242999 1.59572084E-02 2.69010179E-02 5.63008165 8.07549581E-02 0.278482974 1.61101613E-02 1.56482849E-02 4.30925041E-02 1.42345112E-02 1.22078927E-02 0.121624418 1.16846170E-02 3.24292406E-02 1.30606055 1.41518293E-02 3.10450774E-02 2.65699290E-02 3.52693088E-02 3.42936702E-02 5.34380451E-02 0.200426728 2.14103796E-02 3.26091552 1.33211445E-02 + 155119983.23819572 217439.57414573582 15.2951517 3.81534743 0.00000000 0.00000000 0.00000000 2.93137729E-02 3.06417141E-02 2.93030217E-02 3.06171644E-02 1.23287737E-02 1.45284059E-02 0.177723214 1.76774226E-02 3.84270512E-02 0.108318277 1.62215997E-02 2.96607148E-02 4.51796278E-02 0.114833742 1.10638249 2.10561138E-02 2.06560045E-02 3.21179442E-02 4.39049751E-02 0.113630623 0.117163487 9.87267941E-02 4.38019708E-02 5.07847369E-02 0.293830961 0.103827916 2.41404921E-02 2.22557895E-02 1.28041329E-02 5.13479225E-02 2.69860458E-02 1.86953582E-02 1.10235369 1.59483179E-02 2.68939901E-02 5.63029432 8.07473361E-02 0.278510988 1.61153469E-02 1.56552847E-02 4.30836082E-02 1.42320339E-02 1.22065302E-02 0.121616162 1.16797723E-02 3.24198566E-02 1.30611682 1.41522018E-02 3.10488511E-02 2.65708100E-02 3.52665037E-02 3.43142189E-02 5.34359477E-02 0.200386375 2.14139130E-02 3.26047516 1.33246789E-02 + 147083594.46979100 217570.06477574148 15.2909107 3.81463766 0.00000000 0.00000000 3.99492739E-04 2.98726000E-02 3.04479618E-02 2.91372780E-02 3.04726288E-02 1.22678410E-02 1.44850193E-02 0.177012220 1.76216699E-02 3.83070223E-02 0.108091705 1.61546413E-02 2.96271686E-02 4.51103672E-02 0.114690267 1.10449183 2.10230891E-02 2.06343308E-02 3.21082622E-02 4.38721664E-02 0.113616399 0.117204182 9.87361521E-02 4.38218489E-02 5.07826731E-02 0.293436468 0.103252441 2.41404977E-02 2.22645178E-02 1.28028663E-02 5.13424501E-02 2.69792248E-02 1.86848398E-02 1.10262299 1.59410872E-02 2.68867221E-02 5.62979460 8.07193518E-02 0.278563261 1.61163360E-02 1.56525578E-02 4.30938229E-02 1.42396027E-02 1.22090476E-02 0.121644720 1.16807427E-02 3.24195251E-02 1.30603683 1.41496724E-02 3.10492199E-02 2.65705064E-02 3.52657959E-02 3.43108773E-02 5.34349531E-02 0.200329289 2.14155298E-02 3.26054573 1.33269774E-02 + 139047205.70138627 217804.06494487214 15.2913675 3.81400561 0.00000000 0.00000000 8.86940397E-03 2.96714921E-02 3.02511808E-02 2.89292298E-02 3.02988719E-02 1.21707795E-02 1.44147454E-02 0.176105961 1.75472256E-02 3.81932743E-02 0.107824840 1.60987172E-02 2.95276083E-02 4.49620374E-02 0.114422411 1.10292280 2.09672321E-02 2.05937568E-02 3.20617855E-02 4.38438803E-02 0.113555789 0.116975226 9.86118615E-02 4.37662937E-02 5.07539213E-02 0.293493867 0.103432454 2.41492651E-02 2.22369451E-02 1.28020514E-02 5.13115600E-02 2.69730575E-02 1.86930075E-02 1.10241091 1.59274526E-02 2.68894807E-02 5.62809610 8.06867853E-02 0.278419435 1.61080007E-02 1.56396627E-02 4.30811830E-02 1.42432880E-02 1.22119272E-02 0.121549621 1.16729969E-02 3.23996581E-02 1.30586696 1.41462917E-02 3.10494509E-02 2.65672337E-02 3.52699645E-02 3.42986584E-02 5.34312576E-02 0.200332358 2.14116499E-02 3.25989580 1.33293793E-02 + 131010816.93301129 218023.54028074784 15.2852812 3.81265855 0.00000000 0.00000000 1.50630698E-02 2.94000283E-02 3.00036296E-02 2.87096314E-02 3.00864466E-02 1.20999478E-02 1.43448338E-02 0.175040811 1.74699984E-02 3.81788239E-02 0.107729271 1.60559043E-02 2.94706114E-02 4.48582917E-02 0.114080690 1.10057831 2.08964385E-02 2.05486678E-02 3.20246108E-02 4.37231362E-02 0.113450624 0.116920553 9.84881893E-02 4.37208787E-02 5.07019013E-02 0.293531805 0.103383072 2.41380371E-02 2.22139880E-02 1.27915926E-02 5.12466580E-02 2.69610379E-02 1.86648015E-02 1.10160720 1.59229767E-02 2.68554017E-02 5.62570047 8.06582570E-02 0.278388828 1.60999708E-02 1.56412181E-02 4.30774875E-02 1.42452847E-02 1.22066205E-02 0.121441372 1.16682928E-02 3.23803239E-02 1.30435395 1.41293295E-02 3.10140233E-02 2.65085790E-02 3.52661870E-02 3.42892446E-02 5.34113161E-02 0.200281367 2.14099437E-02 3.25881886 1.33287990E-02 + 122974428.16468108 218262.04076000841 15.2738247 3.81272197 0.00000000 0.00000000 2.16832925E-02 2.91981306E-02 2.98050735E-02 2.85560302E-02 2.99539417E-02 1.20418658E-02 1.42793786E-02 0.173805773 1.74114406E-02 3.81313078E-02 0.107321203 1.59525033E-02 2.94129029E-02 4.48079333E-02 0.113896362 1.09677637 2.08322015E-02 2.04968695E-02 3.19976509E-02 4.36398163E-02 0.113401011 0.116343774 9.82181877E-02 4.36298326E-02 5.06593548E-02 0.293533742 0.103678450 2.40625385E-02 2.21881699E-02 1.27685359E-02 5.11428304E-02 2.69011166E-02 1.86248887E-02 1.10074413 1.59135703E-02 2.68009193E-02 5.61705875 8.06195512E-02 0.278301656 1.60963275E-02 1.56391952E-02 4.30639572E-02 1.42413229E-02 1.22041171E-02 0.121412314 1.16698612E-02 3.23813595E-02 1.30396664 1.41269481E-02 3.10115814E-02 2.65109707E-02 3.52628157E-02 3.42875309E-02 5.34041636E-02 0.200251684 2.14128736E-02 3.25895739 1.33320382E-02 + 114938039.39635086 218640.14690903149 15.2418385 3.80649424 0.00000000 0.00000000 2.98582055E-02 2.87788566E-02 2.94794887E-02 2.82724015E-02 2.97757518E-02 1.19648362E-02 1.41784316E-02 0.172340974 1.73206571E-02 3.79677452E-02 0.106983826 1.58791970E-02 2.92882137E-02 4.46928144E-02 0.113685049 1.09160912 2.07784194E-02 2.04192661E-02 3.18547897E-02 4.34450097E-02 0.113290392 0.115986504 9.79751274E-02 4.35206518E-02 5.05711325E-02 0.293044239 0.103651524 2.40313616E-02 2.21735556E-02 1.27533479E-02 5.10337688E-02 2.68758908E-02 1.85994543E-02 1.09911597 1.58951636E-02 2.68016048E-02 5.59833097 7.95856863E-02 0.275618643 1.60568655E-02 1.56229110E-02 4.30263355E-02 1.41748786E-02 1.21931778E-02 0.120967872 1.15931174E-02 3.23605947E-02 1.30342662 1.41042462E-02 3.09974700E-02 2.64788307E-02 3.52530926E-02 3.42502967E-02 5.33419922E-02 0.200188443 2.13902388E-02 3.25565934 1.33246919E-02 + 106901650.62802064 218831.17962911545 15.2384911 3.80601144 0.00000000 0.00000000 3.28450091E-02 2.85774898E-02 2.92876828E-02 2.81199384E-02 2.96236407E-02 1.19126458E-02 1.41087091E-02 0.171584502 1.72462221E-02 3.76721658E-02 0.106737755 1.58268865E-02 2.92469598E-02 4.46348563E-02 0.113564864 1.08958256 2.07686927E-02 2.03963909E-02 3.18329930E-02 4.34021689E-02 0.113272674 0.115821205 9.78886709E-02 4.35325243E-02 5.04948720E-02 0.292964756 0.103677832 2.40312871E-02 2.21805219E-02 1.27544841E-02 5.10636568E-02 2.68993434E-02 1.85938496E-02 1.09876931 1.58939473E-02 2.67990511E-02 5.59764433 7.96166733E-02 0.275616169 1.60560962E-02 1.56228058E-02 4.30285819E-02 1.41784344E-02 1.21935066E-02 0.121003211 1.15966229E-02 3.23661603E-02 1.30342650 1.41029079E-02 3.10003180E-02 2.64795590E-02 3.52578647E-02 3.42489667E-02 5.33411540E-02 0.200143442 2.13857628E-02 3.25524616 1.33242412E-02 + 98865261.859690428 219104.52222745650 15.2217875 3.80211687 0.00000000 6.03418390E-04 3.75686362E-02 2.83301566E-02 2.90028192E-02 2.78737489E-02 2.94314697E-02 1.18171899E-02 1.40032126E-02 0.170421138 1.71482917E-02 3.75283025E-02 0.106342740 1.57436486E-02 2.91328728E-02 4.45292518E-02 0.113106072 1.08500123 2.06447206E-02 1.99503060E-02 3.17403488E-02 4.32989597E-02 0.113072485 0.115530759 9.76868942E-02 4.34099212E-02 5.04231900E-02 0.292619705 0.103081778 2.39638016E-02 2.21752357E-02 1.27412658E-02 5.09931408E-02 2.68811043E-02 1.85553432E-02 1.09772682 1.58710070E-02 2.66164411E-02 5.59319592 7.96395540E-02 0.275605619 1.60658099E-02 1.56180747E-02 4.29259017E-02 1.41586307E-02 1.21806180E-02 0.121008530 1.15944464E-02 3.23554650E-02 1.30183721 1.40771959E-02 3.09656747E-02 2.60471497E-02 3.52460667E-02 3.42488177E-02 5.33320419E-02 0.200138777 2.13888306E-02 3.25230598 1.32843358E-02 + 90828873.091360211 219237.52589972122 15.2506161 3.80125999 0.00000000 3.47654521E-02 3.72975171E-02 2.81833168E-02 2.88257785E-02 2.77474765E-02 2.93286014E-02 1.17507558E-02 1.39297647E-02 0.169837952 1.70980133E-02 3.74257602E-02 0.106185772 1.57091264E-02 2.90917121E-02 4.44502719E-02 0.112865441 1.08389735 2.06010249E-02 1.99243147E-02 3.17082852E-02 4.31944318E-02 0.113071620 0.115514033 9.75442082E-02 4.33867387E-02 5.04108407E-02 0.292394608 0.103045888 2.39546541E-02 2.21817791E-02 1.27401948E-02 5.09838760E-02 2.68974788E-02 1.85596161E-02 1.09754777 1.58757158E-02 2.66099293E-02 5.59265280 7.96411186E-02 0.275591791 1.60746966E-02 1.56195033E-02 4.29103114E-02 1.41619314E-02 1.21830935E-02 0.120992132 1.15947351E-02 3.23562101E-02 1.30190659 1.40779968E-02 3.09591405E-02 2.60402467E-02 3.52504961E-02 3.42548080E-02 5.33301793E-02 0.200108513 2.13860106E-02 3.25170231 1.32824695E-02 + 82792484.323029995 219430.96662127067 15.2419672 3.79928851 0.00000000 3.66026647E-02 3.70011963E-02 2.80118771E-02 2.86274627E-02 2.75986735E-02 2.91645862E-02 1.16827553E-02 1.38677945E-02 0.169009313 1.70124378E-02 3.72647531E-02 0.105970316 1.56670008E-02 2.89799850E-02 4.43755202E-02 0.112498298 1.08256280 2.05400269E-02 1.98851041E-02 3.16768885E-02 4.31241132E-02 0.113009132 0.115507886 9.74526256E-02 4.33515944E-02 5.03612868E-02 0.292270452 0.102836974 2.39448715E-02 2.21522637E-02 1.27247423E-02 5.09615093E-02 2.68937256E-02 1.85370762E-02 1.09704757 1.58736389E-02 2.65828799E-02 5.59020710 7.95662329E-02 0.275317550 1.60696991E-02 1.56052597E-02 4.28928845E-02 1.41650382E-02 1.21835880E-02 0.120856121 1.15855224E-02 3.23190689E-02 1.30163693 1.40730711E-02 3.09543461E-02 2.60383543E-02 3.52489427E-02 3.42499427E-02 5.33094853E-02 0.200078264 2.13789660E-02 3.25032139 1.32805537E-02 + 74756095.554699779 219528.56083092472 15.2428942 3.79966879 0.00000000 3.71896736E-02 3.68011221E-02 2.78815608E-02 2.84695514E-02 2.74541136E-02 2.90491171E-02 1.16369799E-02 1.38259986E-02 0.168425232 1.69725195E-02 3.71922702E-02 0.105735205 1.56432018E-02 2.89331414E-02 4.43734452E-02 0.112401240 1.08219981 2.05171593E-02 1.98886544E-02 3.16998251E-02 4.31086197E-02 0.113023117 0.115549408 9.74969193E-02 4.33601514E-02 5.03914282E-02 0.292284101 0.102819540 2.39564516E-02 2.21565440E-02 1.27264140E-02 5.09675331E-02 2.68832520E-02 1.85363218E-02 1.09727597 1.58834159E-02 2.65894458E-02 5.59168434 7.96010792E-02 0.275471032 1.60755012E-02 1.56087521E-02 4.29027118E-02 1.41667193E-02 1.21851489E-02 0.120868474 1.15870815E-02 3.23197283E-02 1.30180323 1.40764592E-02 3.09631657E-02 2.60386188E-02 3.52522880E-02 3.42513621E-02 5.33220172E-02 0.200112417 2.13820916E-02 3.25064087 1.32830935E-02 + 66719706.786369562 219717.04834567782 15.2331324 3.79811287 0.00000000 3.86245549E-02 3.65496799E-02 2.77295019E-02 2.82901619E-02 2.73226742E-02 2.88960058E-02 1.15882279E-02 1.37680201E-02 0.167602569 1.69189516E-02 3.70990075E-02 0.105495505 1.56105012E-02 2.88790185E-02 4.43256572E-02 0.112109452 1.08044457 2.04811916E-02 1.76825430E-02 3.14791687E-02 4.30575870E-02 0.112777516 0.115361549 9.75109115E-02 4.33253497E-02 5.03500178E-02 0.292255670 0.102513693 2.39507183E-02 2.21469849E-02 1.27206296E-02 5.09375483E-02 2.68656909E-02 1.85268503E-02 1.09672391 1.58837605E-02 2.65833903E-02 5.58994102 7.96154365E-02 0.275397032 1.60719119E-02 1.56073356E-02 4.29077521E-02 1.41630284E-02 1.21812457E-02 0.120853916 1.15845427E-02 3.23481262E-02 1.30190253 1.40743721E-02 3.09703033E-02 2.60348115E-02 3.52531709E-02 3.42507362E-02 5.33171780E-02 0.200064063 2.13794485E-02 3.24954557 1.32799819E-02 + 58683318.018039346 219870.62544581926 15.2313051 3.79879069 0.00000000 3.96158807E-02 3.63101102E-02 2.75352448E-02 2.81081088E-02 2.71496195E-02 2.87063103E-02 1.15197729E-02 1.36861186E-02 0.166840613 1.68675762E-02 3.70019116E-02 0.105102599 1.55969197E-02 2.88081337E-02 4.42791358E-02 0.111942284 1.07924950 2.04784088E-02 1.76621135E-02 3.14459726E-02 4.30302694E-02 0.112699419 0.115310684 9.74674672E-02 4.32827100E-02 5.03252484E-02 0.292201430 0.102494620 2.39615198E-02 2.21649781E-02 1.27197346E-02 5.09596914E-02 2.68809423E-02 1.85288731E-02 1.09687543 1.58907212E-02 2.65889820E-02 5.59026003 7.96167627E-02 0.275379717 1.60648189E-02 1.56049374E-02 4.29141112E-02 1.41581371E-02 1.21827442E-02 0.120846167 1.15863178E-02 3.23479325E-02 1.30204594 1.40825156E-02 3.09839267E-02 2.60391068E-02 3.52607742E-02 3.42681743E-02 5.33227026E-02 0.200022802 2.13872753E-02 3.25035858 1.32815698E-02 + 50646929.249709129 220293.65246215119 15.2050495 3.79170251 0.00000000 4.63948399E-02 3.60453315E-02 2.73442473E-02 2.78732628E-02 2.69840155E-02 2.85462476E-02 1.14490977E-02 1.35898180E-02 0.165484354 1.67715829E-02 3.68548222E-02 0.101032697 1.55160986E-02 2.86999550E-02 4.41326611E-02 0.111620717 1.07608843 2.03580726E-02 1.76118575E-02 3.13210413E-02 4.29659560E-02 0.112597093 0.115112446 9.67734456E-02 4.23531458E-02 5.00984788E-02 0.291643769 0.102440208 2.38891542E-02 2.21126415E-02 1.27106495E-02 5.08619845E-02 2.68813726E-02 1.84872318E-02 1.09543586 1.58510096E-02 2.65543144E-02 5.58412504 7.93985054E-02 0.275001317 1.60421710E-02 1.55826705E-02 4.27970812E-02 1.41392145E-02 1.21665588E-02 0.120673396 1.15535306E-02 3.22840996E-02 1.29865336 1.40290558E-02 3.09336558E-02 2.60046460E-02 3.52169536E-02 3.41195725E-02 5.32186143E-02 0.199693307 2.13584695E-02 3.24431276 1.32556427E-02 + 42610540.481378913 220440.76795625643 15.2040730 3.79151130 3.75472242E-03 4.61327769E-02 3.57919000E-02 2.71657482E-02 2.77263597E-02 2.68365070E-02 2.84399502E-02 1.14069032E-02 1.35414032E-02 0.164903387 1.67350695E-02 3.67885754E-02 0.100663990 1.54866176E-02 2.86427122E-02 4.41064723E-02 0.111385718 1.07491791 2.03271024E-02 1.76044796E-02 3.12913433E-02 4.29635644E-02 0.112555236 0.115100324 9.67532992E-02 4.23288643E-02 5.00950329E-02 0.291782379 0.102483034 2.38875523E-02 2.21165456E-02 1.27084274E-02 5.08742742E-02 2.68799234E-02 1.84979308E-02 1.09514141 1.58578046E-02 2.65561193E-02 5.58396578 7.93995261E-02 0.275121927 1.60461012E-02 1.55861489E-02 4.27994207E-02 1.41391074E-02 1.21679055E-02 0.120697603 1.15557229E-02 3.22817676E-02 1.29848635 1.40284104E-02 3.09371706E-02 2.60028616E-02 3.52189280E-02 3.40951644E-02 5.32084480E-02 0.199611858 2.13558432E-02 3.24388337 1.32531757E-02 + 34574151.713048697 220607.23439810652 15.1997595 3.78993130 6.81064092E-03 4.57952321E-02 3.55839543E-02 2.67979503E-02 2.75663286E-02 2.67261993E-02 2.83229686E-02 1.13646835E-02 1.34995589E-02 0.164454982 1.66947655E-02 3.67306508E-02 0.100347251 1.54546378E-02 2.85565462E-02 4.40528654E-02 0.111257359 1.07363141 2.03100126E-02 1.75884888E-02 3.12764645E-02 4.29683663E-02 0.112472951 0.115013450 9.67123434E-02 4.22997996E-02 5.00819795E-02 0.291797340 0.102481931 2.38828473E-02 2.21096613E-02 1.27034243E-02 5.08612879E-02 2.68723499E-02 1.84991043E-02 1.09492350 1.58655457E-02 2.65513919E-02 5.58322382 7.93336928E-02 0.275016397 1.60451215E-02 1.55820521E-02 4.27905768E-02 1.41395619E-02 1.21689755E-02 0.120740019 1.15569346E-02 3.22768390E-02 1.29815888 1.40263215E-02 3.09340265E-02 2.60125566E-02 3.52207497E-02 3.40945646E-02 5.31789213E-02 0.199357435 2.13328730E-02 3.24239826 1.32504264E-02 + 26537762.944702215 220836.63097347875 15.1936979 3.78900194 9.33356956E-03 4.53182310E-02 3.52593847E-02 2.66230442E-02 2.74252724E-02 2.65394822E-02 2.81463582E-02 1.13144377E-02 1.34518323E-02 0.163766652 1.66477114E-02 3.66679132E-02 0.100181401 1.54057657E-02 2.85237730E-02 4.40054163E-02 0.111168370 1.07231140 2.03026608E-02 1.75648630E-02 3.12603936E-02 4.29007076E-02 0.112362459 0.114766210 9.64967161E-02 4.22586240E-02 5.00619598E-02 0.291178823 0.102255382 2.38351002E-02 2.20729001E-02 1.27036581E-02 5.07958755E-02 2.68536247E-02 1.84984114E-02 1.09416640 1.58435535E-02 2.65498981E-02 5.58129930 7.93415681E-02 0.275021940 1.60462987E-02 1.55871334E-02 4.27931845E-02 1.41373510E-02 1.21629965E-02 0.120739020 1.15570240E-02 3.22691090E-02 1.29828370 1.40217282E-02 3.09351943E-02 2.60107238E-02 3.52202803E-02 3.40974070E-02 5.31600453E-02 0.199352100 2.13318523E-02 3.24226236 1.32495975E-02 + 18501374.176353373 221182.27573836825 15.1713686 3.78405237 1.51532125E-02 4.49004732E-02 3.48310918E-02 2.63669323E-02 2.72546932E-02 2.64026765E-02 2.79817544E-02 1.12483259E-02 1.33888861E-02 0.163135096 1.65786725E-02 3.65007706E-02 9.97594073E-02 1.53596597E-02 2.83795968E-02 4.39603254E-02 0.110595852 1.06954408 2.02156547E-02 1.74876135E-02 3.10890172E-02 4.28149402E-02 0.112043731 0.114683501 9.64181945E-02 4.21828441E-02 5.00074290E-02 0.291003346 0.102131002 2.38001496E-02 2.19912156E-02 1.26815708E-02 5.07191233E-02 2.68160887E-02 1.84750352E-02 1.09066153 1.58230942E-02 2.65342053E-02 5.57465744 7.89914429E-02 0.274369568 1.60301682E-02 1.55634470E-02 4.26845029E-02 1.41218035E-02 1.21488292E-02 0.120430663 1.15361037E-02 3.22144628E-02 1.29505002 1.40167521E-02 3.08842752E-02 2.59768385E-02 3.52088585E-02 3.40690948E-02 5.26972413E-02 0.199082002 2.12508570E-02 3.23821950 1.32436575E-02 + 10464985.408011846 221350.12912598392 15.1694708 3.78392363 1.67503208E-02 4.46184985E-02 3.46086584E-02 2.61563305E-02 2.70894170E-02 2.62759179E-02 2.78280452E-02 1.11974031E-02 1.33376429E-02 0.162691861 1.65366624E-02 3.64528820E-02 9.96800512E-02 1.53534366E-02 2.83507407E-02 4.38626111E-02 0.110515878 1.06891549 2.01919470E-02 1.74767543E-02 3.10725477E-02 4.27805893E-02 0.112033695 0.114624150 9.63597745E-02 4.21516560E-02 4.99847606E-02 0.290758967 0.101970904 2.37829555E-02 2.19899546E-02 1.26800435E-02 5.06902449E-02 2.68127620E-02 1.84579529E-02 1.09007359 1.58168022E-02 2.65090261E-02 5.57462692 7.89758191E-02 0.274436891 1.60326995E-02 1.55586768E-02 4.27028798E-02 1.41189750E-02 1.21511500E-02 0.120486431 1.15408115E-02 3.22082154E-02 1.29537177 1.40204960E-02 3.08816526E-02 2.59752218E-02 3.52167860E-02 3.40619795E-02 5.26837558E-02 0.199086919 2.12587006E-02 3.23838830 1.32443123E-02 + 2428596.6396688623 221522.75562558573 15.1662416 3.78327727 1.86728593E-02 4.43610065E-02 3.44308764E-02 2.60327645E-02 2.69488394E-02 2.61382833E-02 2.77122911E-02 1.11544225E-02 1.32968361E-02 0.162153393 1.67122073E-02 3.64498384E-02 9.93243456E-02 1.53372400E-02 2.83075720E-02 4.38236594E-02 0.110368997 1.06789970 2.01619789E-02 1.74483620E-02 3.10716759E-02 4.27242666E-02 0.111957610 0.114601433 9.62010920E-02 4.21331562E-02 4.99595813E-02 0.290700614 0.101889454 2.37847324E-02 2.19527166E-02 1.26709091E-02 5.06554693E-02 2.67757382E-02 1.84489097E-02 1.08953857 1.58107150E-02 2.64992062E-02 5.57388878 7.89867565E-02 0.274406284 1.60335787E-02 1.55622205E-02 4.27089073E-02 1.41159622E-02 1.21522294E-02 0.120489880 1.15385577E-02 3.22059244E-02 1.29559195 1.40201924E-02 3.08879130E-02 2.59913579E-02 3.52170616E-02 3.40832137E-02 5.26987948E-02 0.199078009 2.12594569E-02 3.23797154 1.32421805E-02 + + Minimum impactor diameter = 2.2200212792338626E-002 + Maximum impactor diameter = 11.106882406088582 + Minimum crater diameter = 4.0000045451624269 d/D = 0.23233126621055267 r/D = 7.2331266210552664E-002 + Maximum crater diameter = 316.58747625558726 d/D = 0.20347746253469898 r/D = 4.3477462534698974E-002 + Tallying craters + Total craters generated: 1866510 + Surface-affecting craters generated: 167582 + Visible craters generated: 167582 + Craters killed during tally: 19321 + Writing surface files + Writing output files + Timing information + nthreads walltime + 2 78058.845182961784 + 1 Reading FORTRAN output + 1 Displaying results +plotting + 1 time = 3.0000000e+09 + 1 saving window diff --git a/test/pdistribution.dat b/test/pdistribution.dat new file mode 100644 index 00000000..e6fb926f --- /dev/null +++ b/test/pdistribution.dat @@ -0,0 +1,67 @@ +# Dlo(m) Dhi(m) Dmean(m) dN N>D R + 1.3486991523E-03 1.9073486328E-03 1.6423004228E-03 5.9957729000E+15 1.0573139000E+16 4.7540482997E+04 + 1.9073486328E-03 2.6973983047E-03 2.2062293551E-03 3.0282298000E+15 4.5773661000E+15 4.1161046534E+04 + 2.6973983047E-03 3.8146972656E-03 3.1208955721E-03 1.0248559200E+15 1.5491363000E+15 2.7882462729E+04 + 3.8146972656E-03 5.3947966094E-03 4.4147672853E-03 3.4684608000E+14 5.2428038000E+14 1.8887559469E+04 + 5.3947966094E-03 7.6293945312E-03 6.2450568315E-03 1.1738450100E+14 1.7743430000E+14 1.2794418503E+04 + 7.6293945312E-03 1.0789593219E-02 8.8113402265E-03 3.9220277000E+13 6.0049799000E+13 8.4902832707E+03 + 1.0789593219E-02 1.5258789062E-02 1.2398529406E-02 1.3780103600E+13 2.0829522000E+13 5.8767014157E+03 + 1.5258789062E-02 2.1579186438E-02 1.7538754648E-02 4.6636556000E+12 7.0494184000E+12 3.9808732083E+03 + 2.1579186438E-02 3.0517578125E-02 2.4810032472E-02 1.5783395700E+12 2.3857628000E+12 2.6966405506E+03 + 3.0517578125E-02 4.3158372875E-02 3.5095861778E-02 5.3416376000E+11 8.0742323000E+11 1.8267022910E+03 + 4.3158372875E-02 6.1035156250E-02 4.9646025810E-02 1.8077917700E+11 2.7325947000E+11 1.2374067865E+03 + 6.1035156250E-02 8.6316745750E-02 7.0228446998E-02 6.1181818000E+10 9.2480293000E+10 8.3821841280E+02 + 8.6316745750E-02 1.2207031250E-01 9.9344000739E-02 2.0706007000E+10 3.1298475000E+10 5.6780854044E+02 + 1.2207031250E-01 1.7263349150E-01 1.4053038118E-01 7.0076168000E+09 1.0592468000E+10 3.8463309265E+02 + 1.7263349150E-01 2.4414062500E-01 1.9879195376E-01 2.3716157000E+09 3.5848512000E+09 2.6055016587E+02 + 2.4414062500E-01 3.4526698300E-01 2.8120781247E-01 8.0263537000E+08 1.2132355000E+09 1.7649649016E+02 + 3.4526698300E-01 4.8828125000E-01 3.9779192232E-01 2.7163909000E+08 4.1060013000E+08 1.1955858936E+02 + 4.8828125000E-01 6.9053396600E-01 5.6270987859E-01 9.1931903000E+07 1.3896104000E+08 8.0988901063E+01 + 6.9053396600E-01 9.7656250000E-01 7.9600009472E-01 3.1112880000E+07 4.7029137000E+07 5.4861820139E+01 + 9.7656250000E-01 1.3810679320E+00 1.1260085777E+00 1.0529655700E+07 1.5916257000E+07 3.7163354616E+01 + 1.3810679320E+00 1.9531250000E+00 1.5928331121E+00 3.5635933000E+06 5.3866013000E+06 2.5174427554E+01 + 1.9531250000E+00 2.7621358640E+00 2.2531953761E+00 1.2060409200E+06 1.8230080000E+06 1.7053135530E+01 + 2.7621358640E+00 3.9062500000E+00 3.1873328893E+00 4.0816510000E+05 6.1696708000E+05 1.1551776792E+01 + 3.9062500000E+00 5.5242717280E+00 4.5087483246E+00 1.3813683200E+05 2.0880198000E+05 7.8251581619E+00 + 5.5242717280E+00 7.8125000000E+00 6.3780005342E+00 4.6750100000E+04 7.0665148000E+04 5.3007442490E+00 + 7.8125000000E+00 1.1048543456E+01 9.0222129591E+00 1.5821744200E+04 2.3915048000E+04 3.5907009404E+00 + 1.1048543456E+01 1.5625000000E+01 1.2762669455E+01 5.3545507000E+03 8.0933038000E+03 2.4323062540E+00 + 1.5625000000E+01 2.2097086912E+01 1.8053847947E+01 1.8121085100E+03 2.7387531000E+03 1.6475902015E+00 + 2.2097086912E+01 3.1250000000E+01 2.5538629172E+01 6.1323525000E+02 9.2664459000E+02 1.1159905542E+00 + 3.1250000000E+01 4.4194173824E+01 3.6126365121E+01 2.0750359000E+02 3.1340934000E+02 7.5582991915E-01 + 4.4194173824E+01 6.2500000000E+01 5.1103211219E+01 7.0196515000E+01 1.0590575000E+02 5.1176524742E-01 + 6.2500000000E+01 8.8388347648E+01 7.2287809290E+01 2.3732056000E+01 3.5709235000E+01 3.4627905441E-01 + 8.8388347648E+01 1.2500000000E+02 1.0224974589E+02 8.0103979000E+00 1.1977179000E+01 2.3389528742E-01 + 1.2500000000E+02 1.7677669530E+02 1.4460796620E+02 2.6911134000E+00 3.9667811000E+00 1.5717169091E-01 + 1.7677669530E+02 2.5000000000E+02 2.0438592922E+02 8.8924006000E-01 1.2756677000E+00 1.0368660994E-01 + 2.5000000000E+02 3.5355339059E+02 2.8776111549E+02 2.7507710000E-01 3.8642764000E-01 6.3297482708E-02 + 3.5355339059E+02 5.0000000000E+02 4.0384615403E+02 8.1608429000E-02 1.1135054000E-01 3.6703167891E-02 + 5.0000000000E+02 7.0710678119E+02 5.7071038316E+02 2.1680416800E-02 2.9742111000E-02 1.9459005009E-02 + 7.0710678119E+02 1.0000000000E+03 8.0804829566E+02 5.7227971000E-03 8.0616942000E-03 1.0308868204E-02 + 1.0000000000E+03 1.4142135624E+03 1.1454774644E+03 1.6015953800E-03 2.3388971000E-03 5.8114986495E-03 + 1.4142135624E+03 2.0000000000E+03 1.6231199419E+03 4.8305643000E-04 7.3730172000E-04 3.5262280494E-03 + 2.0000000000E+03 2.8284271247E+03 2.2988759447E+03 1.5367903000E-04 2.5424529000E-04 2.2537560624E-03 + 2.8284271247E+03 4.0000000000E+03 3.2607740942E+03 5.2011931000E-05 1.0056626000E-04 1.5392026614E-03 + 4.0000000000E+03 5.6568542495E+03 4.6414592887E+03 2.0644944000E-05 4.8554329000E-05 1.2459282690E-03 + 5.6568542495E+03 8.0000000000E+03 6.6059900571E+03 1.0356911000E-05 2.7909385000E-05 1.2742207923E-03 + 8.0000000000E+03 1.1313708499E+04 9.3329647788E+03 5.9892040000E-06 1.7552474000E-05 1.4693108476E-03 + 1.1313708499E+04 1.6000000000E+04 1.3283912866E+04 3.8265792000E-06 1.1563270000E-05 1.9140772515E-03 + 1.6000000000E+04 2.2627416998E+04 1.8824789171E+04 2.8357070000E-06 7.7366908000E-06 2.8543512865E-03 + 2.2627416998E+04 3.2000000000E+04 2.6617714667E+04 2.1273989000E-06 4.9009838000E-06 4.2805732285E-03 + 3.2000000000E+04 4.5254833996E+04 3.7470040859E+04 1.4348502000E-06 2.7735849000E-06 5.6948825225E-03 + 4.5254833996E+04 6.4000000000E+04 5.2678055180E+04 7.7490167000E-07 1.3387347000E-06 6.0429152671E-03 + 6.4000000000E+04 9.0509667992E+04 7.4244853821E+04 3.4344784000E-07 5.6383303000E-07 5.3021934670E-03 + 9.0509667992E+04 1.2800000000E+05 1.0486138921E+05 1.3603557300E-07 2.2038519000E-07 4.1838877537E-03 + 1.2800000000E+05 1.8101933598E+05 1.4823081666E+05 5.0798431000E-08 8.4349617000E-08 3.1205526772E-03 + 1.8101933598E+05 2.5600000000E+05 2.0967561896E+05 1.8259409000E-08 3.3551186000E-08 2.2448185150E-03 + 2.5600000000E+05 3.6203867197E+05 2.9926199092E+05 7.2012457000E-09 1.5291777000E-08 1.8201116587E-03 + 3.6203867197E+05 5.1200000000E+05 4.2113387898E+05 4.6565228000E-09 8.0905313000E-09 2.3192256074E-03 + 5.1200000000E+05 7.2407734394E+05 5.9790163764E+05 2.3805079000E-09 3.4340085000E-09 2.3991896558E-03 + 7.2407734394E+05 1.0240000000E+06 8.2252441352E+05 8.9791544000E-10 1.0535006000E-09 1.6659906420E-03 + 1.0240000000E+06 1.4481546879E+06 1.1478511749E+06 1.4129681600E-10 1.5558516000E-10 5.0380776112E-04 + 1.4481546879E+06 2.0480000000E+06 1.6154428005E+06 1.3133870100E-11 1.4288344000E-11 9.2305632586E-05 + 2.0480000000E+06 2.8963093757E+06 2.2662619241E+06 1.0753626040E-12 1.1544739000E-12 1.4754719898E-05 + 2.8963093757E+06 4.0960000000E+06 3.2144218987E+06 7.4034102600E-14 7.9111296000E-14 2.0496097862E-06 + 4.0960000000E+06 5.7926187515E+06 4.5379697818E+06 4.8179175700E-15 5.0771934000E-15 2.6537493545E-07 + 5.7926187515E+06 8.1920000000E+06 6.3886724393E+06 2.5927583000E-16 2.5927583000E-16 2.8176992558E-08 + 8.1920000000E+06 1.1585237503E+07 9.7419846861E+06 0.0000000000E+00 0.0000000000E+00 0.0000000000E+00 diff --git a/test/run.in b/test/run.in new file mode 100644 index 00000000..244d79ed --- /dev/null +++ b/test/run.in @@ -0,0 +1 @@ +TEM2 diff --git a/test/runjob b/test/runjob new file mode 100644 index 00000000..156f5524 --- /dev/null +++ b/test/runjob @@ -0,0 +1,15 @@ +#!/bin/sh -l +# FILENAME: runjob + +#SBATCH -A daminton +#SBATCH --nodes=1 +#SBATCH --time=100:00:00 +#SBATCH --job-name test + + +source /etc/profile +module load intel +module load idl +cd $SLURM_SUBMIT_DIR + +idl < start.in diff --git a/test/runjob1 b/test/runjob1 new file mode 100644 index 00000000..36941762 --- /dev/null +++ b/test/runjob1 @@ -0,0 +1,9 @@ +#PBS -q daminton +#PBS -l walltime=720:00:00 +#PBS -l nodes=1:ppn=2,naccesspolicy=shared +#PBS -N SHFRAGv2_hs +source /etc/profile +module load gcc +module load idl +cd $PBS_O_WORKDIR +idl < start.in > output diff --git a/test/runjob2 b/test/runjob2 new file mode 100755 index 00000000..cdf2ed29 --- /dev/null +++ b/test/runjob2 @@ -0,0 +1,9 @@ +#PBS -q daminton +#PBS -l walltime=720:00:00 +#PBS -l nodes=1:ppn=2,naccesspolicy=shared +#PBS -N plotya +source /etc/profile +csh +module load idl +cd $PBS_O_WORKDIR +./Plottingya diff --git a/examples/regolith-transport-run-example/start.in b/test/start.in similarity index 100% rename from examples/regolith-transport-run-example/start.in rename to test/start.in