diff --git a/.circleci/config.yml b/.circleci/config.yml index dcf9b392..d9e8f3ed 100644 --- a/.circleci/config.yml +++ b/.circleci/config.yml @@ -18,7 +18,7 @@ jobs: mepo init mepo clone mepo develop GEOSgcm_GridComp GEOSgcm_App GEOSchem_GridComp - if [ "${CIRCLE_BRANCH}" != "develop" ] && [ "${CIRCLE_BRANCH}" != "master" ] + if [ "${CIRCLE_BRANCH}" != "develop" ] && [ "${CIRCLE_BRANCH}" != "master" ] && [ "${CIRCLE_BRANCH}" != "main" ] then mepo checkout-if-exists ${CIRCLE_BRANCH} fi diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiChemistryMethod_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiChemistryMethod_mod.F90 index bbdf1ea8..d4c7a3fd 100644 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiChemistryMethod_mod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiChemistryMethod_mod.F90 @@ -315,7 +315,7 @@ subroutine readChemistryResourceFile (self, config, loc_proc, & !! 0: no photolysis !! 1: set all qj values to qj_init_val !! 2: read in qj values -!! 3: use fastj routine (for fastJ, fastJx, fastJx53b) +!! 3: use fastj routine (for fastJX65 or CloudJ) !! This option should be combined with fastj_opt. !! 4: lookup table for qj (Kawa style) !! 5: lookup table for qj (Kawa style) + @@ -355,7 +355,7 @@ subroutine readChemistryResourceFile (self, config, loc_proc, & call CheckNamelistOptionRange ('chem_opt', self%chem_opt, 0, 8) call CheckNamelistOptionRange ('h2oclim_opt', self%h2oclim_opt, 1, 3) - call CheckNamelistOptionRange ('phot_opt', self%phot_opt, 0, 7) + call CheckNamelistOptionRange ('phot_opt', self%phot_opt, 0, 3) call CheckNamelistOptionRange ('sad_opt', self%sad_opt, 0, 3) call CheckNamelistOptionRange ('oz_eq_synoz_opt', self%oz_eq_synoz_opt, 0, 1) call CheckNamelistOptionRange ('cloudDroplet_opt', self%cloudDroplet_opt, 1, 4) @@ -517,8 +517,6 @@ subroutine InitializeChemistry (self, gmiGrid, config, loc_proc,& use GmiGrid_mod , only : Get_i1, Get_i2, Get_ju1, Get_j2, Get_k1, Get_k2 use ReadForcedBC_mod, only : readForcedBcData ! -# include "phot_lookup.h" -# include "phot_monthly.h" ! ! !INPUT PARAMETERS: type (t_gmiGrid), intent(in) :: gmiGrid @@ -599,8 +597,6 @@ end subroutine InitializeChemistry subroutine initReadChemistry(self, gmiGrid, loc_proc) ! -# include "phot_lookup.h" -# include "phot_monthly.h" ! ! !INPUT PARAMETERS: type (t_gmiGrid ), intent(in) :: gmiGrid diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiFastJX_includeMod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiFastJX_includeMod.F90 index 6e4c74da..6de2c99e 100644 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiFastJX_includeMod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiFastJX_includeMod.F90 @@ -1,131 +1,15 @@ module GmiFastJX_includeMod - USE GmiFastJX_ParametersMod - private PUBLIC :: t_fastJXbundle - !!fast_JX_cmn_t.h - !PUBLIC :: nslat, nslon -! - !!fast_JX_jv_mie.h - !PUBLIC :: A,B,C1,H,AA,CC,S,W,U1,V1,WT,EMU,PM,PM0,POMEGA - !PUBLIC :: ZTAU,FZ,FJ,DD,RR,ZREFL,ZFLUX,RADIUS,ZU0 - !PUBLIC :: ND,N,M,MFIT -! - !!fast_JX_cmn_w.h - !PUBLIC :: P,T,OD,SA, optaer, optdust -!! - !fast_JX_cmn_h.h - !!PUBLIC :: lpar, jpnl, jppj - !PUBLIC :: xgrd,ygrd,ydgrd,etaa,etab - !PUBLIC :: tau,month,iday - !PUBLIC :: do_model_clima -! - !!fast_JX_jv_cmn.h - !PUBLIC :: ncat_acetone_trop,ncat_acetone_stra - !!PUBLIC :: ncat_met_vinyl_ketone - !PUBLIC :: ncat_met_ethyl_ketone - !PUBLIC :: ncat_methyl_glyoxal - !PUBLIC :: dtaumax,szamax - !PUBLIC :: zj,jfacta,zpdep,npdep,jpdep,jind,jlabel - !PUBLIC :: jadsub,dtausub,dsubdiv - !PUBLIC :: TITLE0,TITLEJ,TITLEA - !PUBLIC :: WBIN, WL, FL, QO2, QO3, Q1D, QQQ, QRAYL, TQQ, FFF - !PUBLIC :: VALJ, WAA, QAA, PAA, RAA, SSA, QBC - !PUBLIC :: TJ, PJ, DM, DO3, DBC, Z, AER, AMF - !PUBLIC :: TREF, OREF, BREF - !PUBLIC :: NJVAL,NW1,NW2,MIEDX,NAA,NLBATM - !PUBLIC :: RAD,RFLECT,SZA,U0,TANHT,ZZHT -! - !PUBLIC :: LPAR_MAX, JPNL_MAX, JPPJ_MAX, IPAR, JPAR, LDEG45 - !!PUBLIC :: NB, NC, NS, NW, NP, NH, MX - !PUBLIC :: M__, N__, NL - -# include "gmi_AerDust_const.h" -# include "setkin_par.h" +# include "parm_MIE_fastJX65.h" TYPE t_fastJXbundle -!---------------------------------------------------------------------------- -! fast_JX_jv_cmn.h -! NB Number of levels in CTM plus one for above model top -! NC Number of levels in the fundamental Fast-J grid -!----------------------------------------------------------------------- - INTEGER NB, NC - integer :: ncat_acetone_trop,ncat_acetone_stra ! Added for GMI to {AOO, 8/04} - integer :: ncat_met_vinyl_ketone ! Added for GMI to {AOO, 8/04} - integer :: ncat_met_ethyl_ketone ! Added for GMI to {AOO, 8/04} - integer :: ncat_methyl_glyoxal ! Added for GMI to {AOO, 8/04} - CHARACTER*20 TITLEA(NP) - CHARACTER*78 TITLE0 - CHARACTER*7 TITLEJ(3,NS), jlabel(jppj_max), hzlab(nh) - INTEGER jind(jppj_max),jadsub(nc_max),nhz,hzind(nh) - INTEGER NJVAL,NW1,NW2,MIEDX(MX),NAA,NLBATM,npdep,jpdep(NS) - REAL*8 dtaumax,szamax,zj(jpnl_max,jppj_max),jfacta(jppj_max) - REAL*8 dtausub,dsubdiv - REAL*8 :: RAD,RFLECT,SZA,U0,TANHT,ZZHT - REAL*8 :: TREF(51,18,12),OREF(51,18,12),BREF(51) - REAL*8 :: TJ(NB_MAX),PJ(NB_MAX+1),DM(NB_MAX),DO3(NB_MAX), & - & DBC(NB_MAX),Z(NB_MAX),AER(MX,NB_MAX), & - & AMF(NB_MAX,NB_MAX) - REAL*8 zpdep(NW,3) - REAL*8 :: WBIN(NW+1),WL(NW),FL(NW),QO2(NW,3),QO3(NW,3), & - Q1D(NW,3),QQQ(NW,2,NS-3),QRAYL(NW+1),TQQ(3,NS), & - FFF(NW,jpnl_max),VALJ(NS),WAA(4,NP),QAA(4,NP), & - PAA(8,4,NP),RAA(4,NP),SSA(4,NP),QBC(NW) - -!---------------------------------------------------------------------------- -!fast_JX_cmn_h.h - - integer lpar - integer jpnl, jppj - real*8 xgrd(ipar) ! Longitude (midpoint, radians) - real*8 ygrd(jpar) ! Latitude (midpoint, radians) - real*8 ydgrd(jpar) ! Latitude (midpoint, degrees) - real*8 etaa(lpar_max+1) ! Eta(a) value for level boundaries - real*8 etab(lpar_max+1) ! Eta(b) value for level boundaries - real*8 tau ! Time of Day (hours, GMT) - integer month ! Number of month (1-12) - integer iday ! Day of year - logical do_model_clima ! determines if climatology data come - ! from the model. - -!---------------------------------------------------------------------------- -! fast_JX_cmn_w.h - - real*8 P(ipar,jpar) ! Surface pressure - real*8 T(ipar,jpar,lpar_max+1) ! Temperature profile -! - real*8 OD(ipar,jpar,lpar_max) ! Optical Depth profile - real*8 SA(ipar,jpar) ! Surface Albedo -! - real*8 optaer(lpar_max,NSADaer*nrh_b) ! Opt. Depth profile for aerosols - real*8 optdust(lpar_max,NSADdust) ! Opt. Depth profile for dust -! -!---------------------------------------------------------------------------- -! fast_JX_jv_mie.h - - REAL*8 :: ZREFL,ZFLUX,RADIUS,ZU0 - INTEGER :: ND,N,M,MFIT - - REAL*8 :: A(M__), B(M__,M__), C1(M__), H(M__), AA(M__,M__) - REAL*8 :: CC(M__,M__), S(M__,M__), W(M__,M__), U1(M__,M__) - REAL*8 :: V1(M__), WT(M__), EMU(M__), PM(M__,2*M__), PM0(2*M__) - REAL*8 :: POMEGA(2*M__,N__), ZTAU(N__), FZ(N__), FJ(N__) - REAL*8 :: DD(M__,M__,N__), RR(M__,N__) - -!---------------------------------------------------------------------------- -!fast_JX_cmn_t.h - - integer nslat ! Latitude of current profile point - integer nslon ! Longitude of current profile point - -!---------------------------------------------------------------------------- -!---------------------------------------------------------------------------- -!solar cycle capability +!... solar cycle capability - REAL*8 :: fjx_solar_cycle_param(NW) + REAL*8 :: fjx_solar_cycle_param(W_) !---------------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiPhotolysisRateConstants_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiPhotolysisRateConstants_mod.F90 index 876fdec6..b2006f99 100755 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiPhotolysisRateConstants_mod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/GmiPhotolysisRateConstants_mod.F90 @@ -8,12 +8,6 @@ module GmiPhotRateConst_mod ! ! !USES: - use fastj , only : Control_Fastj, GetQAA_RAAinFastj - use fast_JX , only : Control_Fast_JX, GetQAA_RAAinFastJX - use fast_JX53b , only : Control_Fast_JX53b - use fast_JX53b , only : GetQAA_RAAinFastJX53b - use fast_JX53c , only : Control_Fast_JX53c - use fast_JX53c , only : GetQAA_RAAinFastJX53c use fastJX65_mod , only : controlFastJX65 use fastJX65_mod , only : getQAA_RAAinFastJX65 use CloudJ_mod , only : controlFastJX74 @@ -94,8 +88,6 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & ! # include "gmi_phys_constants.h" # include "gmi_time_constants.h" -# include "phot_lookup.h" -# include "phot_monthly.h" # include "setkin_par.h" # include "gmi_AerDust_const.h" ! @@ -172,6 +164,7 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & integer :: il, ij, it, ic, n integer :: jday, ich4_num integer :: month_gmi + integer, parameter :: four = 4 real*8 :: time_sec, sza_ij, lat_ij real*8 :: overheadO3col_ij (k1:k2) real*8 :: kel_ij (k1:k2) @@ -207,47 +200,19 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & & (TRIM(chem_mecha) == 'strat_trop') .OR. & & (TRIM(chem_mecha) == 'strat_trop_aerosol')) THEN if (do_AerDust_Calc) then - if (fastj_opt == 0) then - call GetQAA_RAAinFastj (RAA_b, QAA_b) - end if - if (fastj_opt == 1) then - call GetQAA_RAAinFastJX (JXbundle, RAA_b, QAA_b) - end if - if (fastj_opt == 2) then - call GetQAA_RAAinFastJX53b (RAA_b, QAA_b) - end if - if (fastj_opt == 3) then - call GetQAA_RAAinFastJX53c (RAA_b, QAA_b) - end if if (fastj_opt == 4) then - call GetQAA_RAAinFastJX65 (RAA_b, QAA_b) + call GetQAA_RAAinFastJX65 (RAA_b, QAA_b, four, NP_b) end if end if end if end if ! end if - -! ================== - if (phot_opt == 2) then -! ================== - - if (qj_timpyr == MONTHS_PER_YEAR) then - call GmiSplitDateTime (nymd, idumyear, month_gmi, idumday) - it = month_gmi - else - it = 1 - endif - - do ic = 1, num_qjs - qjgmi(ic)%pArray3D(i1:i2,ju1:j2,k1:k2) = & - & qjmon(i1:i2,ju1:j2,k1:k2,ic,it) - end do - +! ! ================== - elseif (phot_opt == 3) then + if (phot_opt == 3) then ! ================== - +! ! -------------------------------------------------------------- ! First form some non-grid dependent arguments needed for Fastj. ! -------------------------------------------------------------- @@ -344,62 +309,7 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & cldOD_ij(:) = tau_cloud(il,ij,:) endif ! - if (fastj_opt == 0) then - -! ================== - call Control_Fastj & -! ================== - & (k1, k2, chem_mask_khi, & - & num_qjs, month_gmi, jday, time_sec, fastj_offset_sec, & - & sza_ij, pres3e(il,ij,k1-1:k2), & - & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, overheadO3col_ij, & - & ODAER_ij, ODMDUST_ij) - - elseif (fastj_opt == 1) then - if (.not. do_ozone_inFastJX) then -! ================== - call Control_Fast_JX & -! ================== - & (JXbundle, k1, k2, chem_mask_khi, & - & num_qjs, month_gmi, jday, time_sec, fastj_offset_sec, & - & sza_ij, pres3e(il,ij,k1:k2), pctm2(il,ij), & - & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, overheadO3col_ij, & - & ODAER_ij, ODMDUST_ij, ozone_ij) - else -! ================== - call Control_Fast_JX & -! ================== - & (JXbundle, k1, k2, chem_mask_khi, & - & num_qjs, month_gmi, jday, time_sec, fastj_offset_sec, & - & sza_ij, pres3e(il,ij,k1:k2), pctm2(il,ij), & - & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, overheadO3col_ij, & - & ODAER_ij, ODMDUST_ij) - endif - elseif (fastj_opt == 2) then -! ================== - call Control_Fast_JX53b & -! ================== - & (k1, k2, chem_mask_khi, & - & num_qjs, month_gmi, jday, time_sec, & - & sza_ij, pres3e(il,ij,k1:k2), pctm2(il,ij), & - & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, overheadO3col_ij, & - & ozone_ij) - elseif (fastj_opt == 3) then -! ================== - call Control_Fast_JX53c & -! ================== - & (k1, k2, chem_mask_khi, num_qjs, month_gmi, jday, time_sec, & - & sza_ij, pres3e(il,ij,k1:k2), pctm2(il,ij), & - & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, overheadO3col_ij, & - & ODAER_ij, ODMDUST_ij, ozone_ij) -!! ================== -! call RunFastJX53c & -!! ================== -! & (k1, k2, jday, time_sec, month_gmi, & -! & sza_ij, pres3e(il,ij,k1:k2), pctm2(il,ij), & -! & kel_ij, cldOD_ij, surf_alb_uv(il,ij), qjgmi_ij, & -! & ozone_ij) - elseif (fastj_opt == 4) then + if (fastj_opt == 4) then if (.not. do_ozone_inFastJX) then call controlFastJX65 (k1, k2, chem_mask_khi, num_qjs, month_gmi, & & jday, time_sec, sza_ij, do_clear_sky, & @@ -418,7 +328,7 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & & JXbundle%fjx_solar_cycle_param) endif ! -!... use CloudJ (aka FastJX7.4 +!... use CloudJ (aka FastJX7.4) elseif (fastj_opt == 5) then cldOD_ij(:) = MAPL_UNDEF eradius_ij(:,:) = 0.0d0 @@ -505,45 +415,6 @@ subroutine calcPhotolysisRateConstants( JXbundle, chem_mecha, tropp, & end do end do -! ============================================== - else if ((phot_opt == 4) .or. (phot_opt == 5)) then -! ============================================== - -! ============== - call Lookup_Qj & -! ============== - & (chem_mecha, do_clear_sky, phot_opt, io3_num, nymd, photintv, & - & rsec_jan1, pres3c, temp3, concentration, solarZenithAngle, & - & mcor, mass3, fracCloudCover, qjgmi, & - & pr_diag, loc_proc, num_species, num_qjs, num_qjo, & - & ilo, ihi, julo, jhi, i1, i2, ju1, j2, k1, k2) - - end if - - if (TRIM(chem_mecha) == 'troposphere') then -! ---------------------------------------------------------------------- -! Check to see if the mechanism has a photolysis reaction O3 + hv = 2OH. -! If so, save the rate in the last entry of qjgmi and then the real rate -! needs to be adjusted. Updated to JPL 06-2 (Bryan Duncan 10/2006). -! ---------------------------------------------------------------------- - - if (n_qj_O3_2OH > 0) then - - n2adj(:,:,:) = 2.15d-11 * Exp (110.0d0 / temp3(i1:i2,ju1:j2,:)) * MXRN2 - o2adj(:,:,:) = 3.30d-11 * Exp ( 55.0d0 / temp3(i1:i2,ju1:j2,:)) * MXRO2 - - if (pr_qj_o3_o1d) then - qjgmi(num_qjs+1)%pArray3D(:,:,:) = & - qjgmi(n_qj_O3_2OH)%pArray3D(:,:,:) - end if - - qjgmi(n_qj_O3_2OH)%pArray3D(:,:,:) = & - qjgmi(n_qj_O3_2OH)%pArray3D(:,:,:) / & - & (1.0d0 + ((n2adj(:,:,:) + o2adj(:,:,:)) / & - & (1.63d-10 * Exp(60.0d0/temp3(i1:i2,ju1:j2,:)) & - & * concentration(ih2o_num)%pArray3D(:,:,:)))) - - end if end if !! ---------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/ioChemistry/ReadSolarCycle_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/ioChemistry/ReadSolarCycle_mod.F90 index 3effc772..11b4612d 100644 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/ioChemistry/ReadSolarCycle_mod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/ioChemistry/ReadSolarCycle_mod.F90 @@ -37,16 +37,16 @@ subroutine readSolarCycleData ( s_cycle_dates,s_cycle, sc_infile_name) ! !USES: ! use GmiASCIIoperations_mod, only : AsciiOpenRead - use GmiFastJX_ParametersMod, only : NW ! implicit none ! -# include "GmiParameters.h" +#include "GmiParameters.h" +#include "parm_MIE_fastJX65.h" ! ! !INPUT PARAMETERS: real, intent(inOut), dimension(2628) :: s_cycle_dates ! 2628 months : 1882 - 2100 character (len=MAX_LENGTH_FILE_NAME), intent(in) :: sc_infile_name - real, intent(inOut), dimension(NW,2628) :: s_cycle ! 2628 months : 1882 - 2100 + real, intent(inOut), dimension(W_,2628) :: s_cycle ! 2628 months : 1882 - 2100 ! !DESCRIPTION: ! This routine sets/reads the solar cycle scaling values. @@ -54,7 +54,7 @@ subroutine readSolarCycleData ( s_cycle_dates,s_cycle, sc_infile_name) ! !LOCAL VARIABLES: integer :: ic, im integer :: lun - integer :: fjx_bin = NW + integer :: fjx_bin = W_ ! !----------------------------------------------------------------------------- !BOC diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/ECT42_grid.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/ECT42_grid.dat deleted file mode 100644 index 798011cc..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/ECT42_grid.dat +++ /dev/null @@ -1,538 +0,0 @@ -EC T42 Longitude (mid_pnt deg.) (XDGRD(J),I=1,IM) IM= 128 - 0.00 2.81 5.62 8.44 11.25 14.06 16.88 19.69 22.50 25.31 28.12 30.94 33.75 36.56 39.38 42.19 - 45.00 47.81 50.62 53.44 56.25 59.06 61.88 64.69 67.50 70.31 73.12 75.94 78.75 81.56 84.38 87.19 - 90.00 92.81 95.62 98.44 101.25 104.06 106.88 109.69 112.50 115.31 118.12 120.94 123.75 126.56 129.38 132.19 - 135.00 137.81 140.62 143.44 146.25 149.06 151.88 154.69 157.50 160.31 163.12 165.94 168.75 171.56 174.38 177.19 - 180.00 -177.19 -174.38 -171.56 -168.75 -165.94 -163.12 -160.31 -157.50 -154.69 -151.88 -149.06 -146.25 -143.44 -140.62 -137.81 - -135.00 -132.19 -129.38 -126.56 -123.75 -120.94 -118.12 -115.31 -112.50 -109.69 -106.88 -104.06 -101.25 -98.44 -95.62 -92.81 - -90.00 -87.19 -84.38 -81.56 -78.75 -75.94 -73.12 -70.31 -67.50 -64.69 -61.88 -59.06 -56.25 -53.44 -50.62 -47.81 - -45.00 -42.19 -39.38 -36.56 -33.75 -30.94 -28.12 -25.31 -22.50 -19.69 -16.88 -14.06 -11.25 -8.44 -5.62 -2.81 -EC T42 Latitude (mid_pnt deg.) (YDGRD(J),J=1,JM) JM= 64 - -87.86 -85.10 -82.31 -79.53 -76.74 -73.95 -71.16 -68.37 -65.58 -62.79 -60.00 -57.21 -54.42 -51.63 -48.84 -46.04 - -43.25 -40.46 -37.67 -34.88 -32.09 -29.30 -26.51 -23.72 -20.93 -18.14 -15.35 -12.56 -9.77 -6.98 -4.19 -1.40 - 1.40 4.19 6.98 9.77 12.56 15.35 18.14 20.93 23.72 26.51 29.30 32.09 34.88 37.67 40.46 43.25 - 46.04 48.84 51.63 54.42 57.21 60.00 62.79 65.58 68.37 71.16 73.95 76.74 79.53 82.31 85.10 87.86 -EC T42 Area in m^2 (AREAXY(1,J),J=1,JM) IM/JM= 128 64 - 3.60 8.30 13.00 18.00 22.00 27.00 31.00 36.00 40.00 44.00 49.00 53.00 56.00 60.00 64.00 67.00 - 71.00 74.00 77.00 80.00 82.00 85.00 87.00 89.00 91.00 92.00 94.00 95.00 96.00 96.00 97.00 97.00 - 97.00 97.00 96.00 96.00 95.00 94.00 92.00 91.00 89.00 87.00 85.00 82.00 80.00 77.00 74.00 71.00 - 67.00 64.00 60.00 56.00 53.00 49.00 44.00 40.00 36.00 31.00 27.00 22.00 18.00 13.00 8.30 3.60 -EC/Olso T42 Y2000-01 annual mean surface pressure ((P(I,J),I=1,IM),J=1,JM) IM/JM= 128 64 - 697.1 695.7 694.3 692.9 691.5 690.1 688.7 687.4 686.0 684.7 683.4 682.1 680.9 679.6 678.5 677.3 - 676.3 675.2 674.2 673.3 672.4 671.6 670.8 670.1 669.4 668.8 668.2 667.7 667.2 666.8 666.3 666.0 - 665.6 665.3 665.1 664.9 664.7 664.6 664.5 664.5 664.6 664.8 665.0 665.3 665.7 666.2 666.9 667.6 - 668.5 669.5 670.6 671.9 673.3 674.8 676.4 678.1 680.0 681.9 683.9 686.0 688.1 690.3 692.5 694.8 - 697.0 699.1 701.3 703.4 705.4 707.3 709.1 710.8 712.4 713.8 715.1 716.2 717.3 718.1 718.9 719.5 - 720.0 720.4 720.7 720.9 721.0 721.0 721.0 721.0 720.9 720.8 720.7 720.6 720.5 720.5 720.4 720.3 - 720.3 720.2 720.2 720.2 720.1 720.0 719.9 719.8 719.6 719.4 719.1 718.7 718.3 717.8 717.3 716.6 - 715.9 715.1 714.3 713.3 712.3 711.3 710.2 709.0 707.8 706.6 705.3 704.0 702.6 701.3 699.9 698.5 - 737.0 732.9 728.8 724.5 720.2 715.7 711.1 706.3 701.5 696.5 691.5 686.6 681.7 677.0 672.6 668.4 - 664.7 661.3 658.4 656.0 654.1 652.7 651.8 651.3 651.3 651.7 652.5 653.6 654.9 656.3 657.9 659.5 - 661.2 662.8 664.3 665.8 667.1 668.3 669.5 670.6 671.7 672.9 674.2 675.7 677.5 679.6 682.3 685.4 - 689.1 693.4 698.3 704.0 710.3 717.2 724.9 733.1 741.9 751.2 760.8 770.8 781.0 791.2 801.4 811.5 - 821.2 830.6 839.4 847.6 854.9 861.4 866.9 871.3 874.6 876.6 877.5 877.1 875.6 872.9 869.2 864.7 - 859.3 853.4 847.0 840.4 833.8 827.3 821.1 815.4 810.2 805.9 802.4 799.7 798.0 797.3 797.4 798.4 - 800.2 802.7 805.6 809.0 812.5 816.1 819.5 822.6 825.2 827.2 828.5 828.9 828.4 827.0 824.8 821.8 - 818.0 813.6 808.6 803.3 797.6 791.9 786.1 780.3 774.7 769.2 764.0 759.0 754.3 749.8 745.4 741.2 - 757.7 752.8 747.8 742.4 736.4 729.7 722.1 713.7 704.5 694.7 684.4 674.0 663.6 653.5 644.0 635.3 - 627.5 620.7 615.0 610.5 607.0 604.6 603.1 602.5 602.6 603.6 605.2 607.5 610.4 613.9 617.9 622.2 - 626.9 631.7 636.5 641.3 645.8 650.1 654.2 657.9 661.5 665.0 668.7 672.7 677.3 682.7 689.0 696.6 - 705.5 715.9 727.9 741.4 756.5 773.1 791.0 810.1 830.0 850.4 871.0 891.5 911.4 930.4 948.1 964.4 - 979.0 991.7 1002.6 1011.5 1018.5 1023.3 1026.1 1026.7 1025.0 1021.1 1014.8 1006.1 995.3 982.4 967.7 951.6 - 934.4 916.6 898.6 881.0 864.2 848.5 834.4 822.2 812.2 804.6 799.6 797.3 797.8 801.1 807.1 815.7 - 826.7 839.8 854.6 870.7 887.4 904.1 920.2 934.9 947.6 957.7 964.8 968.5 968.8 965.6 959.2 949.9 - 938.2 924.7 909.8 894.2 878.4 862.8 847.8 833.7 820.7 808.9 798.4 789.2 781.2 774.2 768.1 762.7 - 732.9 724.6 717.3 710.8 704.6 698.5 691.9 684.8 677.0 668.6 659.8 651.0 642.6 635.1 628.8 624.0 - 621.0 619.6 619.6 620.6 622.1 623.5 624.3 624.1 622.6 619.9 616.5 612.7 609.1 606.5 605.3 605.7 - 608.0 611.9 617.1 623.3 629.8 636.3 642.3 647.7 652.5 656.9 661.1 665.6 670.6 676.6 683.9 692.7 - 703.3 715.8 730.5 747.5 766.8 788.5 812.6 838.8 866.5 895.0 923.4 950.6 975.5 996.9 1014.0 1026.5 - 1034.4 1038.0 1037.9 1035.0 1030.0 1023.5 1015.9 1007.4 997.8 986.9 974.5 960.5 944.7 927.5 909.2 890.3 - 871.5 853.4 836.5 821.3 808.0 796.8 787.7 780.9 776.2 773.7 773.6 775.7 780.4 787.8 797.9 810.9 - 826.6 845.1 865.8 888.4 912.1 936.3 959.9 982.0 1001.6 1017.9 1030.1 1037.6 1040.1 1037.8 1030.9 1019.9 - 1005.6 988.7 970.0 950.2 929.8 909.4 889.1 869.2 849.8 831.2 813.4 796.6 780.9 766.7 753.9 742.6 - 686.4 668.4 654.5 644.5 637.8 633.6 631.1 629.6 628.3 626.8 624.9 622.6 620.6 619.4 619.9 623.1 - 629.8 640.1 654.1 670.9 688.9 705.9 719.3 726.9 727.1 719.7 705.6 687.3 667.4 648.8 633.7 623.5 - 618.9 619.4 624.2 632.0 641.0 649.8 657.2 662.8 666.4 668.6 670.0 671.4 673.5 676.5 680.6 685.8 - 692.0 699.2 707.6 717.6 730.0 745.4 764.8 788.6 816.8 849.0 883.7 918.9 952.0 980.4 1002.0 1015.5 - 1020.8 1019.1 1012.3 1002.8 992.6 983.1 974.9 967.9 961.3 954.1 945.2 933.9 920.1 904.4 887.6 871.0 - 856.1 843.9 835.1 830.0 828.6 830.1 833.7 838.4 843.3 847.6 851.1 853.7 855.8 857.8 860.5 864.3 - 869.6 876.5 885.1 895.0 906.2 918.2 930.8 943.8 956.7 969.3 981.0 991.2 999.3 1004.7 1007.1 1006.6 - 1003.3 997.8 990.4 981.5 971.1 958.9 944.5 927.1 906.3 882.0 854.5 824.6 793.7 763.1 734.3 708.5 - 729.1 706.7 690.3 679.4 673.5 671.7 672.9 676.0 679.6 682.2 682.5 679.7 673.4 664.5 654.6 646.3 - 642.2 644.8 655.9 676.0 704.0 737.0 769.8 796.4 810.7 809.0 791.2 761.1 724.8 688.8 658.3 636.8 - 625.2 623.1 628.6 638.8 650.7 661.5 669.3 673.2 673.7 672.0 669.5 667.6 667.1 668.5 671.6 676.1 - 681.4 687.0 692.6 698.7 705.8 715.4 729.0 748.1 773.6 805.8 843.7 884.8 925.7 962.1 990.5 1008.5 - 1015.9 1014.7 1008.2 1000.3 994.1 991.5 993.0 997.7 1003.4 1007.9 1008.9 1005.1 996.3 983.5 968.5 953.8 - 941.3 932.8 929.2 930.7 936.6 945.5 955.7 965.1 972.0 975.3 974.5 970.2 963.6 956.0 948.6 942.2 - 937.0 932.7 928.5 924.1 919.3 914.4 910.6 909.1 910.9 916.9 926.8 939.8 954.3 968.4 980.3 988.8 - 993.9 996.0 996.5 996.4 996.3 995.8 993.6 987.8 976.5 958.2 932.6 900.7 864.5 826.8 790.3 757.2 - 895.0 883.0 874.0 867.7 864.0 862.7 863.8 866.9 871.1 874.5 874.6 868.1 852.5 827.1 794.0 757.4 - 723.2 697.4 684.4 687.0 706.0 739.3 781.7 824.9 858.8 874.5 867.3 839.4 798.1 753.1 712.9 683.0 - 665.5 659.9 663.6 673.0 684.4 694.4 701.2 704.3 704.3 702.1 698.8 695.2 692.2 690.8 692.0 696.7 - 705.3 717.5 732.5 748.7 765.0 780.9 796.8 814.2 834.6 859.2 887.9 919.2 950.2 977.4 997.2 1007.9 - 1009.9 1005.2 997.7 990.9 987.6 989.3 995.5 1004.7 1014.5 1022.6 1027.2 1027.9 1025.1 1019.9 1013.7 1007.8 - 1003.1 1000.3 999.5 1000.8 1003.7 1007.6 1011.4 1013.9 1014.1 1011.4 1005.8 998.4 990.6 984.2 980.3 979.2 - 980.3 981.6 981.0 976.5 967.5 954.9 941.1 929.3 922.6 923.2 931.4 946.0 964.1 981.8 995.5 1002.8 - 1003.5 999.1 992.7 987.4 985.3 987.2 992.2 998.0 1001.9 1001.4 995.0 982.8 966.1 947.0 927.8 910.0 - 1018.5 1021.8 1023.4 1023.0 1020.6 1016.9 1013.0 1010.4 1010.2 1012.4 1015.5 1016.2 1010.0 993.2 964.3 925.6 - 883.1 844.1 815.5 802.4 806.9 828.5 863.1 903.8 941.0 965.5 970.7 955.6 925.1 887.1 850.3 820.9 - 801.8 792.9 792.0 795.6 801.0 806.5 811.8 817.5 823.6 829.2 832.0 830.1 822.9 812.4 802.7 798.5 - 803.3 818.5 842.4 871.3 900.0 924.4 942.4 954.5 962.8 969.8 977.1 984.8 992.3 998.1 1001.2 1001.2 - 998.4 994.1 989.6 986.5 985.5 986.7 988.9 990.8 991.1 989.4 986.6 984.3 983.9 986.1 990.6 996.2 - 1001.1 1004.2 1004.7 1002.9 999.8 996.3 993.4 991.4 990.1 988.6 986.5 983.7 980.7 978.8 979.4 983.0 - 989.1 996.1 1001.4 1002.4 997.6 987.1 973.4 960.0 950.6 947.9 952.8 964.0 978.4 992.0 1001.0 1003.1 - 998.5 989.2 978.8 970.2 965.8 966.1 970.5 977.0 983.9 989.8 994.3 997.8 1001.1 1004.9 1009.3 1014.1 - 998.9 1001.8 1003.5 1004.8 1005.8 1005.8 1004.0 1000.5 996.4 993.8 994.3 998.3 1004.4 1009.6 1010.7 1005.7 - 995.1 981.3 968.3 959.6 957.4 962.2 972.6 986.1 999.7 1010.4 1016.0 1015.2 1008.5 997.5 984.9 973.5 - 965.0 959.7 956.4 953.3 949.8 946.8 946.5 951.4 962.0 976.0 988.2 992.8 986.8 971.9 954.1 940.9 - 938.0 946.9 964.8 986.0 1004.2 1015.7 1019.9 1019.3 1016.8 1014.2 1011.7 1008.5 1004.2 999.5 995.7 994.1 - 994.8 996.8 999.2 1001.0 1002.3 1002.9 1002.4 999.8 994.5 987.3 980.1 975.6 975.3 979.1 985.3 991.8 - 996.6 999.1 999.4 998.0 995.6 993.1 991.5 991.2 992.4 994.2 995.4 994.9 992.4 988.6 984.8 982.1 - 981.4 982.5 984.6 986.3 986.3 983.8 979.0 973.3 968.6 966.6 968.1 972.3 977.4 981.2 982.4 980.7 - 977.0 972.7 969.2 967.5 967.6 969.1 970.6 971.0 969.8 967.8 966.5 967.8 972.3 979.4 987.3 994.1 - 981.3 980.5 980.2 982.4 987.0 992.6 996.5 996.7 992.9 986.6 980.7 977.5 978.2 982.1 987.6 992.9 - 996.9 999.5 1001.2 1002.2 1002.1 1000.3 996.3 990.6 984.9 981.3 981.3 985.5 992.7 1000.6 1007.3 1011.4 - 1013.2 1013.4 1012.5 1010.1 1005.9 1000.2 994.6 991.7 993.3 999.3 1007.2 1013.3 1014.6 1011.2 1005.8 1002.6 - 1004.1 1009.7 1015.8 1018.2 1014.6 1006.3 997.4 992.0 992.3 996.9 1002.0 1003.7 1000.8 995.1 990.6 990.0 - 993.2 997.5 999.5 998.4 995.5 993.5 993.3 993.6 992.2 988.5 984.3 982.2 983.5 986.6 989.0 989.3 - 988.5 988.9 992.3 998.0 1003.6 1006.9 1007.6 1006.6 1005.4 1004.3 1003.2 1001.3 998.5 995.1 991.4 987.7 - 984.1 981.0 979.2 979.3 981.1 983.7 985.6 986.1 985.4 984.7 984.6 984.6 983.8 981.1 976.9 972.5 - 969.6 968.6 969.2 970.7 972.5 974.3 975.1 973.9 970.2 965.0 960.7 959.9 963.4 969.8 976.3 980.4 - 999.0 1003.4 1007.0 1009.7 1011.7 1013.0 1013.4 1012.5 1010.3 1007.0 1003.6 1000.6 998.4 996.1 992.7 987.7 - 981.6 975.7 971.4 969.8 970.8 973.4 976.0 977.2 976.5 974.3 972.6 973.2 976.6 982.0 986.9 989.4 - 989.3 988.1 987.9 989.5 992.2 993.9 992.7 988.4 982.4 977.0 973.8 973.7 976.2 980.3 985.7 991.9 - 998.3 1003.5 1005.7 1004.3 999.8 994.5 990.9 990.8 994.4 1000.1 1005.1 1006.4 1002.7 996.1 990.6 989.6 - 992.9 996.4 995.6 989.4 981.4 976.7 977.2 980.0 980.3 976.2 970.9 969.1 972.6 978.2 981.2 979.8 - 977.3 979.0 986.8 997.9 1006.8 1010.0 1008.2 1004.6 1001.8 1000.1 998.5 996.7 995.3 995.5 996.9 998.0 - 997.2 994.6 991.4 989.8 990.6 992.8 994.3 993.6 990.9 988.1 987.1 987.9 988.2 986.2 981.6 976.6 - 973.1 971.2 969.2 966.4 963.6 963.2 965.7 969.3 971.2 970.4 968.6 968.7 972.3 978.9 986.5 993.4 - 984.4 996.0 1006.2 1011.4 1010.5 1006.1 1001.4 998.4 997.1 997.0 997.4 998.1 998.7 998.2 996.1 992.1 - 986.9 981.3 976.4 973.0 972.1 974.1 978.6 984.2 988.4 989.4 987.2 984.0 982.7 984.5 988.2 991.2 - 991.7 990.1 988.5 988.7 991.2 994.9 997.8 998.3 995.9 991.8 988.3 987.2 988.6 991.5 994.4 996.3 - 997.2 997.6 998.7 1001.6 1007.0 1013.6 1018.7 1019.4 1015.3 1009.2 1004.5 1002.5 1001.0 997.7 993.0 990.2 - 991.4 995.0 996.4 992.8 986.7 983.8 986.4 990.8 990.3 982.7 973.1 969.4 974.5 983.7 989.6 989.3 - 987.1 989.1 996.4 1004.0 1006.6 1003.6 999.6 999.3 1003.0 1006.8 1007.3 1004.5 1001.3 1000.2 1000.9 1001.0 - 999.0 995.4 992.0 990.4 990.8 992.4 993.8 993.4 990.8 987.3 985.6 986.6 988.2 986.9 982.0 976.2 - 973.0 972.0 970.0 965.1 959.2 956.9 959.9 965.8 969.9 970.4 968.8 967.6 967.6 968.5 970.5 975.4 - 970.0 982.6 995.5 1003.2 1005.3 1004.7 1004.5 1004.8 1004.0 1001.1 997.2 994.0 992.0 990.9 990.1 989.9 - 990.4 991.6 992.8 993.3 992.3 989.7 986.4 983.2 980.6 977.8 974.6 972.4 973.3 978.7 987.0 995.2 - 1001.1 1004.1 1004.5 1002.8 999.4 995.7 993.2 992.7 993.7 995.5 997.9 1001.2 1004.7 1007.4 1008.6 1008.7 - 1008.8 1009.5 1010.4 1011.9 1014.6 1018.4 1020.5 1017.5 1008.8 998.7 993.5 995.8 1001.5 1003.5 998.0 988.6 - 982.2 982.6 986.7 988.6 986.5 984.4 986.8 992.7 996.0 992.6 985.9 983.4 988.4 996.2 1000.0 998.3 - 996.3 998.8 1004.2 1006.8 1003.8 998.9 998.2 1003.6 1010.7 1013.4 1009.9 1004.1 1000.9 1001.4 1002.3 1000.2 - 996.1 993.6 994.1 994.9 992.9 989.1 988.0 991.6 996.7 999.0 998.0 996.4 995.6 993.0 986.8 979.5 - 975.9 976.5 976.8 972.9 966.8 963.5 964.7 967.2 967.6 966.5 967.3 970.4 972.3 969.8 964.8 963.5 - 986.9 997.1 1006.5 1012.4 1015.8 1018.9 1022.3 1023.6 1020.9 1014.9 1009.0 1005.9 1005.0 1004.4 1002.8 1000.4 - 997.5 994.5 992.5 992.8 995.1 996.4 994.2 989.0 983.1 978.3 974.8 973.1 974.3 978.5 983.8 988.2 - 991.8 996.2 1000.9 1003.4 1001.1 995.5 990.0 987.5 987.8 989.5 991.8 994.6 997.6 999.9 1001.7 1004.5 - 1009.9 1016.7 1021.3 1020.7 1015.8 1010.4 1007.5 1006.8 1006.0 1004.2 1002.8 1004.0 1007.0 1007.8 1002.3 991.3 - 981.0 977.7 981.4 986.1 985.9 981.7 979.7 983.4 989.7 992.8 991.4 989.8 991.2 993.6 993.5 991.7 - 993.0 998.5 1003.8 1004.3 1001.2 1000.3 1003.9 1008.4 1008.4 1002.3 994.5 991.4 995.8 1003.9 1008.3 1005.2 - 999.6 999.9 1007.2 1011.5 1002.5 983.5 970.4 974.6 991.5 1005.5 1007.3 1001.8 998.2 997.4 994.7 989.1 - 984.9 984.4 983.9 979.7 973.7 970.9 971.6 971.5 968.6 967.4 972.8 982.7 989.6 988.5 983.2 981.4 - 997.6 1004.0 1008.8 1012.7 1016.0 1017.7 1017.4 1015.1 1011.0 1006.8 1005.0 1006.1 1008.0 1008.7 1008.7 1009.7 - 1010.1 1007.0 1001.1 997.6 1000.0 1005.7 1009.1 1008.2 1005.4 1002.7 999.7 996.1 993.8 994.0 995.0 994.6 - 993.9 995.7 1000.2 1004.0 1004.1 1001.5 999.6 999.9 1001.3 1002.1 1002.6 1003.6 1005.6 1007.6 1008.5 1009.1 - 1011.6 1016.8 1022.2 1024.8 1023.1 1019.1 1016.3 1016.9 1020.2 1021.7 1016.6 1005.9 996.5 994.6 998.3 1000.1 - 995.8 989.5 987.8 991.6 995.1 994.2 991.8 993.1 998.3 1001.9 1000.5 996.8 995.4 996.0 996.0 996.4 - 1000.4 1006.3 1008.2 1004.9 1002.4 1005.0 1009.3 1008.3 1001.9 996.0 995.1 999.1 1005.7 1011.9 1013.7 1008.1 - 999.6 998.1 1007.9 1017.0 1006.5 975.6 948.1 948.3 975.0 1003.4 1011.3 1002.7 995.8 997.3 999.6 996.6 - 992.1 990.5 989.7 985.8 980.8 979.4 981.4 981.7 979.1 978.7 984.3 992.1 994.9 991.8 988.9 991.2 - 1001.3 1002.1 1005.3 1012.9 1019.5 1020.0 1016.4 1013.7 1013.3 1013.1 1012.5 1011.8 1009.3 1004.3 1000.6 1003.5 - 1012.0 1018.5 1018.1 1014.2 1012.6 1013.5 1012.8 1009.7 1007.5 1007.8 1007.5 1004.4 1001.4 1001.9 1005.3 1008.0 - 1009.0 1010.3 1011.5 1010.4 1006.3 1002.3 1000.8 1001.3 1002.3 1003.6 1006.0 1009.5 1013.9 1018.5 1021.7 1022.2 - 1020.5 1018.5 1018.5 1021.4 1026.3 1029.7 1028.0 1022.6 1018.9 1017.7 1012.0 997.2 981.6 978.3 989.6 1002.8 - 1004.1 994.1 984.7 984.4 990.9 996.3 998.4 1000.9 1006.1 1010.1 1008.7 1005.4 1005.7 1008.6 1008.9 1007.1 - 1008.4 1011.5 1010.3 1005.0 1003.9 1009.1 1011.6 1006.2 1000.5 1004.0 1013.3 1017.0 1012.4 1007.8 1009.0 1010.9 - 1006.0 999.1 1002.6 1015.2 1014.5 984.5 944.7 932.5 959.6 999.9 1018.0 1011.0 1002.1 1003.4 1006.2 1002.5 - 996.8 995.7 997.2 996.4 993.2 991.6 992.4 992.9 992.3 993.9 998.5 1001.6 999.3 994.9 994.6 998.4 - 1012.8 1010.5 1014.6 1024.4 1030.5 1027.5 1022.2 1022.0 1024.1 1022.2 1017.5 1015.8 1017.1 1015.9 1010.8 1007.1 - 1009.1 1014.1 1017.0 1016.7 1015.9 1015.2 1012.5 1008.2 1005.9 1007.7 1010.3 1009.9 1007.8 1007.7 1009.9 1011.5 - 1012.0 1013.1 1014.3 1012.7 1008.4 1004.5 1002.0 999.3 997.2 998.8 1003.9 1008.4 1009.9 1010.8 1013.8 1018.5 - 1022.3 1022.7 1018.9 1014.8 1016.5 1023.8 1027.5 1021.9 1014.1 1012.8 1013.6 1005.4 989.4 979.8 984.1 994.4 - 998.3 993.1 986.2 984.4 988.1 992.6 994.9 997.7 1004.0 1010.4 1011.2 1009.0 1010.9 1014.8 1012.5 1005.5 - 1003.7 1008.1 1009.4 1006.0 1006.8 1012.9 1014.0 1006.9 1003.2 1010.0 1018.1 1015.1 1004.4 999.7 1008.0 1020.9 - 1023.1 1011.9 1005.5 1018.2 1031.1 1008.5 955.5 922.3 939.9 986.2 1014.5 1012.5 1005.5 1008.5 1012.0 1008.1 - 1002.4 1001.0 1002.3 1002.7 1001.4 999.8 999.2 999.7 1000.8 1002.8 1006.4 1009.6 1010.2 1010.0 1012.0 1014.3 - 1015.2 1016.6 1020.4 1024.8 1024.6 1019.8 1017.0 1019.4 1020.0 1012.7 1002.2 999.2 1006.4 1016.5 1021.1 1018.2 - 1012.4 1009.2 1010.2 1012.9 1015.2 1018.2 1021.9 1023.5 1022.3 1021.3 1022.0 1022.6 1021.7 1020.5 1019.1 1016.2 - 1012.7 1011.8 1013.7 1015.1 1014.5 1013.7 1013.0 1010.5 1008.2 1010.6 1016.9 1019.9 1015.8 1009.6 1007.1 1009.9 - 1017.2 1024.5 1023.7 1013.1 1005.1 1011.8 1026.5 1032.2 1027.0 1023.2 1024.7 1020.8 1006.6 992.1 986.8 989.6 - 995.4 1001.2 1004.3 1003.6 1002.8 1004.8 1007.1 1008.7 1012.9 1018.8 1019.4 1015.1 1014.8 1018.4 1016.2 1008.9 - 1008.1 1014.9 1017.1 1012.5 1011.4 1015.6 1015.8 1011.5 1011.1 1013.5 1011.0 1006.1 1007.6 1013.7 1017.5 1020.3 - 1022.2 1016.2 1008.1 1017.8 1037.5 1022.0 960.4 912.0 924.9 976.6 1008.3 1005.4 1000.6 1007.7 1012.7 1010.1 - 1008.1 1007.6 1005.0 1003.1 1004.0 1004.5 1004.8 1007.3 1009.6 1008.2 1006.6 1009.0 1012.6 1013.6 1013.4 1014.2 - 1016.0 1020.5 1020.1 1017.5 1016.9 1018.6 1020.6 1021.5 1021.1 1019.4 1015.9 1009.7 1002.4 1000.1 1006.2 1014.2 - 1016.1 1014.6 1016.8 1020.3 1019.5 1018.1 1022.1 1027.6 1027.3 1023.4 1022.2 1023.8 1024.6 1024.4 1025.0 1025.2 - 1023.2 1020.8 1020.3 1019.8 1017.1 1014.4 1014.2 1015.0 1014.3 1014.4 1016.6 1018.2 1017.9 1017.9 1017.5 1014.1 - 1011.7 1015.5 1018.4 1009.1 995.7 998.7 1019.3 1035.4 1033.1 1024.2 1021.9 1021.4 1015.2 1006.5 1001.2 999.4 - 1000.8 1006.1 1010.1 1007.9 1006.1 1012.5 1020.6 1021.9 1021.2 1024.8 1026.4 1021.6 1019.1 1023.0 1023.9 1019.5 - 1019.4 1023.5 1021.5 1015.3 1015.0 1017.7 1015.5 1014.6 1020.7 1021.2 1009.3 1004.9 1020.2 1032.3 1019.7 1004.3 - 1010.8 1022.1 1016.3 1014.6 1031.4 1021.9 957.7 902.8 919.6 980.7 1010.7 1001.4 1000.6 1014.3 1015.5 1008.3 - 1011.0 1015.4 1010.7 1007.4 1011.0 1011.6 1008.5 1011.1 1015.8 1013.1 1008.4 1010.5 1015.0 1013.7 1009.5 1010.2 - 1025.2 1026.0 1021.0 1017.8 1023.4 1029.3 1021.0 1000.7 986.7 992.9 1014.5 1030.0 1022.3 1003.8 999.5 1010.4 - 1017.6 1016.3 1018.5 1024.4 1023.2 1017.0 1016.7 1021.6 1023.1 1021.7 1023.0 1025.9 1025.4 1022.4 1022.3 1025.3 - 1026.4 1023.6 1021.3 1020.4 1017.2 1012.0 1011.2 1014.7 1013.6 1005.5 997.9 997.1 1003.6 1014.4 1021.8 1016.7 - 1003.6 997.9 1001.8 999.8 988.0 985.6 1003.5 1024.0 1026.7 1018.4 1016.6 1021.0 1021.1 1017.4 1015.0 1012.4 - 1008.0 1006.3 1007.2 1005.2 1004.4 1012.2 1021.3 1020.5 1016.4 1020.3 1026.0 1024.0 1021.1 1023.8 1024.6 1020.6 - 1019.7 1020.5 1016.5 1014.4 1020.9 1023.9 1016.0 1012.9 1022.5 1026.1 1014.0 1007.8 1020.2 1027.6 1012.5 1002.1 - 1021.5 1040.8 1024.8 1007.4 1026.0 1028.9 958.7 886.3 901.2 975.4 1009.2 994.6 1000.3 1024.6 1021.4 1005.3 - 1010.6 1019.9 1013.2 1010.1 1018.2 1017.0 1006.3 1006.0 1013.5 1014.2 1012.2 1017.1 1023.0 1022.7 1019.9 1021.0 - 1023.2 1021.0 1017.2 1018.0 1026.8 1025.7 995.5 946.6 905.2 893.1 922.1 978.0 1017.7 1019.1 1011.3 1016.3 - 1019.3 1011.4 1008.6 1017.0 1023.3 1023.3 1024.4 1027.5 1028.7 1029.2 1030.8 1031.9 1030.2 1026.2 1022.8 1022.7 - 1022.8 1019.6 1017.2 1020.2 1022.1 1018.0 1016.6 1021.1 1017.4 998.9 981.8 980.3 989.5 999.3 1005.3 1004.0 - 995.9 991.8 997.3 999.9 989.3 980.5 992.8 1017.3 1028.7 1023.9 1020.7 1024.0 1022.6 1015.9 1013.8 1015.4 - 1013.5 1011.6 1015.5 1019.2 1018.1 1018.5 1021.6 1020.6 1018.4 1022.9 1028.1 1026.0 1023.6 1025.2 1023.7 1019.4 - 1020.6 1023.0 1019.1 1018.1 1025.2 1026.6 1017.6 1013.4 1018.9 1022.7 1020.5 1018.4 1017.7 1016.4 1014.7 1018.7 - 1031.8 1036.0 1012.7 996.9 1029.2 1049.6 966.4 859.2 861.0 958.9 1016.8 994.4 987.6 1013.4 1014.7 1002.1 - 1013.5 1023.1 1008.4 1002.7 1015.9 1017.0 1005.1 1005.5 1014.2 1015.6 1015.4 1019.5 1022.1 1022.5 1024.0 1024.4 - 1016.8 1017.5 1016.0 1017.6 1023.6 1010.3 967.5 917.7 871.8 835.8 843.2 912.7 994.3 1021.0 1010.1 1009.8 - 1017.3 1015.2 1011.9 1015.5 1019.7 1023.3 1027.0 1027.0 1025.3 1026.2 1025.6 1022.6 1024.0 1027.9 1026.7 1024.4 - 1025.5 1023.9 1019.8 1021.4 1024.2 1019.1 1015.5 1020.4 1014.2 985.0 957.7 956.7 971.0 977.8 977.2 981.0 - 990.2 999.9 1007.6 1007.2 993.5 979.6 987.1 1013.5 1031.1 1026.8 1018.7 1019.4 1019.1 1012.5 1010.8 1015.6 - 1015.8 1012.2 1015.5 1021.6 1020.3 1016.5 1018.8 1023.2 1025.4 1027.4 1027.2 1023.5 1023.5 1027.0 1025.1 1021.1 - 1024.5 1028.2 1023.8 1019.6 1020.1 1018.3 1017.6 1022.2 1020.6 1014.7 1022.0 1031.2 1021.2 1013.5 1026.1 1029.8 - 1014.7 1011.0 1012.7 1006.7 1029.5 1055.9 970.3 825.6 801.6 927.8 1040.1 1014.8 968.4 974.8 986.5 992.6 - 1017.5 1029.0 1007.6 998.0 1011.7 1014.5 1008.1 1014.3 1021.4 1018.8 1019.2 1022.2 1019.1 1017.7 1020.4 1019.1 - 1021.7 1024.6 1019.7 1020.6 1024.7 991.9 932.5 902.0 893.0 866.4 857.4 916.1 999.1 1022.7 1001.9 995.9 - 1006.6 1015.7 1022.4 1022.2 1014.1 1013.0 1019.1 1017.8 1014.7 1020.0 1022.3 1016.5 1017.6 1025.2 1024.0 1019.5 - 1023.6 1026.2 1020.0 1017.5 1019.3 1013.6 1009.0 1015.6 1011.3 976.6 939.5 934.0 950.5 957.4 951.2 955.3 - 977.2 999.8 1007.0 1000.0 987.6 980.1 987.9 1009.0 1023.8 1020.3 1012.7 1015.2 1019.9 1017.0 1014.2 1016.5 - 1015.4 1009.3 1008.0 1011.0 1010.4 1009.8 1015.1 1020.2 1020.6 1020.5 1020.4 1018.8 1020.4 1024.2 1022.3 1018.3 - 1019.9 1020.8 1017.1 1017.2 1018.4 1013.2 1015.8 1029.3 1026.2 1010.1 1017.6 1032.9 1018.4 1009.0 1032.0 1029.9 - 996.7 1010.5 1048.9 1023.4 998.4 1037.8 990.2 809.7 730.1 853.6 1030.5 1034.3 957.9 942.0 956.8 971.7 - 1003.5 1024.2 1011.7 1004.9 1014.2 1012.6 1009.2 1019.1 1022.4 1016.3 1020.4 1026.4 1022.7 1021.6 1023.8 1021.1 - 1021.9 1022.8 1012.9 1019.5 1027.0 969.4 883.1 863.1 895.2 899.3 891.4 935.6 1002.4 1023.7 1011.0 997.1 - 982.6 983.5 1009.4 1025.2 1014.4 1010.4 1021.7 1021.9 1015.0 1021.4 1028.1 1021.8 1018.7 1022.9 1018.8 1012.1 - 1016.5 1020.5 1014.6 1013.0 1018.1 1015.5 1010.2 1014.7 1013.5 987.7 956.2 947.1 955.3 954.0 939.9 938.8 - 963.5 991.0 994.5 981.7 978.0 989.7 1005.0 1015.0 1018.2 1016.2 1013.6 1014.9 1017.2 1015.0 1011.5 1011.6 - 1013.2 1013.6 1014.4 1014.6 1013.5 1015.1 1018.7 1017.7 1014.0 1016.0 1020.9 1021.0 1019.3 1019.6 1018.4 1016.5 - 1017.1 1015.5 1012.1 1017.9 1025.8 1019.2 1012.4 1022.7 1026.9 1014.4 1017.5 1030.2 1015.8 1005.6 1030.1 1029.1 - 996.7 1021.3 1063.1 1004.9 959.6 1049.4 1064.0 835.4 679.8 770.8 982.6 1035.0 965.7 945.5 950.8 945.3 - 964.6 997.5 1007.3 1010.8 1017.6 1012.8 1010.5 1019.5 1019.1 1013.1 1019.0 1023.5 1019.7 1021.6 1023.4 1019.1 - 1016.3 1016.3 1006.1 1016.1 1019.0 947.6 860.6 854.4 897.6 902.4 891.0 923.6 975.5 1007.3 1023.0 1006.3 - 957.0 942.2 987.8 1027.1 1018.4 1009.4 1021.9 1024.0 1012.9 1013.5 1019.4 1015.7 1013.4 1018.2 1018.2 1014.9 - 1017.4 1018.4 1013.5 1013.9 1018.9 1017.1 1011.4 1009.5 1005.9 995.8 986.1 981.8 977.6 966.1 950.4 948.1 - 969.0 991.9 989.4 973.0 975.6 1000.7 1020.5 1019.7 1012.8 1012.5 1013.3 1010.0 1007.6 1008.4 1008.9 1008.4 - 1009.8 1013.6 1016.3 1015.3 1013.8 1015.5 1017.3 1015.6 1014.7 1018.3 1021.5 1019.5 1016.4 1016.3 1017.0 1017.0 - 1018.8 1020.1 1016.1 1014.7 1022.2 1023.1 1012.6 1013.0 1023.5 1021.0 1017.0 1025.8 1022.5 1011.1 1022.1 1027.2 - 1006.4 1013.9 1032.0 988.3 977.8 1089.6 1094.3 837.9 666.5 749.1 958.9 1022.4 972.5 964.8 957.3 921.2 - 923.1 965.7 996.5 1009.2 1016.1 1014.2 1014.5 1020.5 1018.7 1016.5 1021.3 1018.7 1013.0 1017.8 1018.9 1012.8 - 1018.0 1020.0 1014.1 1017.0 995.9 920.3 864.1 884.9 919.5 903.1 889.4 918.9 953.2 981.2 1015.8 1011.4 - 959.1 942.4 989.0 1026.7 1015.6 1002.3 1009.6 1013.3 1007.6 1007.3 1010.5 1009.3 1009.1 1013.3 1015.7 1015.4 - 1016.0 1015.3 1013.5 1013.7 1012.5 1008.9 1009.1 1009.7 1004.2 1001.1 1004.4 1001.3 988.5 978.0 973.9 975.4 - 985.2 995.2 990.3 978.8 983.3 1003.5 1015.5 1010.2 1004.6 1008.2 1010.4 1006.1 1005.3 1010.7 1013.8 1011.2 - 1008.0 1007.0 1006.8 1006.7 1008.1 1010.2 1010.7 1012.2 1015.7 1015.7 1011.8 1011.0 1013.5 1015.2 1015.9 1013.8 - 1012.3 1018.0 1020.0 1009.6 1008.2 1020.8 1020.3 1012.4 1020.4 1022.8 1009.4 1013.9 1027.9 1016.8 1008.6 1023.2 - 1021.4 1005.1 1010.0 1021.2 1032.6 1037.5 937.2 754.6 688.0 810.2 979.0 996.5 956.1 964.9 955.2 909.9 - 905.2 949.5 991.4 1011.2 1015.8 1013.0 1014.8 1018.4 1015.9 1017.1 1022.3 1017.9 1014.0 1020.4 1020.1 1013.8 - 1017.3 1017.0 1017.3 1019.9 981.1 898.6 855.8 881.7 903.1 885.0 886.4 917.5 933.8 950.7 994.0 1014.5 - 989.5 977.5 997.9 1012.4 1010.3 1009.2 1010.0 1009.3 1011.0 1013.5 1014.0 1013.6 1012.7 1010.6 1008.6 1008.2 - 1008.8 1009.4 1010.9 1012.2 1008.6 1004.6 1009.4 1016.0 1013.8 1012.3 1015.5 1008.7 993.3 987.8 991.5 992.2 - 992.3 996.4 998.9 998.6 1002.4 1009.2 1009.4 1004.5 1005.3 1010.5 1010.0 1006.6 1008.7 1011.5 1009.8 1008.4 - 1009.4 1009.4 1009.0 1011.0 1014.3 1015.2 1012.3 1011.8 1014.8 1012.3 1007.5 1011.9 1017.2 1014.1 1014.3 1015.6 - 1008.3 1009.5 1021.2 1016.0 1006.0 1018.3 1024.5 1011.4 1015.0 1024.8 1010.0 1007.0 1027.0 1018.7 1000.0 1019.9 - 1030.8 1002.2 1008.1 1053.1 1025.0 893.2 759.7 711.8 783.0 928.7 1004.0 969.1 944.8 962.0 955.8 924.6 - 918.5 945.5 985.7 1016.5 1019.6 1009.9 1012.2 1017.1 1013.0 1012.8 1017.5 1015.9 1015.1 1019.0 1016.9 1013.9 - 1014.8 1005.9 1007.7 1025.0 999.5 916.4 857.6 861.0 876.2 872.4 877.9 892.3 898.2 923.8 979.7 1015.4 - 1011.5 1003.0 999.7 999.0 1010.9 1021.8 1014.3 1006.1 1009.0 1009.3 1006.8 1009.1 1010.4 1007.7 1007.1 1009.2 - 1011.1 1011.2 1010.4 1012.0 1013.9 1011.7 1009.1 1008.1 1005.4 1005.9 1011.2 1010.9 1003.7 1000.0 998.9 996.5 - 1001.0 1013.4 1020.3 1015.6 1010.3 1010.9 1011.2 1008.7 1009.3 1010.8 1006.8 1004.4 1008.1 1007.3 1002.3 1004.9 - 1011.4 1013.1 1013.2 1014.1 1014.2 1015.0 1013.9 1011.3 1012.8 1013.8 1012.4 1016.9 1018.2 1008.5 1009.9 1022.6 - 1016.3 1005.6 1017.1 1023.0 1011.3 1013.6 1019.6 1007.6 1008.9 1025.5 1018.9 1009.5 1021.6 1018.8 1005.0 1018.4 - 1023.0 999.2 1010.4 1034.0 954.2 813.3 757.0 826.5 955.1 1022.7 995.1 959.4 964.6 973.8 963.8 954.6 - 945.8 940.9 967.9 1010.1 1018.9 1008.1 1013.0 1019.6 1014.5 1012.9 1015.2 1013.3 1013.1 1013.4 1010.4 1012.7 - 1020.6 1008.6 1004.8 1026.9 1022.8 956.6 892.0 883.4 901.6 901.2 886.3 874.4 880.2 924.0 987.6 1016.4 - 1010.6 1009.4 1011.4 1008.1 1011.0 1011.4 1001.6 999.9 1005.8 1003.2 1001.0 1006.3 1007.5 1006.1 1009.5 1011.9 - 1011.6 1011.2 1007.9 1006.8 1012.1 1012.9 1005.0 998.4 995.8 995.4 998.7 1004.2 1008.3 1009.5 1006.6 1005.2 - 1013.4 1023.1 1015.2 992.1 979.7 990.7 1006.3 1007.9 1004.3 1004.9 1003.9 1003.7 1008.1 1009.2 1007.7 1011.2 - 1011.9 1007.3 1007.8 1009.0 1005.1 1007.3 1012.7 1010.1 1009.8 1014.6 1012.2 1010.3 1013.5 1008.5 1005.9 1018.1 - 1019.7 1006.9 1009.4 1017.7 1010.6 1008.9 1017.4 1013.8 1009.5 1016.7 1016.2 1009.8 1012.8 1014.7 1014.3 1016.9 - 1008.8 1006.6 1026.8 1001.3 902.1 842.6 895.7 1001.5 1046.8 1011.2 967.8 968.5 988.0 978.9 964.0 972.1 - 965.7 940.6 951.7 992.7 1009.3 1008.1 1015.3 1016.3 1011.0 1014.7 1016.3 1011.9 1014.1 1015.4 1010.9 1015.5 - 1019.6 1015.6 1009.8 1017.1 1010.9 967.9 926.3 925.4 940.0 928.0 898.3 877.9 882.3 926.9 992.1 1019.1 - 1007.4 1008.6 1022.0 1018.8 1006.6 1000.0 1000.3 1008.4 1013.7 1009.6 1010.6 1015.4 1010.0 1005.1 1008.3 1006.0 - 1001.7 1006.4 1009.0 1004.0 1001.7 1000.5 997.5 1001.0 1009.0 1008.7 1000.8 996.0 999.5 1007.6 1012.2 1009.5 - 1001.2 986.6 965.3 947.1 949.7 976.6 1002.6 1005.6 1000.7 1004.9 1009.0 1007.6 1008.1 1009.1 1009.9 1013.0 - 1010.3 1004.7 1009.9 1015.3 1009.9 1010.1 1016.4 1011.7 1008.2 1015.0 1011.8 1004.1 1013.3 1020.2 1009.5 1006.0 - 1014.1 1013.5 1009.9 1012.8 1012.0 1010.2 1016.2 1019.9 1013.8 1008.0 1009.8 1013.9 1011.5 1009.0 1016.6 1014.9 - 999.7 1015.3 1040.0 979.4 889.1 906.2 1005.4 1034.8 988.1 969.9 983.8 992.0 990.8 979.3 970.9 980.9 - 980.5 960.3 961.0 985.6 1001.8 1011.0 1016.9 1009.1 1005.3 1014.8 1014.5 1007.9 1014.2 1018.4 1010.4 1011.2 - 1009.8 1010.8 1012.4 1007.8 987.6 961.0 948.7 955.1 954.5 930.4 900.4 875.0 859.7 888.8 966.3 1019.4 - 1012.3 1002.3 1010.3 1008.9 1004.6 1011.5 1016.4 1013.7 1009.7 1006.6 1009.5 1013.0 1007.5 1004.7 1010.1 1008.0 - 1003.1 1010.5 1016.8 1008.1 998.0 994.9 995.0 1000.0 1008.3 1009.5 1000.0 989.4 989.4 1000.1 1007.8 999.3 - 976.0 951.7 941.5 950.4 971.9 995.6 1009.2 1007.6 1004.4 1009.0 1011.2 1007.3 1006.0 1005.6 1003.6 1006.4 - 1010.0 1009.6 1013.4 1018.0 1013.9 1011.7 1015.7 1012.3 1008.1 1015.6 1017.6 1008.9 1012.0 1021.2 1013.8 1004.9 - 1012.6 1018.8 1013.1 1012.3 1017.4 1014.0 1007.9 1011.2 1014.8 1010.4 1011.9 1020.9 1015.8 1005.2 1013.5 1016.4 - 999.6 1009.9 1026.3 964.3 896.2 940.8 1023.3 997.8 952.9 995.7 1038.5 1008.6 983.2 993.0 997.5 995.6 - 997.1 992.7 990.5 997.5 1005.9 1014.3 1016.4 1008.9 1009.5 1017.1 1012.0 1005.9 1012.6 1014.9 1007.9 1006.8 - 1010.0 1006.9 1017.5 1010.5 980.7 962.7 967.2 975.0 967.6 942.2 907.9 867.4 836.3 860.9 949.3 1019.7 - 1018.5 1003.9 1006.9 1005.3 1007.2 1017.8 1013.0 999.9 1001.2 1006.0 1004.7 1005.8 1007.5 1008.4 1012.4 1013.3 - 1010.3 1011.8 1009.9 998.1 992.8 1002.2 1008.8 999.8 985.5 980.1 982.8 986.7 993.0 1002.0 1003.9 993.8 - 980.6 974.4 981.5 999.7 1014.2 1014.5 1008.4 1005.6 1006.8 1008.0 1005.8 1003.8 1007.5 1010.7 1007.0 1006.1 - 1011.8 1012.1 1006.8 1006.8 1008.8 1007.9 1010.1 1013.2 1010.6 1011.0 1017.2 1015.6 1007.2 1007.3 1013.1 1014.1 - 1013.6 1013.5 1009.8 1009.2 1015.5 1015.1 1006.1 1006.2 1015.2 1014.8 1009.2 1012.7 1012.7 1005.4 1011.3 1019.3 - 1007.8 1006.7 1016.5 974.0 913.9 935.5 1004.2 1008.9 989.9 1019.8 1032.1 991.0 976.0 1000.9 1010.2 1004.1 - 1007.8 1010.9 1009.6 1011.8 1013.8 1012.7 1011.0 1011.3 1015.5 1015.4 1009.5 1010.7 1014.1 1010.0 1011.6 1017.0 - 1011.7 1009.3 1022.9 1007.0 967.8 953.5 962.7 970.0 968.0 949.3 915.1 883.2 869.5 894.2 957.1 1005.5 - 1009.4 1011.4 1024.0 1019.1 1008.5 1008.0 1003.0 1001.3 1015.8 1021.6 1010.8 1008.9 1014.2 1010.0 1004.6 1005.9 - 1007.0 1004.5 995.7 982.1 981.2 1001.4 1019.5 1008.3 979.2 965.8 977.3 994.4 1003.7 1008.1 1006.9 1001.9 - 1004.2 1013.5 1019.1 1019.9 1016.9 1008.1 1001.5 1004.4 1008.2 1006.9 1005.5 1005.8 1007.9 1011.8 1011.4 1007.7 - 1009.8 1011.9 1006.8 1007.4 1015.1 1013.3 1009.1 1015.6 1016.3 1006.4 1009.0 1018.6 1012.4 1005.4 1014.2 1018.7 - 1010.0 1007.8 1013.1 1011.2 1008.1 1012.9 1015.9 1013.2 1013.6 1012.9 1005.2 1004.5 1013.2 1013.5 1009.4 1012.9 - 1010.4 1008.1 1022.6 1006.4 935.2 900.4 952.8 1009.9 995.9 962.9 958.8 969.9 982.6 993.0 998.3 1005.6 - 1012.4 1010.3 1008.9 1014.0 1014.8 1009.3 1007.4 1011.8 1014.1 1008.4 1007.2 1016.9 1016.8 1006.7 1013.2 1022.9 - 1001.8 1007.4 1015.7 984.1 941.1 933.4 944.7 951.6 953.7 940.6 923.5 926.8 927.4 909.8 914.2 949.3 - 977.2 995.4 1015.6 1018.2 1007.0 1007.8 1015.3 1017.4 1017.8 1013.2 1006.1 1008.7 1012.7 1006.6 1001.9 1005.9 - 1009.3 1007.2 1000.5 990.8 987.0 996.9 1010.9 1008.7 988.9 977.9 990.5 1004.7 1003.0 1000.8 1006.4 1009.0 - 1009.6 1012.7 1009.6 1002.3 1001.5 1004.2 1006.2 1009.8 1009.5 1006.2 1009.2 1011.2 1004.4 1002.6 1008.0 1006.7 - 1005.3 1011.5 1013.5 1012.9 1018.1 1016.0 1007.1 1011.5 1018.6 1010.7 1006.6 1016.2 1018.7 1013.4 1014.5 1013.7 - 1007.2 1010.9 1021.0 1016.4 1005.3 1009.4 1018.2 1012.1 1005.5 1011.8 1014.5 1011.4 1017.1 1017.4 1004.8 1004.2 - 1009.1 1002.6 1013.7 1024.5 962.2 884.6 902.6 972.5 964.3 913.5 928.1 985.1 1003.3 991.7 998.3 1015.1 - 1015.6 1007.8 1008.2 1011.5 1010.7 1010.6 1012.3 1013.5 1012.8 1009.3 1010.8 1017.5 1012.3 1000.7 1004.9 1009.8 - 991.1 999.0 998.0 963.7 932.7 934.2 945.1 951.2 952.6 942.3 947.2 972.0 937.4 846.7 822.7 891.1 - 953.3 967.0 986.0 1009.1 1009.7 1011.9 1021.5 1012.1 995.4 997.5 1008.1 1008.3 1003.5 1005.1 1011.2 1014.3 - 1012.7 1007.8 1002.1 1001.7 1006.6 1008.6 1008.1 1008.3 1001.8 994.4 1001.2 1007.2 995.5 989.4 1003.0 1011.0 - 1004.3 1001.2 1002.0 1001.5 1006.2 1011.6 1010.6 1009.7 1008.0 1003.3 1006.6 1012.8 1007.2 1003.3 1011.0 1012.0 - 1006.2 1010.2 1013.2 1006.3 1005.9 1011.7 1009.3 1006.9 1013.5 1016.9 1012.3 1009.9 1012.2 1013.1 1010.8 1009.8 - 1012.5 1014.0 1012.5 1011.4 1010.8 1010.7 1010.9 1006.3 1004.3 1014.2 1018.5 1008.2 1005.0 1008.2 1004.5 1011.9 - 1022.4 1003.5 992.9 1016.6 996.7 923.7 907.9 955.9 964.9 939.9 963.3 1008.4 1010.3 1000.9 1015.0 1021.8 - 1010.4 1009.1 1016.2 1012.7 1008.7 1014.3 1016.4 1011.8 1012.2 1016.0 1015.4 1007.6 991.9 981.4 987.2 992.7 - 983.9 984.7 978.9 961.1 953.2 959.6 961.3 958.0 948.4 935.1 955.6 987.3 924.2 811.2 801.9 897.5 - 959.7 958.6 985.7 1024.5 1018.0 1004.5 1009.7 1005.1 1002.4 1020.8 1024.1 997.9 986.9 1003.9 1012.8 1004.5 - 1002.2 1003.8 996.4 995.1 1007.8 1012.7 1007.6 1011.8 1017.2 1009.5 1003.5 1003.6 996.1 992.9 1005.0 1010.8 - 1004.5 1006.6 1013.8 1013.2 1012.1 1011.1 1004.8 1004.5 1010.4 1007.8 1004.1 1009.9 1012.7 1010.2 1013.5 1014.9 - 1009.4 1010.0 1013.9 1009.0 1006.2 1015.5 1020.3 1012.0 1008.2 1015.9 1018.0 1010.0 1009.1 1014.5 1012.1 1011.8 - 1019.8 1014.7 1001.0 1007.2 1019.6 1012.7 1006.3 1013.6 1016.0 1011.2 1007.1 1001.4 1003.3 1013.5 1015.6 1017.9 - 1023.5 1005.0 983.9 1002.6 1018.0 982.3 955.1 974.4 992.7 992.8 1003.2 1011.9 1006.2 1011.6 1023.2 1014.2 - 1003.2 1012.7 1020.8 1013.7 1010.8 1016.2 1014.2 1008.3 1010.5 1016.1 1013.1 995.5 969.2 956.6 968.0 981.7 - 979.3 973.2 966.5 962.6 970.8 982.3 980.1 963.8 934.4 912.1 937.3 977.7 940.3 869.2 879.8 944.4 - 957.5 951.5 996.0 1033.7 1016.7 1003.8 1013.5 1015.6 1021.7 1029.6 998.8 957.4 968.1 1009.2 1015.5 998.4 - 1004.9 1021.8 1016.2 1002.3 998.8 992.0 982.9 994.3 1015.6 1015.5 1001.5 997.2 1000.1 1003.5 1007.4 1005.5 - 1002.2 1008.5 1013.3 1007.0 1005.0 1009.3 1006.6 1005.6 1014.5 1016.4 1008.2 1008.0 1012.9 1010.0 1007.0 1010.8 - 1012.1 1011.0 1015.7 1020.2 1016.4 1014.1 1018.6 1017.7 1011.0 1013.2 1018.9 1015.7 1015.1 1020.7 1016.4 1010.6 - 1016.9 1016.6 1008.2 1014.9 1020.6 1006.5 1005.5 1022.6 1017.9 1001.1 1007.7 1022.4 1025.8 1025.6 1014.1 991.1 - 981.6 984.5 986.0 998.6 1017.0 1012.8 998.0 1000.2 1011.4 1016.4 1017.0 1015.0 1015.4 1020.5 1017.9 1009.3 - 1011.8 1019.4 1016.2 1011.8 1015.5 1016.8 1013.4 1013.3 1013.8 1012.1 1010.7 999.3 973.8 958.9 968.4 980.7 - 980.0 977.8 969.5 959.0 963.9 980.7 986.4 968.9 935.9 917.8 940.1 970.1 959.3 940.4 953.1 953.3 - 923.3 928.6 977.1 1000.9 1000.1 1017.9 1027.3 1010.2 1005.6 1003.3 967.4 942.2 972.4 1015.4 1020.3 1011.1 - 1016.5 1021.8 1013.3 1001.2 992.5 982.6 975.3 984.4 1005.3 1012.7 1001.9 995.4 1001.5 1007.5 1005.8 1001.2 - 1000.3 1004.3 1005.2 1001.0 1003.6 1014.0 1015.8 1008.8 1009.2 1014.1 1012.1 1010.1 1013.9 1013.3 1008.9 1013.1 - 1018.8 1013.0 1009.5 1017.7 1017.7 1006.2 1007.5 1019.0 1018.5 1013.1 1016.2 1017.2 1014.8 1017.9 1017.0 1009.6 - 1010.4 1016.0 1017.3 1017.4 1012.1 1004.3 1011.9 1019.3 1003.7 1000.1 1027.2 1030.1 994.5 976.5 978.5 963.9 - 952.3 972.7 1000.0 1009.4 1012.4 1015.5 1013.3 1011.1 1013.5 1015.7 1015.6 1018.2 1022.5 1018.9 1010.7 1014.4 - 1025.1 1021.2 1010.4 1013.8 1020.5 1015.7 1014.0 1020.0 1017.7 1011.0 1012.7 1009.9 993.8 983.0 984.4 983.9 - 973.1 977.5 967.7 951.2 950.8 961.6 962.1 948.1 935.9 943.5 964.5 968.9 957.5 962.4 966.8 931.5 - 898.8 923.2 966.1 977.2 992.8 1025.4 1021.6 995.5 1002.9 1015.8 992.8 970.2 972.9 978.9 988.9 1009.3 - 1010.1 983.0 959.6 952.1 957.7 980.0 1005.8 1015.5 1016.2 1016.3 1009.3 1002.3 1005.7 1008.6 1004.5 1003.5 - 1005.4 1004.8 1006.6 1010.3 1009.5 1009.8 1013.7 1011.4 1006.1 1009.6 1014.5 1012.8 1014.4 1019.3 1016.8 1015.3 - 1020.9 1018.0 1008.6 1013.0 1021.1 1015.5 1012.4 1019.9 1017.9 1010.2 1015.2 1020.1 1013.6 1012.8 1020.3 1019.8 - 1014.6 1015.0 1015.0 1010.3 1008.9 1016.4 1022.1 1010.5 1000.3 1021.1 1031.8 968.0 888.9 890.7 953.6 987.2 - 984.8 999.3 1022.1 1021.4 1011.1 1008.8 1007.0 1005.1 1010.1 1015.6 1014.7 1014.4 1017.0 1015.4 1013.8 1020.3 - 1023.7 1015.6 1012.7 1021.5 1022.8 1014.5 1014.1 1018.2 1015.3 1013.3 1013.1 1002.2 988.4 985.8 983.5 974.4 - 964.7 951.7 931.6 927.6 942.3 947.2 934.0 923.9 931.2 952.5 970.2 970.4 971.1 985.8 974.3 922.1 - 900.9 947.7 998.2 1003.0 1004.2 1015.5 1009.0 1008.8 1033.7 1033.6 992.2 958.8 945.6 942.7 968.2 1011.4 - 1021.1 993.7 957.0 914.4 892.6 930.3 996.6 1023.7 1017.2 1014.2 1010.2 1004.9 1010.5 1013.0 1005.2 1005.3 - 1008.7 1001.9 1002.1 1013.7 1010.8 999.6 1006.6 1017.8 1014.2 1013.2 1019.2 1015.1 1010.5 1017.8 1018.4 1009.4 - 1013.2 1022.6 1018.1 1014.0 1021.5 1024.5 1019.8 1016.7 1011.4 1007.9 1017.6 1026.2 1019.5 1015.3 1023.3 1025.6 - 1019.3 1017.2 1016.2 1012.0 1015.1 1023.8 1017.6 1004.0 1016.8 1039.7 992.8 878.6 817.9 875.8 987.6 1037.0 - 1025.9 1022.8 1028.2 1019.7 1010.8 1010.3 1007.4 1005.4 1013.6 1022.5 1021.3 1017.6 1019.1 1022.8 1025.0 1023.1 - 1017.1 1015.3 1022.2 1025.7 1019.7 1017.3 1020.5 1017.4 1014.2 1019.1 1012.4 986.7 971.1 976.4 978.9 971.4 - 984.9 942.3 900.6 903.4 932.1 941.3 937.6 948.1 962.0 964.5 966.5 977.6 994.2 997.9 961.9 909.5 - 910.9 978.8 1033.5 1022.9 997.2 993.1 1000.8 1016.5 1023.6 991.7 947.9 943.3 971.6 996.6 1007.9 1008.2 - 1008.3 1016.0 987.7 896.4 828.5 857.7 937.0 975.9 982.2 994.9 998.6 996.3 1011.5 1020.8 1007.9 1004.3 - 1011.0 1000.2 990.7 1003.3 1009.4 1000.7 1006.6 1019.4 1014.7 1011.7 1022.0 1020.6 1011.4 1018.3 1024.8 1014.1 - 1010.8 1022.2 1022.1 1011.0 1010.1 1014.6 1013.7 1013.5 1015.3 1015.4 1018.0 1021.9 1020.8 1019.4 1020.6 1017.8 - 1014.9 1019.5 1023.2 1019.8 1018.6 1017.2 1006.9 1007.0 1029.0 1016.6 922.5 826.9 834.7 944.5 1042.7 1046.6 - 1018.4 1016.8 1021.7 1015.9 1015.7 1022.3 1022.0 1018.2 1019.1 1020.7 1020.5 1021.6 1023.4 1024.1 1024.2 1021.4 - 1018.3 1022.5 1027.8 1021.6 1014.7 1021.9 1028.6 1020.9 1017.1 1023.2 1013.9 988.4 976.8 983.1 990.7 995.6 - 1005.9 974.0 930.6 924.8 938.5 942.3 957.0 990.6 1002.2 983.6 976.8 988.4 983.0 948.5 909.4 900.8 - 943.4 1005.4 1014.0 968.3 942.4 957.4 970.1 962.2 960.2 976.1 996.6 1010.6 1013.4 990.9 928.5 855.0 - 833.1 868.2 869.3 797.1 759.8 825.1 920.8 953.0 959.5 983.6 991.5 988.4 1011.0 1028.4 1010.8 1002.0 - 1016.4 1011.9 992.7 995.3 1006.2 1004.2 1006.4 1013.7 1008.4 1006.5 1021.2 1026.6 1017.2 1020.2 1030.9 1025.8 - 1016.5 1018.5 1018.8 1012.3 1011.2 1013.1 1011.3 1014.0 1021.9 1021.8 1014.5 1012.8 1018.6 1023.6 1022.4 1018.1 - 1018.4 1023.2 1023.0 1017.5 1015.7 1015.3 1013.2 1018.6 1016.6 960.2 865.9 827.3 894.6 1006.6 1048.5 1020.1 - 1006.0 1020.9 1027.5 1021.6 1022.1 1025.0 1022.8 1020.9 1018.5 1012.6 1011.9 1018.5 1020.1 1015.6 1016.1 1021.0 - 1023.2 1024.4 1024.4 1019.0 1016.6 1023.4 1026.1 1019.3 1018.0 1022.8 1017.7 1004.1 991.0 975.9 970.8 991.4 - 970.6 986.3 980.4 977.9 971.6 962.4 975.8 1001.3 1000.5 987.8 1000.2 1010.6 972.4 916.1 903.0 944.7 - 999.2 1002.0 935.2 869.2 872.1 916.1 913.1 870.1 888.4 994.7 1070.0 996.8 850.8 736.0 656.3 603.9 - 604.2 648.4 665.7 645.0 680.3 813.3 942.6 969.2 967.8 994.0 1001.2 991.4 1011.1 1031.8 1012.6 996.3 - 1011.8 1018.0 1000.3 992.8 996.9 994.9 998.0 1011.2 1015.5 1013.4 1021.5 1028.4 1021.6 1017.0 1022.2 1023.3 - 1018.1 1015.7 1015.9 1017.0 1020.6 1019.6 1011.7 1008.4 1013.2 1015.4 1012.9 1015.1 1020.9 1022.8 1022.4 1025.8 - 1029.6 1025.9 1016.9 1013.0 1017.5 1021.7 1021.7 1015.3 981.6 909.6 848.3 860.1 941.2 1011.4 1018.0 1009.0 - 1024.9 1038.3 1029.1 1021.8 1025.1 1020.0 1010.4 1013.9 1021.1 1017.5 1014.3 1019.7 1021.5 1017.3 1020.0 1027.0 - 1025.4 1019.4 1019.8 1024.0 1024.9 1022.1 1018.1 1016.5 1019.5 1022.3 1022.3 1018.7 996.6 950.0 916.1 930.9 - 925.0 953.4 975.9 990.0 991.0 990.2 1000.7 1006.1 994.7 997.0 1025.4 1032.5 991.5 955.8 969.0 1003.1 - 1000.3 940.1 857.6 814.7 843.7 895.3 876.3 811.8 817.3 906.2 928.9 787.2 617.7 525.5 491.5 484.1 - 506.9 549.0 564.4 563.6 626.1 776.8 913.7 951.0 966.8 1009.7 1025.1 1007.8 1013.0 1029.7 1015.5 993.6 - 995.7 1000.0 991.0 986.6 987.7 983.2 987.2 1008.6 1024.1 1021.2 1019.5 1026.5 1028.0 1021.4 1017.0 1017.5 - 1018.0 1016.0 1012.2 1010.0 1011.0 1010.7 1007.1 1004.8 1005.7 1008.2 1013.8 1020.7 1019.9 1012.3 1012.1 1022.2 - 1026.9 1019.7 1016.0 1023.9 1028.2 1017.2 1000.9 980.6 934.9 869.5 837.7 875.6 950.2 993.3 999.5 1014.8 - 1035.9 1025.8 1001.0 1004.6 1025.8 1025.5 1011.0 1012.4 1022.5 1020.5 1014.3 1016.8 1020.0 1019.0 1021.9 1027.0 - 1024.2 1018.5 1021.4 1028.1 1026.6 1019.1 1016.3 1019.9 1021.4 1017.9 1018.8 1024.5 1010.0 961.9 913.5 902.7 - 939.3 949.4 965.0 977.6 985.8 997.4 1010.3 1010.8 1003.4 1008.2 1015.3 996.2 966.9 967.5 984.3 966.0 - 913.4 871.5 855.2 857.4 881.9 913.0 899.3 836.3 785.0 761.7 715.3 634.2 575.4 562.0 559.6 547.0 - 548.4 569.5 578.1 581.5 636.5 754.4 857.8 898.1 937.9 1005.8 1041.7 1025.8 1012.2 1017.4 1014.0 999.9 - 990.5 982.0 974.1 978.0 986.5 985.7 986.8 1003.7 1020.3 1020.0 1016.0 1022.8 1030.5 1027.9 1020.7 1017.5 - 1016.8 1014.1 1009.0 1004.3 1001.8 1002.9 1007.5 1011.4 1009.7 1006.6 1010.5 1017.4 1015.9 1009.6 1012.5 1020.7 - 1018.4 1012.4 1023.5 1041.1 1027.7 981.9 943.2 920.9 882.1 824.1 799.6 843.7 924.2 977.7 995.6 1010.9 - 1018.1 996.0 971.7 982.6 1013.9 1025.5 1017.0 1013.0 1014.0 1008.6 1004.0 1007.9 1011.9 1010.7 1012.5 1019.6 - 1024.4 1025.1 1025.9 1025.0 1019.4 1015.2 1018.1 1022.0 1017.1 1007.6 1008.5 1021.7 1026.3 1004.6 968.8 943.9 - 974.7 992.1 1005.0 1005.3 999.8 996.5 992.3 985.1 984.8 989.1 971.6 928.2 900.7 909.8 911.3 869.1 - 833.4 863.4 934.6 968.3 954.1 950.7 964.3 936.0 840.5 726.7 652.1 646.2 706.9 779.9 782.5 720.2 - 672.3 665.5 670.0 679.1 724.5 803.4 857.6 869.2 895.5 961.5 1016.9 1021.0 1002.3 995.0 999.3 1004.8 - 1003.2 989.5 975.1 976.9 990.6 998.3 999.8 1007.8 1019.9 1024.7 1023.2 1022.9 1022.7 1019.7 1015.9 1012.7 - 1008.0 1004.0 1004.9 1008.3 1007.8 1004.0 1002.9 1004.1 1002.4 1000.5 1005.2 1012.8 1015.0 1015.8 1022.5 1026.3 - 1018.0 1014.0 1030.5 1039.2 996.0 919.1 867.4 851.9 829.9 785.1 764.8 810.5 900.5 969.7 992.3 998.7 - 1003.6 994.1 975.6 971.8 986.3 1001.9 1009.2 1011.0 1008.6 1004.6 1005.5 1010.9 1012.4 1009.6 1011.5 1019.9 - 1026.6 1027.4 1024.5 1019.8 1014.6 1012.9 1015.1 1014.6 1008.0 1002.5 1006.8 1017.7 1019.9 1004.5 981.2 968.5 - 968.4 1005.8 1025.7 1023.8 1014.0 1001.1 979.3 957.5 955.9 970.0 966.5 936.1 912.1 908.0 889.7 847.3 - 838.5 909.2 1013.4 1043.9 996.2 972.6 1009.7 1029.2 948.8 815.1 730.7 739.3 818.5 893.1 896.5 852.9 - 823.9 818.7 812.2 809.1 837.0 882.8 894.1 865.9 856.0 897.1 958.9 991.9 988.4 977.0 979.8 996.6 - 1010.6 1006.3 990.4 983.4 991.8 1003.3 1009.0 1013.1 1021.0 1029.2 1031.8 1026.7 1017.5 1011.3 1010.6 1009.3 - 1001.9 994.5 996.4 1004.1 1005.7 998.0 989.5 987.0 989.5 996.2 1005.9 1012.1 1010.9 1009.5 1014.9 1019.2 - 1015.9 1016.7 1028.5 1021.3 962.2 877.6 823.3 810.0 801.7 778.5 773.5 822.0 907.2 970.3 986.0 987.9 - 1001.0 1009.4 996.0 974.2 966.9 977.6 993.0 1001.1 1002.1 1003.2 1006.9 1008.9 1007.4 1008.5 1016.2 1023.6 - 1023.0 1018.0 1015.7 1015.8 1013.2 1008.2 1003.9 1000.5 997.8 999.5 1007.1 1011.7 999.2 969.0 941.4 940.0 - 959.0 977.1 975.8 967.5 972.3 984.0 978.9 958.5 952.6 974.7 1001.8 1009.1 1002.1 990.0 962.4 924.4 - 916.9 965.1 1029.5 1039.6 999.2 980.4 1012.3 1043.8 1012.2 932.5 866.6 842.4 844.3 849.3 857.8 883.5 - 917.0 921.8 886.4 852.6 858.9 889.5 894.7 864.0 841.8 862.5 914.3 959.3 975.4 972.4 971.1 981.1 - 995.4 1000.6 994.0 986.7 989.2 999.1 1007.8 1011.7 1014.4 1019.4 1024.2 1023.5 1017.3 1011.5 1009.8 1007.8 - 1000.9 992.7 990.4 993.8 996.2 995.0 993.3 993.4 995.2 999.2 1005.0 1007.4 1003.7 1000.3 1003.7 1009.9 - 1013.0 1017.7 1025.6 1016.6 969.2 899.6 846.5 823.8 814.1 806.1 816.7 863.3 929.1 972.2 979.4 979.1 - 992.2 1005.3 999.1 980.1 968.8 970.8 976.0 977.7 980.5 987.9 994.1 993.2 991.8 1000.2 1015.5 1023.2 - 1017.7 1010.0 1009.7 1011.1 1005.0 994.0 987.6 987.4 987.6 987.6 992.0 998.0 991.7 967.7 942.8 939.6 - 984.9 970.2 937.2 912.4 920.9 953.6 974.8 968.2 958.1 970.8 1001.2 1025.4 1032.4 1028.2 1017.2 1002.8 - 996.6 1006.6 1020.0 1017.7 1003.2 997.5 1005.9 1011.2 1002.1 987.1 973.6 950.8 909.9 867.8 851.9 866.1 - 880.2 860.5 816.0 789.0 803.9 843.5 870.0 868.8 861.9 873.3 904.2 940.2 967.6 980.7 981.2 976.5 - 975.0 978.4 982.7 985.6 990.2 999.6 1011.5 1019.3 1020.1 1017.7 1016.9 1017.1 1014.4 1007.6 999.9 994.4 - 992.0 991.6 991.8 992.0 993.7 998.8 1005.3 1007.2 1001.7 994.2 991.4 993.4 995.9 998.3 1003.3 1009.8 - 1015.3 1020.9 1026.6 1021.5 991.5 940.7 891.3 859.5 845.9 847.7 868.2 908.0 951.8 977.5 980.9 978.6 - 982.9 989.0 988.9 983.6 977.7 970.3 960.1 954.5 962.6 981.2 995.1 996.5 995.7 1004.7 1019.2 1024.8 - 1018.4 1011.4 1009.5 1004.9 991.2 976.9 973.4 978.1 978.7 973.1 973.1 985.2 998.0 997.7 988.5 984.9 - 1004.5 992.8 961.2 932.6 932.0 957.1 979.7 979.3 967.0 965.6 978.4 990.5 992.1 990.4 996.1 1009.0 - 1019.7 1020.7 1013.5 1006.7 1006.8 1010.3 1005.5 988.3 972.3 974.1 991.9 1002.2 984.1 942.2 896.3 856.1 - 818.4 783.4 763.0 770.2 803.3 844.0 872.7 885.2 891.2 899.9 915.6 940.1 970.5 993.9 996.5 980.8 - 965.4 965.5 978.7 992.0 998.7 1003.9 1013.5 1024.5 1029.1 1025.4 1019.8 1017.0 1014.3 1006.6 994.3 984.8 - 984.1 990.2 995.5 994.8 991.7 992.3 997.2 999.7 995.3 987.4 982.5 982.1 983.3 985.4 991.1 1001.8 - 1013.5 1020.2 1016.5 997.6 962.2 918.5 881.8 864.4 869.1 890.5 920.8 951.6 974.9 985.7 986.4 984.3 - 984.4 987.0 990.3 991.5 985.7 970.0 951.2 943.9 956.4 980.7 999.3 1004.7 1005.7 1012.1 1020.4 1021.1 - 1014.0 1007.6 1004.6 998.2 984.8 972.2 968.5 970.1 967.4 960.8 962.2 976.9 994.1 1000.6 999.0 1000.9 - 996.4 1011.1 1007.1 992.2 985.0 991.3 998.8 995.5 985.8 982.5 988.2 992.1 986.0 976.4 976.4 989.7 - 1005.6 1009.9 1000.5 989.3 988.1 995.9 1000.3 991.8 975.9 967.1 973.3 987.8 994.8 981.2 945.2 896.6 - 852.2 827.8 830.1 852.2 877.3 891.2 893.7 894.0 898.1 905.5 916.4 934.4 958.7 977.1 976.7 961.5 - 952.1 964.1 991.8 1014.4 1017.8 1008.4 1001.6 1003.3 1007.8 1009.1 1008.4 1010.3 1013.8 1012.5 1003.6 992.7 - 988.0 991.3 996.5 996.5 991.7 987.8 989.1 994.0 998.2 999.1 996.2 990.1 983.1 980.5 987.7 1003.4 - 1017.0 1014.3 988.0 944.0 897.0 862.5 850.7 863.6 894.6 931.1 960.4 976.6 982.0 982.9 984.4 988.3 - 994.4 1001.8 1008.8 1010.7 1001.2 979.8 956.1 943.5 947.7 962.5 976.8 986.6 995.9 1007.4 1016.0 1015.5 - 1007.7 1000.5 997.7 995.4 989.4 981.1 973.3 965.6 957.1 951.6 955.2 966.0 973.6 971.5 968.0 976.4 - 992.2 1015.2 1024.4 1020.7 1014.4 1011.9 1009.1 1001.2 991.5 988.7 994.9 1002.5 1001.9 993.3 986.8 989.9 - 999.1 1003.0 994.5 979.2 970.3 976.0 992.7 1008.4 1013.4 1008.1 1001.5 1001.4 1007.1 1009.6 999.0 975.0 - 949.1 934.4 934.7 941.0 940.1 927.5 909.9 896.8 890.9 890.0 893.6 903.4 917.6 928.1 928.9 926.4 - 936.1 967.0 1009.6 1040.5 1043.2 1023.8 1001.7 989.6 987.3 989.2 992.8 999.2 1007.5 1012.1 1008.3 998.3 - 989.6 987.6 991.4 995.8 996.9 995.6 995.1 997.6 1002.1 1006.2 1007.5 1006.0 1005.1 1008.9 1018.3 1026.3 - 1020.6 992.6 946.7 899.1 866.9 859.4 875.4 905.4 935.8 956.5 965.3 967.8 971.5 979.9 991.6 1002.9 - 1012.1 1020.2 1027.0 1028.5 1019.4 998.7 973.8 955.2 949.3 955.0 967.7 983.9 1002.0 1018.7 1028.2 1027.0 - 1018.4 1009.2 1003.5 999.8 994.8 987.0 977.4 967.5 959.9 957.2 959.9 963.7 962.6 956.9 955.6 967.9 - 991.7 999.0 999.4 997.2 998.7 1004.4 1007.9 1003.1 991.8 982.5 981.5 987.3 992.8 993.6 992.6 995.4 - 1002.7 1008.3 1004.9 992.4 979.9 978.2 991.5 1013.4 1032.3 1039.8 1037.0 1032.2 1031.5 1033.6 1032.0 1021.9 - 1005.7 990.3 980.3 974.4 967.9 957.5 943.2 926.9 910.6 897.7 892.5 897.6 910.0 921.9 927.9 931.7 - 943.1 967.9 1000.2 1025.2 1031.9 1022.6 1009.1 1000.9 999.1 1000.0 1001.4 1003.8 1007.6 1010.1 1007.5 999.5 - 990.1 984.9 985.9 990.9 995.4 996.1 993.0 988.3 984.8 984.2 987.3 994.0 1003.0 1010.8 1011.5 998.0 - 968.2 928.6 893.2 876.0 883.4 910.8 944.0 966.0 968.8 958.4 948.9 952.2 970.2 995.2 1015.6 1024.8 - 1025.0 1023.8 1025.7 1028.2 1024.6 1011.1 992.1 976.9 973.4 982.9 1000.8 1019.4 1032.3 1036.4 1032.8 1025.4 - 1019.0 1016.0 1014.4 1010.4 1001.6 989.4 977.9 970.7 968.9 971.2 974.3 974.9 972.4 969.6 971.7 980.3 - 985.6 973.0 959.9 954.7 962.6 981.0 1000.1 1010.2 1008.4 1000.3 993.7 992.2 993.8 994.8 994.6 995.7 - 999.8 1005.2 1007.6 1004.6 998.6 995.2 999.0 1008.9 1019.5 1025.6 1026.1 1024.3 1024.2 1026.0 1026.0 1020.4 - 1009.1 996.4 987.7 985.5 988.2 990.7 987.4 976.4 960.9 948.1 945.3 954.5 970.1 981.6 981.0 968.7 - 953.1 943.0 941.7 947.2 955.7 965.2 975.8 986.7 995.6 1000.0 1000.4 999.7 1000.8 1003.7 1005.7 1004.3 - 999.4 993.9 990.5 990.1 991.2 990.7 986.6 978.8 969.2 960.4 954.4 951.5 949.0 942.3 927.3 903.2 - 875.7 854.9 851.5 870.7 909.0 952.7 983.4 989.2 973.7 953.4 945.0 955.9 980.6 1005.7 1018.8 1017.6 - 1010.2 1007.3 1012.9 1022.0 1025.1 1017.2 1002.8 992.7 995.4 1011.3 1031.2 1041.8 1034.3 1011.0 983.8 966.3 - 966.0 981.5 1003.6 1020.2 1023.4 1013.7 997.9 983.8 975.6 973.3 974.5 977.3 981.1 985.9 990.5 991.5 - 997.3 977.3 956.0 942.9 943.7 957.2 976.7 994.1 1004.4 1008.2 1009.3 1010.4 1011.5 1010.7 1007.0 1001.8 - 997.7 996.3 997.6 1000.3 1003.3 1006.7 1010.8 1015.3 1019.0 1021.0 1021.7 1022.2 1023.5 1024.4 1022.2 1014.5 - 1001.6 987.5 977.0 973.6 977.1 984.2 989.9 991.7 990.9 991.6 997.4 1007.4 1015.6 1013.3 995.4 964.2 - 928.8 899.5 883.3 882.1 893.9 913.8 936.1 954.8 965.9 968.9 967.0 965.1 967.5 975.0 985.0 993.6 - 998.0 998.0 995.7 993.6 992.6 991.8 988.6 980.9 968.2 951.6 933.5 915.9 899.5 883.9 868.7 855.5 - 847.8 850.3 866.4 895.2 930.2 960.7 977.2 977.5 968.5 961.0 962.6 973.3 986.4 993.8 992.5 987.2 - 986.7 996.2 1013.3 1028.4 1031.3 1019.5 1001.3 989.8 993.8 1011.6 1030.5 1033.2 1009.7 965.2 917.5 885.6 - 881.0 904.7 947.9 995.3 1030.6 1044.3 1037.1 1017.2 994.7 976.9 968.0 969.1 978.8 992.9 1004.8 1007.4 - 1016.8 1005.7 988.7 972.1 960.9 956.9 958.7 963.6 969.6 976.6 985.1 995.2 1005.4 1013.1 1016.3 1014.7 - 1009.8 1004.4 1000.8 1000.2 1002.8 1008.0 1014.7 1022.0 1028.9 1034.8 1039.5 1042.5 1042.8 1038.8 1028.7 1012.3 - 991.7 970.9 954.7 946.5 947.0 954.7 966.2 978.1 988.2 995.5 999.8 999.8 993.5 979.4 958.3 934.1 - 912.7 899.7 898.3 908.6 927.3 948.8 966.8 976.5 976.4 968.8 958.6 950.9 949.4 954.6 964.6 975.7 - 984.8 990.4 992.9 993.5 993.2 991.4 986.7 977.5 963.5 946.1 928.4 913.5 903.7 899.8 901.2 906.9 - 915.6 926.5 938.5 950.4 960.3 966.9 970.3 972.4 975.6 981.4 988.4 993.5 993.3 987.8 981.0 979.2 - 986.6 1001.9 1018.0 1024.9 1016.8 996.8 976.0 966.9 976.3 1000.3 1024.8 1030.9 1005.6 952.4 888.6 835.5 - 807.9 811.8 844.6 896.9 954.2 1001.1 1027.0 1030.0 1016.5 997.0 980.9 974.4 979.2 992.2 1007.4 1017.2 - 1004.4 1006.1 1004.1 998.9 991.8 983.9 976.3 969.8 965.5 965.0 969.1 978.1 990.4 1003.7 1015.2 1022.5 - 1025.0 1023.2 1019.1 1014.6 1011.5 1010.7 1012.8 1017.4 1023.8 1030.8 1037.1 1040.9 1040.5 1034.7 1023.1 1006.6 - 988.1 970.8 958.4 953.0 955.3 963.8 975.8 987.6 996.4 1000.0 997.8 990.8 980.6 969.4 959.8 954.4 - 955.2 963.1 977.2 995.3 1013.5 1027.8 1034.8 1033.3 1024.5 1011.4 997.9 987.3 981.6 980.9 984.2 989.4 - 994.8 999.1 1001.9 1002.9 1001.9 998.5 991.9 982.3 970.6 958.9 950.2 946.8 950.1 959.8 973.6 988.1 - 999.6 1005.6 1005.2 999.9 992.5 986.4 984.2 986.9 993.8 1001.9 1007.9 1008.9 1004.6 997.6 991.9 990.7 - 994.3 999.5 1000.8 993.7 978.5 961.0 950.3 954.3 975.3 1007.6 1037.2 1045.9 1020.7 962.6 886.4 812.8 - 758.1 731.5 735.0 765.8 816.6 876.8 934.0 977.5 1002.0 1009.1 1004.8 996.9 991.1 990.2 993.8 999.6 - 982.4 983.7 988.4 994.5 1000.3 1003.9 1004.5 1002.2 998.1 994.0 991.5 991.9 995.6 1002.0 1009.7 1017.0 - 1022.5 1025.5 1026.0 1024.8 1022.8 1021.3 1021.0 1022.3 1025.2 1028.9 1032.5 1034.7 1034.4 1031.0 1024.5 1015.9 - 1006.7 998.7 993.7 992.6 995.4 1001.3 1008.5 1015.1 1019.6 1021.0 1019.7 1016.5 1012.9 1010.6 1010.7 1013.7 - 1019.6 1027.5 1036.1 1043.9 1049.4 1051.8 1051.0 1047.6 1042.6 1037.2 1032.5 1029.0 1027.0 1026.0 1025.8 1025.9 - 1026.1 1026.4 1026.7 1026.7 1026.0 1024.0 1020.2 1014.7 1008.4 1002.6 998.9 998.6 1002.1 1008.7 1016.7 1023.8 - 1027.8 1027.5 1023.4 1016.8 1010.2 1005.7 1004.4 1006.3 1010.0 1013.3 1014.4 1012.4 1007.6 1001.7 996.5 992.9 - 990.4 987.4 982.5 975.5 968.3 965.0 969.6 984.6 1008.1 1033.2 1048.6 1041.9 1005.8 942.7 864.5 787.0 - 723.6 682.9 668.5 680.4 716.0 770.4 835.7 901.8 958.6 998.9 1020.0 1024.4 1017.5 1005.7 994.0 985.8 - 990.5 982.4 980.0 982.7 988.8 996.3 1003.2 1008.1 1010.5 1010.3 1008.5 1006.1 1004.2 1003.4 1004.0 1006.0 - 1009.0 1012.6 1016.3 1020.0 1023.5 1027.1 1030.7 1034.4 1038.1 1041.5 1044.2 1045.7 1045.8 1044.3 1041.2 1037.1 - 1032.5 1028.1 1024.7 1022.6 1022.1 1023.0 1025.0 1027.8 1030.9 1034.1 1037.2 1040.3 1043.2 1046.0 1048.4 1050.0 - 1050.5 1049.8 1047.8 1044.8 1041.5 1038.6 1036.8 1036.3 1037.4 1039.7 1042.6 1045.3 1047.1 1047.5 1046.4 1044.4 - 1041.9 1039.8 1038.4 1038.1 1038.7 1039.6 1040.3 1040.3 1039.4 1037.7 1035.5 1033.3 1031.3 1029.7 1028.3 1026.8 - 1025.1 1023.1 1021.0 1019.2 1018.0 1017.7 1018.0 1018.5 1018.4 1017.0 1014.1 1009.7 1004.5 999.3 994.8 991.4 - 989.1 987.7 987.1 987.5 989.4 993.5 999.9 1007.2 1012.4 1010.6 996.8 967.2 921.5 863.7 801.2 742.6 - 695.1 664.1 652.4 660.8 689.0 734.7 793.5 859.1 923.4 978.2 1017.4 1038.4 1042.7 1034.6 1019.8 1003.8 - 1009.4 998.4 990.2 985.8 985.0 987.2 991.3 996.1 1000.8 1004.6 1007.2 1008.6 1009.1 1009.1 1009.1 1009.4 - 1010.2 1011.8 1014.0 1016.9 1020.2 1024.0 1027.9 1031.7 1035.4 1038.7 1041.3 1043.1 1044.0 1044.0 1043.1 1041.4 - 1039.1 1036.6 1034.2 1032.3 1031.0 1030.5 1031.1 1032.8 1035.4 1038.7 1042.6 1046.5 1050.2 1053.2 1055.1 1055.8 - 1055.1 1053.4 1051.0 1048.4 1046.3 1045.0 1044.9 1045.9 1047.8 1050.0 1051.9 1053.0 1052.7 1051.0 1047.9 1044.0 - 1039.8 1036.0 1033.2 1031.7 1031.5 1032.3 1033.8 1035.5 1036.9 1037.7 1037.5 1036.6 1034.9 1032.8 1030.5 1028.3 - 1026.5 1025.2 1024.4 1024.1 1023.9 1023.8 1023.2 1022.0 1019.8 1016.6 1012.5 1008.0 1003.2 998.8 995.0 991.9 - 989.6 987.8 986.3 984.5 981.9 977.6 970.8 960.2 944.6 923.1 895.3 861.8 824.4 785.7 749.1 718.0 - 695.3 683.4 683.6 696.7 722.5 759.7 805.8 857.1 909.0 956.4 994.8 1021.4 1035.4 1038.1 1032.3 1021.6 - 1014.2 1008.9 1004.0 1000.2 998.0 997.7 999.1 1001.8 1005.5 1009.6 1013.8 1017.7 1021.0 1023.6 1025.5 1026.8 - 1027.5 1028.0 1028.1 1028.2 1028.4 1028.6 1029.0 1029.6 1030.4 1031.3 1032.3 1033.4 1034.4 1035.4 1036.3 1037.1 - 1037.7 1038.3 1038.8 1039.3 1040.0 1040.7 1041.7 1042.9 1044.3 1045.8 1047.4 1048.9 1050.2 1051.2 1051.9 1052.3 - 1052.5 1052.4 1052.3 1052.4 1052.6 1053.1 1053.9 1054.7 1055.5 1055.9 1055.8 1055.0 1053.3 1050.9 1047.9 1044.6 - 1041.1 1037.9 1035.1 1033.1 1031.7 1031.1 1031.1 1031.4 1032.0 1032.5 1032.7 1032.7 1032.4 1031.7 1030.8 1029.7 - 1028.5 1027.3 1026.1 1024.8 1023.4 1021.7 1019.8 1017.5 1014.8 1011.7 1008.4 1004.8 1001.0 997.2 993.3 989.2 - 984.9 979.9 974.1 967.0 958.4 947.8 935.0 920.0 902.8 883.7 863.4 842.7 822.7 804.6 789.7 779.1 - 773.8 774.5 781.8 795.5 815.2 840.1 868.6 899.1 929.3 957.3 981.2 999.7 1012.3 1019.0 1020.7 1018.6 - 1018.1 1016.9 1015.6 1014.5 1013.9 1013.9 1014.5 1015.8 1017.7 1020.0 1022.6 1025.4 1028.1 1030.6 1032.9 1034.8 - 1036.3 1037.4 1038.2 1038.7 1039.0 1039.2 1039.3 1039.5 1039.7 1040.1 1040.7 1041.4 1042.3 1043.3 1044.4 1045.6 - 1046.8 1048.0 1049.0 1050.0 1050.8 1051.5 1051.9 1052.2 1052.2 1052.2 1051.9 1051.5 1051.0 1050.5 1050.0 1049.5 - 1049.0 1048.7 1048.5 1048.5 1048.7 1048.9 1049.2 1049.6 1049.9 1050.1 1050.1 1050.0 1049.6 1048.9 1048.1 1047.1 - 1046.0 1044.9 1043.7 1042.6 1041.6 1040.6 1039.7 1038.8 1038.0 1037.1 1036.1 1035.0 1033.8 1032.5 1031.1 1029.5 - 1027.9 1026.2 1024.4 1022.6 1020.9 1019.1 1017.3 1015.6 1013.8 1012.1 1010.3 1008.6 1006.7 1004.8 1002.6 1000.2 - 997.5 994.3 990.5 986.1 981.1 975.4 969.1 962.2 955.1 947.8 940.7 934.2 928.5 924.1 921.2 920.2 - 921.2 924.2 929.4 936.4 945.0 954.8 965.3 975.9 986.1 995.5 1003.4 1009.8 1014.4 1017.3 1018.7 1018.8 - 1025.3 1024.3 1023.4 1022.6 1022.0 1021.5 1021.4 1021.4 1021.6 1022.1 1022.8 1023.7 1024.7 1025.8 1027.1 1028.3 - 1029.6 1030.9 1032.2 1033.5 1034.8 1036.0 1037.2 1038.4 1039.6 1040.7 1041.8 1042.9 1044.0 1045.0 1046.0 1046.8 - 1047.7 1048.4 1049.0 1049.5 1049.9 1050.1 1050.3 1050.3 1050.2 1050.0 1049.7 1049.3 1048.8 1048.4 1047.9 1047.4 - 1047.0 1046.5 1046.2 1045.8 1045.6 1045.3 1045.2 1045.0 1044.9 1044.8 1044.8 1044.6 1044.5 1044.3 1044.1 1043.8 - 1043.4 1043.0 1042.5 1041.9 1041.3 1040.5 1039.7 1038.9 1037.9 1037.0 1035.9 1034.9 1033.8 1032.7 1031.6 1030.5 - 1029.5 1028.5 1027.6 1026.8 1026.0 1025.4 1024.9 1024.6 1024.3 1024.2 1024.1 1024.1 1024.2 1024.4 1024.6 1024.8 - 1025.0 1025.2 1025.2 1025.3 1025.2 1025.1 1024.9 1024.7 1024.4 1024.1 1023.9 1023.7 1023.6 1023.6 1023.8 1024.0 - 1024.5 1025.0 1025.7 1026.4 1027.2 1028.0 1028.6 1029.2 1029.5 1029.7 1029.6 1029.3 1028.8 1028.1 1027.3 1026.3 - 1026.5 1026.1 1025.7 1025.3 1025.0 1024.7 1024.5 1024.3 1024.2 1024.1 1024.1 1024.2 1024.3 1024.4 1024.6 1024.9 - 1025.2 1025.5 1025.8 1026.2 1026.7 1027.1 1027.6 1028.1 1028.6 1029.1 1029.6 1030.0 1030.5 1031.0 1031.5 1031.9 - 1032.3 1032.7 1033.1 1033.4 1033.7 1034.0 1034.2 1034.5 1034.7 1034.8 1035.0 1035.1 1035.2 1035.2 1035.3 1035.3 - 1035.3 1035.3 1035.2 1035.2 1035.1 1035.1 1035.0 1034.9 1034.8 1034.6 1034.5 1034.3 1034.2 1034.0 1033.8 1033.7 - 1033.5 1033.2 1033.0 1032.8 1032.6 1032.4 1032.2 1031.9 1031.7 1031.5 1031.3 1031.1 1030.9 1030.7 1030.6 1030.4 - 1030.3 1030.2 1030.2 1030.2 1030.2 1030.2 1030.2 1030.3 1030.4 1030.6 1030.8 1030.9 1031.1 1031.4 1031.6 1031.8 - 1032.1 1032.3 1032.6 1032.8 1033.0 1033.2 1033.4 1033.5 1033.7 1033.8 1033.8 1033.9 1033.8 1033.8 1033.7 1033.6 - 1033.4 1033.2 1032.9 1032.6 1032.2 1031.9 1031.5 1031.0 1030.5 1030.0 1029.5 1029.0 1028.5 1028.0 1027.5 1027.0 -EC T42 annual mean (T(L),I=1,LM) LM= 40 - 278.69 278.73 278.74 278.66 278.44 278.06 277.53 276.90 276.21 275.41 - 274.51 273.52 272.45 271.24 269.77 267.96 265.84 263.43 260.77 257.97 - 254.91 251.49 247.78 243.77 239.54 235.19 230.87 226.85 223.35 220.48 - 218.12 215.87 213.36 210.72 208.43 207.65 209.18 212.20 216.40 224.93 - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_scat.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_scat.dat deleted file mode 100644 index 809375e5..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_scat.dat +++ /dev/null @@ -1,109 +0,0 @@ -21 (JX_spec.dat) Scattering phase fns, scale extinct @ 999 nm (mjp 5/05) -ATAU 250 1.180 0.010 sub-layers: max#, factor layer:layer, min dtau - w(nm) Q r-eff ss-alb pi(0) pi(1) pi(2) pi(3) pi(4) pi(5) pi(6) pi(7) -01 RAYLE = Rayleigh phase - 300 123.5 0.001 1.0000 1.000 0.0 0.500 0.0 0.0 0.0 0.0 0.0 - 400 39.1 0.001 1.0000 1.000 0.0 0.500 0.0 0.0 0.0 0.0 0.0 - 600 7.7 0.001 1.0000 1.000 0.0 0.500 0.0 0.0 0.0 0.0 0.0 - 999 1.0 0.001 1.0000 1.000 0.0 0.500 0.0 0.0 0.0 0.0 0.0 -02 ISOTR = isotropic - 300 1.0 0.001 1.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 400 1.0 0.001 1.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 600 1.0 0.001 1.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 999 1.0 0.001 1.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 -03 ABSRB = fully absorbing 'soot',(m2/g) from Loiusse et al.JGR,1996 ? 999nm - 300 10.0 0.001 0.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 400 9.0 0.001 0.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 600 6.5 0.001 0.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 - 999 6.5 0.001 0.0000 1.000 0.0 0.0 0.0 0.0 0.0 0.0 0.0 -04 S_Bkg = backgrnd stratospheric sulfate (n=1.46, log-norm: r=.09um/sigma=.6) - 300 2.7541 0.221 1.0000 1.000 2.157 2.767 2.627 2.457 2.098 1.792 1.518 - 400 2.4017 0.221 1.0000 1.000 2.146 2.641 2.422 2.122 1.709 1.357 1.070 - 600 1.6454 0.221 1.0000 1.000 2.076 2.377 2.023 1.608 1.177 0.846 0.599 - 999 0.7449 0.221 1.0000 1.000 1.877 1.920 1.412 0.970 0.614 0.388 0.238 -05 S_Vol = volcanic stratospheric sulfate (n=1.46, log-norm: r=.08um/sigma=.8) - 300 2.6437 0.386 1.0000 1.000 2.152 2.901 2.856 2.971 2.772 2.709 2.587 - 400 2.5603 0.386 1.0000 1.000 2.142 2.810 2.706 2.691 2.421 2.254 2.066 - 600 2.2221 0.386 1.0000 1.000 2.127 2.673 2.488 2.308 1.963 1.698 1.461 - 999 1.5319 0.386 1.0000 1.000 2.076 2.458 2.165 1.841 1.449 1.142 0.898 -06 W_H01 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.1um / alpha=2) - 300 2.8438 0.25 1.0000 1.000 2.454 3.376 3.624 3.608 3.300 2.911 2.526 - 400 2.3497 0.25 1.0000 1.000 2.431 3.235 3.355 3.108 2.686 2.180 1.690 - 600 1.4037 0.25 1.0000 1.000 2.328 2.789 2.593 2.062 1.492 1.013 0.632 - 999 0.5034 0.25 1.0000 1.000 1.916 1.870 1.233 0.704 0.338 0.154 0.062 -07 W_H04 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.4um / alpha=2) - 300 2.2995 1.00 1.0000 1.000 2.433 3.625 4.104 4.645 5.020 5.409 5.802 - 400 2.4743 1.00 1.0000 1.000 2.341 3.475 3.863 4.330 4.589 4.878 5.125 - 600 2.6719 1.00 1.0000 1.000 2.325 3.334 3.624 3.896 3.939 3.968 3.964 - 999 2.9565 1.00 1.0000 1.000 2.434 3.393 3.685 3.709 3.528 3.213 2.903 -08 W_C02 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=2.0um / alpha=6) - 300 2.1410 3.00 1.0000 1.000 2.544 3.886 4.572 5.256 5.933 6.530 7.291 - 400 2.1778 3.00 1.0000 1.000 2.513 3.834 4.480 5.160 5.785 6.356 7.044 - 600 2.2287 3.00 1.0000 1.000 2.483 3.767 4.359 4.998 5.542 6.054 6.639 - 999 2.3071 3.00 1.0000 1.000 2.395 3.597 4.063 4.648 5.052 5.478 5.857 -09 W_C04 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=4.0um / alpha=6) - 300 2.0835 6.00 1.0000 1.000 2.596 3.973 4.725 5.406 6.129 6.751 7.607 - 400 2.1064 6.00 1.0000 1.000 2.571 3.936 4.660 5.345 6.056 6.670 7.492 - 600 2.1345 6.00 1.0000 1.000 2.557 3.902 4.596 5.263 5.923 6.507 7.267 - 999 2.1922 6.00 1.0000 1.000 2.499 3.799 4.418 5.081 5.667 6.213 6.851 -10 W_C08 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=8.0um / alpha=6) - 300 2.0539 12.00 1.0000 1.000 2.619 4.013 4.798 5.476 6.232 6.870 7.780 - 400 2.0643 12.00 1.0000 1.000 2.611 3.999 4.773 5.451 6.194 6.826 7.716 - 600 2.0883 12.00 1.0000 1.000 2.589 3.965 4.712 5.394 6.121 6.744 7.599 - 999 2.1236 12.00 1.0000 1.000 2.563 3.917 4.625 5.302 5.992 6.593 7.385 -11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um / alpha=6) - 300 2.0440 20.00 1.0000 1.000 2.627 4.026 4.822 5.499 6.264 6.907 7.833 - 400 2.0529 20.00 1.0000 1.000 2.620 4.014 4.800 5.477 6.234 6.872 7.783 - 600 2.0716 20.00 1.0000 1.000 2.604 3.990 4.755 5.435 6.178 6.807 7.690 - 999 2.0978 20.00 1.0000 1.000 2.585 3.955 4.691 5.368 6.077 6.688 7.520 -12 W_L06 = water cloud (Lacis) (n=1.335, r-mode=5.5um / alpha=11/3) - 300 2.0616 10.00 1.0000 1.000 2.613 4.002 4.779 5.458 6.205 6.839 7.735 - 400 2.0747 10.00 1.0000 1.000 2.601 3.984 4.745 5.425 6.158 6.785 7.657 - 600 2.1005 10.00 1.0000 1.000 2.580 3.947 4.679 5.359 6.070 6.684 7.514 - 999 2.1423 10.00 1.0000 1.000 2.545 3.884 4.568 5.244 5.909 6.496 7.250 -13 Ice-H = hexagonal ice cloud (Mishchenko) - 300 2.0000 67. 1.0000 1.000 2.435 3.712 4.756 5.960 6.908 7.865 8.954 - 400 2.0000 67. 1.0000 1.000 2.435 3.712 4.756 5.960 6.908 7.865 8.954 - 600 2.0000 67. 1.0000 1.000 2.435 3.712 4.756 5.960 6.908 7.865 8.954 - 999 2.0000 67. 1.0000 1.000 2.435 3.712 4.756 5.960 6.908 7.865 8.954 -14 Ice-I = irregular ice cloud (Mishchenko) - 300 2.0000 50. 1.0000 1.000 2.257 3.164 4.096 5.088 6.018 6.897 7.794 - 400 2.0000 50. 1.0000 1.000 2.257 3.164 4.096 5.088 6.018 6.897 7.794 - 600 2.0000 50. 1.0000 1.000 2.257 3.164 4.096 5.088 6.018 6.897 7.794 - 999 2.0000 50. 1.0000 1.000 2.257 3.164 4.096 5.088 6.018 6.897 7.794 -15 Mdust 0.15 = mineral dust (R.V.Martin) - 300 3.0039 0.150 0.884 1.000 2.030 2.363 2.082 1.710 1.290 0.941 0.638 - 400 2.4763 0.150 0.937 1.000 1.988 2.151 1.735 1.248 0.809 0.503 0.279 - 600 1.2768 0.150 0.979 1.000 1.816 1.675 1.075 0.604 0.281 0.132 0.049 - 999 0.3595 0.150 0.958 1.000 1.320 0.994 0.377 0.126 0.031 0.008 0.001 -16 Mdust 0.25 = mineral dust (R.V.Martin) - 300 2.9406 0.250 0.820 1.000 2.046 2.643 2.593 2.634 2.406 2.244 1.944 - 400 3.1046 0.250 0.913 1.000 2.021 2.486 2.264 2.047 1.671 1.362 1.039 - 600 2.6144 0.250 0.980 1.000 2.026 2.296 1.926 1.470 1.013 0.668 0.403 - 999 1.2426 0.250 0.974 1.000 1.824 1.689 1.087 0.611 0.286 0.134 0.050 -17 Mdust 0.4 = mineral dust (R.V.Martin) - 300 2.6069 0.400 0.739 1.000 2.192 3.070 3.393 3.903 4.021 4.248 4.168 - 400 2.8244 0.400 0.860 1.000 2.027 2.711 2.679 2.900 2.734 2.723 2.478 - 600 3.1156 0.400 0.971 1.000 2.017 2.537 2.306 2.136 1.761 1.466 1.151 - 999 2.4773 0.400 0.975 1.000 2.036 2.286 1.903 1.428 0.966 0.623 0.368 -18 Mdust 0.8 = mineral dust (R.V.Martin) - 300 2.3457 0.800 0.640 1.000 2.517 3.780 4.729 5.755 6.524 7.339 7.903 - 400 2.4344 0.800 0.763 1.000 2.295 3.320 3.800 4.578 4.913 5.482 5.662 - 600 2.6416 0.800 0.936 1.000 2.023 2.830 2.805 3.279 3.178 3.418 3.275 - 999 3.0396 0.800 0.957 1.000 2.019 2.618 2.441 2.414 2.106 1.895 1.610 -19 Mdust 1.5 = mineral dust (R.V.Martin) - 300 2.2228 1.500 0.579 1.000 2.705 4.250 5.641 7.023 8.293 9.53910.662 - 400 2.2732 1.500 0.676 1.000 2.539 3.821 4.771 5.881 6.738 7.733 8.463 - 600 2.3707 1.500 0.890 1.000 2.240 3.259 3.544 4.375 4.592 5.292 5.471 - 999 2.5751 1.500 0.913 1.000 2.083 2.944 3.008 3.555 3.538 3.852 3.789 -20 Mdust 2.5 = mineral dust (R.V.Martin) - 300 2.1579 2.500 0.556 1.000 2.780 4.476 6.085 7.664 9.18610.67312.096 - 400 2.1923 2.500 0.616 1.000 2.678 4.164 5.458 6.813 8.046 9.32510.461 - 600 2.2560 2.500 0.842 1.000 2.391 3.526 4.044 5.035 5.527 6.483 6.961 - 999 2.3716 2.500 0.869 1.000 2.268 3.300 3.634 4.458 4.720 5.401 5.624 -21 Mdust 4.0 = mineral dust (R.V.Martin) - 300 2.1154 4.000 0.550 1.000 2.809 4.574 6.281 7.960 9.60711.22412.806 - 400 2.1402 4.000 0.577 1.000 2.761 4.405 5.941 7.485 8.97410.46211.878 - 600 2.1852 4.000 0.786 1.000 2.505 3.744 4.488 5.599 6.354 7.485 8.238 - 999 2.2637 4.000 0.819 1.000 2.413 3.563 4.133 5.118 5.652 6.582 7.097 - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_spec.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_spec.dat deleted file mode 100644 index 613f109c..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_spec.dat +++ /dev/null @@ -1,404 +0,0 @@ -(fort10_06b) UCI J-v8.4 (4/06) JPL02+irHNO4+IUPAC/NO2/VOC+Blitz +flux2006 -NW-JValues 62 64 18 1 18 NJVAL,NQQQ, NWWW, NW1:NW2=01:18 or 12:18 -w-eff (nm) 187. 191. 193. 196. 202. 208. - 211. 214. 261. 267. 277. 295. - 303. 310. 316. 333. 380. 574. -SOL#/cm2/s 1.391E+12 1.627E+12 1.664E+12 9.278E+11 7.842E+12 4.680E+12 - 9.918E+12 1.219E+13 6.364E+14 4.049E+14 3.150E+14 5.889E+14 - 7.678E+14 5.045E+14 8.902E+14 3.853E+15 1.547E+16 2.131E+17 -Raylay cm2 5.073E-25 4.479E-25 4.196E-25 3.906E-25 3.355E-25 2.929E-25 - 2.736E-25 2.581E-25 1.049E-25 9.492E-26 8.103E-26 6.131E-26 - 5.422E-26 4.923E-26 4.514E-26 3.643E-26 2.087E-26 3.848E-27 -O2 180 1.727E-21 1.989E-22 3.004E-23 9.833E-24 7.306E-24 6.835E-24 - 6.243E-24 5.804E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O2 260 2.273E-21 3.070E-22 4.943E-23 1.408E-23 7.688E-24 6.835E-24 - 6.243E-24 5.886E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O2 300 2.763E-21 4.269E-22 7.478E-23 2.100E-23 8.350E-24 6.835E-24 - 6.243E-24 5.992E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O3 180 5.849E-19 4.708E-19 4.154E-19 3.549E-19 3.230E-19 4.555E-19 - 6.287E-19 9.126E-19 8.846E-18 3.467E-18 1.495E-18 7.561E-19 - 2.367E-19 8.756E-20 3.690E-20 4.256E-21 1.806E-23 1.625E-21 -O3 260 5.916E-19 4.794E-19 4.246E-19 3.651E-19 3.332E-19 4.610E-19 - 6.325E-19 8.750E-19 8.857E-18 3.565E-18 1.555E-18 8.016E-19 - 2.572E-19 9.710E-20 4.136E-20 5.409E-21 2.784E-23 1.625E-21 -O3 300 5.884E-19 4.736E-19 4.183E-19 3.557E-19 3.302E-19 4.688E-19 - 6.372E-19 8.993E-19 8.863E-18 3.597E-18 1.597E-18 8.391E-19 - 2.778E-19 1.079E-19 4.720E-20 6.725E-21 4.845E-23 1.625E-21 -O3(1D) 180 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.926E-01 4.516E-01 8.621E-02 7.740E-02 0.000E+00 0.000E+00 -O3(1D) 260 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.934E-01 5.091E-01 1.472E-01 8.632E-02 0.000E+00 0.000E+00 -O3(1D) 300 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.954E-01 5.723E-01 2.362E-01 9.937E-02 0.000E+00 0.000E+00 -NO 300 1.009E-18 1.156E-18 5.791E-19 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.482E-20 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -NO 300 1.009E-18 1.156E-18 5.791E-19 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.482E-20 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H2COa 223 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.945E-20 1.289E-20 1.969E-20 4.324E-21 5.105E-26 0.000E+00 -H2COa 293 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.850E-20 1.317E-20 1.895E-20 3.922E-21 4.467E-26 0.000E+00 -H2COb 223 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 6.397E-21 4.443E-21 9.027E-21 1.040E-20 1.960E-22 0.000E+00 -H2COb 293 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 6.086E-21 4.543E-21 8.717E-21 9.424E-21 1.903E-22 0.000E+00 -H2O2 200 2.120E-19 4.214E-19 4.925E-19 5.431E-19 4.449E-19 3.760E-19 - 3.459E-19 3.196E-19 5.333E-20 4.860E-20 3.421E-20 8.360E-21 - 5.008E-21 3.220E-21 2.115E-21 7.984E-22 2.101E-23 0.000E+00 -H2O2 300 2.046E-19 4.066E-19 4.752E-19 5.241E-19 4.293E-19 3.628E-19 - 3.338E-19 3.083E-19 5.466E-20 4.902E-20 3.437E-20 9.300E-21 - 5.735E-21 3.803E-21 2.583E-21 1.046E-21 2.715E-23 0.000E+00 -CH3OOH 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.746E-19 2.438E-19 2.745E-20 2.778E-20 2.214E-20 5.621E-21 - 3.573E-21 2.441E-21 1.755E-21 7.405E-22 4.261E-23 0.000E+00 -CH3OOH 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.746E-19 2.438E-19 2.745E-20 2.778E-20 2.214E-20 5.621E-21 - 3.573E-21 2.441E-21 1.755E-21 7.405E-22 4.261E-23 0.000E+00 -NO2 220 0.000E+00 0.000E+00 5.112E-21 0.000E+00 1.845E-19 3.942E-19 - 4.317E-19 4.464E-19 3.127E-20 1.011E-19 1.155E-19 1.053E-19 - 1.476E-19 1.878E-19 2.280E-19 3.257E-19 4.420E-19 1.968E-22 -NO2 298 0.000E+00 0.000E+00 5.040E-21 0.000E+00 1.828E-19 4.053E-19 - 4.544E-19 4.748E-19 3.376E-20 1.042E-19 1.171E-19 1.052E-19 - 1.493E-19 1.885E-19 2.281E-19 3.455E-19 4.612E-19 3.691E-22 -NO3 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.266E-19 -NO3 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.266E-19 -N2O5 225 0.000E+00 0.000E+00 7.943E-19 6.872E-19 7.111E-18 6.566E-18 - 5.183E-18 3.985E-18 2.695E-19 2.794E-19 2.822E-19 3.823E-20 - 1.998E-20 1.170E-20 7.246E-21 2.286E-21 1.173E-22 0.000E+00 -N2O5 300 0.000E+00 0.000E+00 7.943E-19 6.872E-19 7.111E-18 6.566E-18 - 5.183E-18 3.985E-18 2.695E-19 2.843E-19 2.968E-19 5.404E-20 - 3.317E-20 2.226E-20 1.551E-20 6.389E-21 5.481E-22 0.000E+00 -HNO2 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.175E-20 3.470E-20 1.093E-19 8.764E-20 0.000E+00 -HNO2 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.175E-20 3.470E-20 1.093E-19 8.764E-20 0.000E+00 -HNO3 200 7.671E-18 1.061E-17 1.043E-17 8.241E-18 3.790E-18 1.301E-18 - 6.914E-19 5.036E-19 1.629E-20 1.796E-20 1.854E-20 3.396E-21 - 1.377E-21 5.474E-22 2.100E-22 2.131E-23 8.822E-26 0.000E+00 -HNO3 300 7.781E-18 1.091E-17 1.090E-17 9.123E-18 4.474E-18 1.565E-18 - 8.458E-19 5.886E-19 1.875E-20 2.165E-20 2.305E-20 4.384E-21 - 1.923E-21 8.345E-22 3.586E-22 4.720E-23 2.683E-25 0.000E+00 -HNO4 297 3.105E-18 6.120E-18 6.954E-18 7.486E-18 4.751E-18 2.866E-18 - 2.220E-18 1.840E-18 2.806E-19 2.208E-19 1.538E-19 2.601E-20 - 1.103E-20 5.239E-21 2.793E-21 2.250E-22 0.000E+00 4.792E-23 -HNO4 298 3.105E-18 6.120E-18 6.954E-18 7.486E-18 4.751E-18 2.866E-18 - 2.220E-18 1.840E-18 2.806E-19 2.208E-19 1.538E-19 2.601E-20 - 1.103E-20 5.239E-21 2.793E-21 2.250E-22 0.000E+00 4.792E-23 -ClNO3a 210 1.194E-19 3.411E-19 6.382E-19 1.137E-18 1.621E-18 1.789E-18 - 1.936E-18 2.025E-18 2.000E-19 2.847E-19 2.070E-19 2.113E-20 - 1.125E-20 6.895E-21 4.722E-21 2.354E-21 9.486E-22 6.713E-24 -ClNO3a 296 1.282E-19 3.661E-19 6.817E-19 1.217E-18 1.691E-18 1.808E-18 - 1.933E-18 2.009E-18 2.313E-19 3.034E-19 2.143E-19 2.760E-20 - 1.542E-20 9.855E-21 6.949E-21 3.329E-21 1.168E-21 9.354E-24 -ClNO3b 210 7.960E-20 2.274E-19 4.255E-19 7.580E-19 1.080E-18 1.192E-18 - 1.291E-18 1.350E-18 1.333E-19 1.898E-19 1.380E-19 1.408E-20 - 7.500E-21 4.347E-21 2.460E-21 7.192E-22 2.663E-23 0.000E+00 -ClNO3b 296 8.550E-20 2.441E-19 4.544E-19 8.114E-19 1.127E-18 1.205E-18 - 1.289E-18 1.339E-18 1.542E-19 2.023E-19 1.429E-19 1.840E-20 - 1.028E-20 6.210E-21 3.618E-21 1.031E-21 3.292E-23 0.000E+00 -Cl2 200 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.777E-21 2.162E-20 4.789E-20 8.147E-20 - 1.387E-19 1.880E-19 2.284E-19 2.549E-19 6.256E-20 6.399E-22 -Cl2 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 5.189E-21 2.557E-20 5.321E-20 8.674E-20 - 1.403E-19 1.849E-19 2.205E-19 2.436E-19 6.516E-20 6.748E-22 -HOCl 297 0.000E+00 0.000E+00 6.024E-21 5.363E-21 5.123E-20 5.423E-20 - 5.793E-20 6.702E-20 1.021E-19 6.538E-20 5.427E-20 5.567E-20 - 6.067E-20 5.957E-20 5.378E-20 3.123E-20 6.548E-21 1.195E-23 -HOCl 298 0.000E+00 0.000E+00 6.024E-21 5.363E-21 5.123E-20 5.423E-20 - 5.793E-20 6.702E-20 1.021E-19 6.538E-20 5.427E-20 5.567E-20 - 6.067E-20 5.957E-20 5.378E-20 3.123E-20 6.548E-21 1.195E-23 -OClO 204 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.590E-19 4.774E-19 7.317E-19 1.163E-18 - 1.806E-18 2.524E-18 3.061E-18 4.703E-18 3.328E-18 3.958E-20 -OClO 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.590E-19 4.774E-19 7.317E-19 1.163E-18 - 1.806E-18 2.524E-18 3.061E-18 4.703E-18 3.328E-18 3.958E-20 -Cl2O2 229 1.769E-18 3.509E-18 4.077E-18 4.468E-18 3.491E-18 2.731E-18 - 2.406E-18 2.210E-18 3.736E-18 1.901E-18 1.277E-18 9.342E-19 - 6.254E-19 4.338E-19 3.062E-19 1.569E-19 2.717E-20 1.598E-22 -Cl2O2 230 1.769E-18 3.509E-18 4.077E-18 4.468E-18 3.491E-18 2.731E-18 - 2.406E-18 2.210E-18 3.736E-18 1.901E-18 1.277E-18 9.342E-19 - 6.254E-19 4.338E-19 3.062E-19 1.569E-19 2.717E-20 1.598E-22 -ClO 297 0.000E+00 0.000E+00 1.700E-20 1.348E-20 1.942E-19 3.038E-19 - 3.488E-19 3.899E-19 4.613E-18 3.043E-18 1.697E-18 1.304E-18 - 4.511E-19 1.512E-19 5.199E-20 2.434E-21 0.000E+00 0.000E+00 -ClO 298 0.000E+00 0.000E+00 1.700E-20 1.348E-20 1.942E-19 3.038E-19 - 3.488E-19 3.899E-19 4.613E-18 3.043E-18 1.697E-18 1.304E-18 - 4.511E-19 1.512E-19 5.199E-20 2.434E-21 0.000E+00 0.000E+00 -BrO 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.867E-18 3.589E-18 4.195E-18 6.168E-18 6.416E-19 0.000E+00 -BrO 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.867E-18 3.589E-18 4.195E-18 6.168E-18 6.416E-19 0.000E+00 -BrNO3 230 0.000E+00 0.000E+00 4.706E-19 4.130E-19 4.049E-18 3.829E-18 - 3.342E-18 3.003E-18 5.340E-19 5.991E-19 4.493E-19 2.069E-19 - 1.739E-19 1.487E-19 1.264E-19 8.798E-20 3.698E-20 1.433E-21 -BrNO3 298 0.000E+00 0.000E+00 5.742E-19 5.079E-19 4.810E-18 4.201E-18 - 3.465E-18 3.015E-18 5.525E-19 5.955E-19 4.506E-19 2.094E-19 - 1.702E-19 1.421E-19 1.203E-19 8.624E-20 3.697E-20 1.435E-21 -HOBr 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 1.275E-19 2.011E-19 2.203E-19 2.198E-19 - 1.727E-19 1.369E-19 1.158E-19 1.125E-19 6.205E-20 2.760E-21 -HOBr 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 1.275E-19 2.011E-19 2.203E-19 2.198E-19 - 1.727E-19 1.369E-19 1.158E-19 1.125E-19 6.205E-20 2.760E-21 -BrCl 295 0.000E+00 0.000E+00 2.231E-21 1.793E-21 2.467E-20 3.703E-20 - 4.155E-20 4.525E-20 2.449E-20 1.885E-20 1.089E-20 6.209E-21 - 8.067E-21 1.270E-20 2.234E-20 1.002E-19 3.069E-19 2.079E-20 -BrCl 298 0.000E+00 0.000E+00 2.231E-21 1.793E-21 2.467E-20 3.703E-20 - 4.155E-20 4.525E-20 2.449E-20 1.885E-20 1.089E-20 6.209E-21 - 8.067E-21 1.270E-20 2.234E-20 1.002E-19 3.069E-19 2.079E-20 -N2O 200 1.065E-19 8.370E-20 6.860E-20 5.030E-20 2.101E-20 6.196E-21 - 3.137E-21 2.461E-21 3.187E-25 1.033E-23 4.192E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -N2O 300 1.212E-19 9.913E-20 8.348E-20 6.438E-20 3.032E-20 1.110E-20 - 6.355E-21 4.604E-21 1.450E-24 4.001E-23 1.193E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CFCl3 210 2.235E-18 1.654E-18 1.341E-18 9.895E-19 4.775E-19 1.726E-19 - 9.677E-20 6.948E-20 3.726E-23 5.742E-22 1.696E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CFCl3 298 2.235E-18 1.654E-18 1.341E-18 9.895E-19 4.896E-19 2.040E-19 - 1.270E-19 9.334E-20 9.773E-23 1.292E-21 2.965E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CF2Cl2 210 9.761E-19 5.212E-19 3.336E-19 1.523E-19 3.679E-20 5.682E-21 - 2.471E-21 5.890E-21 1.860E-25 6.426E-24 2.757E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CF2Cl2 298 1.011E-18 5.853E-19 4.027E-19 2.183E-19 6.318E-20 1.272E-20 - 5.987E-21 8.765E-21 8.059E-25 2.473E-23 8.297E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F113 210 9.497E-19 5.917E-19 4.254E-19 2.482E-19 7.456E-20 1.707E-20 - 8.903E-21 1.083E-20 3.433E-24 5.693E-23 1.547E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F113 295 9.511E-19 5.959E-19 4.337E-19 2.628E-19 9.316E-20 2.669E-20 - 1.447E-20 1.388E-20 6.622E-24 1.039E-22 2.672E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F114 210 1.201E-19 5.463E-20 3.371E-20 1.594E-20 4.529E-21 9.476E-22 - 4.520E-22 6.984E-22 4.735E-26 2.382E-24 6.853E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F114 298 1.207E-19 5.582E-20 3.519E-20 1.815E-20 5.996E-21 1.606E-21 - 8.457E-22 9.362E-22 1.184E-25 5.777E-24 1.539E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F115 210 6.875E-21 2.992E-21 1.894E-21 1.021E-21 3.543E-22 1.135E-22 - 6.099E-23 6.161E-23 0.000E+00 5.814E-25 1.349E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F115 298 6.875E-21 2.992E-21 1.894E-21 1.021E-21 3.543E-22 1.135E-22 - 6.099E-23 6.161E-23 0.000E+00 5.814E-25 1.349E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CCl4 210 3.700E-18 1.712E-18 1.123E-18 7.233E-19 6.126E-19 4.759E-19 - 3.782E-19 2.865E-19 6.520E-22 7.169E-21 1.329E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CCl4 298 3.700E-18 1.712E-18 1.124E-18 7.237E-19 6.261E-19 5.193E-19 - 4.361E-19 3.497E-19 1.542E-21 1.199E-20 1.823E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Cl 210 2.839E-19 1.304E-19 8.153E-20 3.963E-20 1.112E-20 2.169E-21 - 9.976E-22 1.660E-21 1.051E-25 4.276E-24 1.401E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Cl 298 2.842E-19 1.310E-19 8.252E-20 4.131E-20 1.284E-20 3.138E-21 - 1.607E-21 2.031E-21 2.284E-25 9.236E-24 2.797E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3CCl3210 2.720E-18 2.022E-18 1.681E-18 1.340E-18 7.225E-19 3.107E-19 - 1.821E-19 1.241E-19 6.301E-23 1.516E-21 3.926E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3CCl3298 2.720E-18 2.022E-18 1.682E-18 1.340E-18 7.436E-19 3.535E-19 - 2.234E-19 1.564E-19 2.108E-22 2.590E-21 5.500E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Cl2 295 1.001E-18 5.807E-19 3.980E-19 2.147E-19 7.135E-20 2.123E-20 - 1.194E-20 1.227E-20 7.550E-24 1.014E-22 2.360E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Cl2 298 1.001E-18 5.807E-19 3.980E-19 2.147E-19 7.135E-20 2.123E-20 - 1.194E-20 1.227E-20 7.550E-24 1.014E-22 2.360E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHF2Cl 210 7.494E-21 2.752E-21 1.541E-21 6.772E-22 1.908E-22 3.775E-23 - 1.836E-23 2.980E-23 0.000E+00 0.000E+00 2.072E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHF2Cl 298 7.508E-21 2.783E-21 1.580E-21 7.388E-22 2.371E-22 6.205E-23 - 3.498E-23 4.067E-23 0.000E+00 0.000E+00 5.984E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F123 210 9.477E-19 5.104E-19 3.413E-19 1.845E-19 6.084E-20 1.632E-20 - 8.820E-21 9.596E-21 4.462E-24 6.962E-23 1.708E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F123 295 1.036E-18 6.020E-19 4.220E-19 2.466E-19 8.890E-20 2.668E-20 - 1.501E-20 1.435E-20 1.189E-23 1.412E-22 3.164E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F141b 210 1.070E-18 7.020E-19 5.165E-19 3.064E-19 1.026E-19 2.588E-20 - 1.298E-20 1.430E-20 2.940E-24 6.901E-23 2.167E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F141b 298 1.126E-18 7.473E-19 5.560E-19 3.445E-19 1.219E-19 3.311E-20 - 1.749E-20 1.724E-20 4.901E-24 1.135E-22 3.115E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F142b 210 2.300E-20 8.701E-21 4.892E-21 2.158E-21 6.225E-22 1.325E-22 - 6.412E-23 9.552E-23 0.000E+00 1.808E-25 8.567E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F142b 298 2.842E-20 1.175E-20 6.994E-21 3.378E-21 1.063E-21 2.568E-22 - 1.309E-22 1.599E-22 0.000E+00 4.680E-25 1.974E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Br 210 1.088E-18 5.032E-19 5.880E-19 6.974E-19 7.649E-19 6.880E-19 - 6.102E-19 5.213E-19 6.091E-21 3.141E-20 3.384E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Br 296 1.088E-18 5.032E-19 5.880E-19 6.974E-19 7.710E-19 7.004E-19 - 6.238E-19 5.365E-19 7.709E-21 3.416E-20 3.537E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H1211 210 5.525E-19 6.381E-19 7.586E-19 9.286E-19 1.221E-18 1.287E-18 - 1.221E-18 1.107E-18 2.880E-20 8.647E-20 7.900E-20 2.574E-23 - 6.500E-24 2.067E-24 7.281E-25 6.002E-28 0.000E+00 0.000E+00 -H1211 298 5.083E-19 5.769E-19 6.841E-19 8.288E-19 1.109E-18 1.171E-18 - 1.110E-18 1.002E-18 3.538E-20 8.341E-20 7.245E-20 1.035E-22 - 2.614E-23 8.312E-24 2.928E-24 2.414E-27 0.000E+00 0.000E+00 -H1301 210 6.008E-20 8.104E-20 9.353E-20 1.082E-19 1.320E-19 1.358E-19 - 1.256E-19 1.096E-19 7.435E-22 5.808E-21 7.096E-21 1.158E-25 - 7.298E-27 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H1301 298 5.456E-20 7.322E-20 8.413E-20 9.672E-20 1.181E-19 1.235E-19 - 1.170E-19 1.049E-19 1.371E-21 6.950E-21 7.252E-21 3.859E-25 - 2.432E-26 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H2402 210 1.120E-18 1.230E-18 1.268E-18 1.303E-18 1.288E-18 1.169E-18 - 1.064E-18 9.203E-19 2.046E-20 7.238E-20 6.550E-20 1.609E-23 - 4.515E-24 1.715E-24 8.065E-25 8.505E-28 0.000E+00 0.000E+00 -H2402 298 1.023E-18 1.133E-18 1.175E-18 1.220E-18 1.211E-18 1.098E-18 - 1.004E-18 8.982E-19 2.561E-20 7.202E-20 6.334E-20 4.022E-23 - 1.129E-23 4.288E-24 2.016E-24 2.126E-27 0.000E+00 0.000E+00 -CH2Br2 210 1.959E-18 1.953E-18 2.050E-18 2.218E-18 2.152E-18 2.272E-18 - 2.588E-18 3.086E-18 1.541E-19 4.674E-19 3.038E-19 7.403E-23 - 4.852E-24 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Br2 298 1.985E-18 1.979E-18 2.078E-18 2.248E-18 2.209E-18 2.274E-18 - 2.409E-18 2.573E-18 1.722E-19 3.733E-19 2.365E-19 2.590E-22 - 2.022E-23 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHBr3 210 5.582E-18 4.311E-18 4.041E-18 3.938E-18 4.623E-18 4.751E-18 - 5.084E-18 5.538E-18 7.770E-19 9.248E-19 5.607E-19 7.371E-21 - 1.884E-21 5.808E-22 2.106E-22 2.441E-23 2.035E-25 0.000E+00 -CHBr3 296 5.645E-18 4.311E-18 3.957E-18 3.752E-18 4.281E-18 4.543E-18 - 4.825E-18 5.242E-18 8.941E-19 9.054E-19 5.341E-19 1.628E-20 - 4.870E-21 1.707E-21 7.074E-22 9.311E-23 9.691E-25 0.000E+00 -CH3I 210 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 3.728E-20 4.774E-20 8.199E-19 2.010E-19 6.431E-20 2.781E-20 - 8.253E-21 3.557E-21 1.826E-21 3.437E-22 2.347E-24 0.000E+00 -CH3I 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 3.728E-20 4.774E-20 8.383E-19 2.430E-19 9.306E-20 4.648E-20 - 1.511E-20 6.466E-21 3.293E-21 6.699E-22 9.781E-24 0.000E+00 -CF3I 210 7.810E-21 3.897E-21 2.406E-21 1.654E-21 1.770E-21 2.843E-21 - 4.166E-21 6.218E-21 5.767E-19 3.647E-19 2.023E-19 1.225E-19 - 4.277E-20 1.644E-20 7.396E-21 1.169E-21 1.219E-23 0.000E+00 -CF3I 300 7.810E-21 3.897E-21 2.406E-21 1.654E-21 1.770E-21 2.843E-21 - 4.166E-21 6.218E-21 5.173E-19 3.550E-19 2.274E-19 1.541E-19 - 6.499E-20 2.943E-20 1.453E-20 2.580E-21 3.848E-23 0.000E+00 -OCS 225 2.886E-20 2.996E-20 2.915E-20 2.338E-20 6.033E-20 1.226E-19 - 1.688E-19 2.184E-19 1.003E-20 4.131E-20 2.415E-20 9.441E-25 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -OCS 295 4.075E-20 4.032E-20 3.634E-20 2.433E-20 5.993E-20 1.216E-19 - 1.685E-19 2.189E-19 1.389E-20 4.620E-20 2.468E-20 3.027E-24 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -PAN 250 2.687E-19 7.661E-19 1.399E-18 2.529E-18 2.977E-18 2.201E-18 - 1.765E-18 1.322E-18 6.565E-20 9.407E-20 8.486E-20 2.438E-21 - 9.252E-22 4.355E-22 2.288E-22 5.480E-23 6.941E-25 0.000E+00 -PAN 298 2.951E-19 8.392E-19 1.520E-18 2.757E-18 3.144E-18 2.279E-18 - 1.834E-18 1.385E-18 7.911E-20 1.056E-19 9.185E-20 3.555E-21 - 1.399E-21 6.750E-22 3.627E-22 9.257E-23 1.265E-24 0.000E+00 -CH3NO3 240 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.337E-20 1.004E-20 6.638E-21 4.679E-21 - 2.022E-21 9.381E-22 3.730E-22 3.755E-23 0.000E+00 0.000E+00 -CH3NO3 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.788E-20 1.233E-20 8.359E-21 6.029E-21 - 2.735E-21 1.346E-21 5.734E-22 6.957E-23 0.000E+00 0.000E+00 -ActAld 297 0.000E+00 0.000E+00 2.422E-23 0.000E+00 3.974E-22 5.086E-22 - 4.875E-22 4.794E-22 1.893E-20 2.310E-20 2.384E-20 2.161E-20 - 1.460E-20 8.410E-21 3.335E-21 1.751E-22 0.000E+00 0.000E+00 -ActAld 298 0.000E+00 0.000E+00 2.422E-23 0.000E+00 3.974E-22 5.086E-22 - 4.875E-22 4.794E-22 1.893E-20 2.310E-20 2.384E-20 2.161E-20 - 1.460E-20 8.410E-21 3.335E-21 1.751E-22 0.000E+00 0.000E+00 -MeVK 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 8.241E-22 2.211E-21 3.811E-21 5.521E-21 - 7.955E-21 8.828E-21 7.236E-21 3.374E-21 1.790E-22 0.000E+00 -MeVK 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 8.241E-22 2.211E-21 3.811E-21 5.521E-21 - 7.955E-21 8.828E-21 7.236E-21 3.374E-21 1.790E-22 0.000E+00 -MeAcr 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.398E-23 7.595E-23 1.398E-22 2.107E-22 - 3.151E-22 3.995E-22 4.742E-22 5.222E-22 1.064E-22 0.000E+00 -MeAcr 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.398E-23 7.595E-23 1.398E-22 2.107E-22 - 3.151E-22 3.995E-22 4.742E-22 5.222E-22 1.064E-22 0.000E+00 -GlyAld 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.443E-20 1.829E-19 - 1.143E-19 6.872E-20 3.025E-20 3.387E-20 3.392E-20 2.784E-20 - 1.706E-20 9.411E-21 4.388E-21 4.937E-22 0.000E+00 0.000E+00 -GlyAld 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.443E-20 1.829E-19 - 1.143E-19 6.872E-20 3.025E-20 3.387E-20 3.392E-20 2.784E-20 - 1.706E-20 9.411E-21 4.388E-21 4.937E-22 0.000E+00 0.000E+00 -MEKeto 297 0.000E+00 0.000E+00 5.903E-22 0.000E+00 5.952E-21 1.749E-21 - 1.668E-21 1.837E-21 4.246E-20 4.757E-20 4.604E-20 4.170E-20 - 2.684E-20 1.570E-20 7.721E-21 8.142E-22 3.734E-25 0.000E+00 -MEKeto 298 0.000E+00 0.000E+00 5.903E-22 0.000E+00 5.952E-21 1.749E-21 - 1.668E-21 1.837E-21 4.246E-20 4.757E-20 4.604E-20 4.170E-20 - 2.684E-20 1.570E-20 7.721E-21 8.142E-22 3.734E-25 0.000E+00 -EAld 297 0.000E+00 0.000E+00 2.124E-23 0.000E+00 3.576E-22 5.328E-22 - 6.036E-22 6.848E-22 2.982E-20 4.517E-20 5.121E-20 5.548E-20 - 4.630E-20 3.578E-20 2.441E-20 5.853E-21 1.257E-23 0.000E+00 -EAld 298 0.000E+00 0.000E+00 2.124E-23 0.000E+00 3.576E-22 5.328E-22 - 6.036E-22 6.848E-22 2.982E-20 4.517E-20 5.121E-20 5.548E-20 - 4.630E-20 3.578E-20 2.441E-20 5.853E-21 1.257E-23 0.000E+00 -MGlyxl 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.483E-20 4.131E-20 4.375E-20 4.384E-20 - 3.465E-20 2.428E-20 1.788E-20 6.194E-21 2.237E-20 1.435E-21 -MGlyxl 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.483E-20 4.131E-20 4.375E-20 4.384E-20 - 3.465E-20 2.428E-20 1.788E-20 6.194E-21 2.237E-20 1.435E-21 -Glyxla 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 6.833E-21 1.009E-20 1.174E-20 1.333E-20 - 1.238E-20 1.117E-20 8.335E-21 2.625E-21 0.000E+00 0.000E+00 -Glyxla 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 6.833E-21 1.009E-20 1.174E-20 1.333E-20 - 1.238E-20 1.117E-20 8.335E-21 2.625E-21 0.000E+00 0.000E+00 -Glyxlb 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 5.914E-22 2.199E-22 -Glyxlb 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 5.914E-22 2.199E-22 -XXXX 299 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -XXXX 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -C3H6O 220 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.819E-20 3.809E-20 3.492E-20 3.100E-20 - 1.944E-20 1.088E-20 5.532E-21 4.637E-22 3.425E-25 0.000E+00 -C3H6O 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.851E-20 4.004E-20 3.775E-20 3.439E-20 - 2.255E-20 1.356E-20 7.273E-21 8.481E-22 6.682E-25 0.000E+00 -Q2-Acet240 3.000E-02 3.000E-02 3.000E-02 3.000E-02 3.000E-02 3.000E-02 - 3.000E-02 3.000E-02 3.000E-02 2.380E-02 1.144E-02 5.156E-03 - 1.931E-03 8.022E-04 4.144E-04 4.156E-05 0.000E+00 0.000E+00 -Q2-Acet300 2.000E-01 2.000E-01 2.000E-01 2.000E-01 2.000E-01 2.000E-01 - 2.000E-01 2.000E-01 2.000E-01 1.790E-01 1.250E-01 8.564E-02 - 5.100E-02 3.298E-02 2.214E-02 3.533E-03 0.000E+00 0.000E+00 -Q1A-Ace240 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.207E+00 4.133E+00 2.498E+01 9.452E+01 1.000E+02 1.000E+02 -Q1A-Ace300 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.006E+00 - 1.223E+00 2.411E+00 6.656E+00 1.969E+01 2.100E+01 2.100E+01 -Q1B-Ace240 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 2.447E-02 1.841E-01 1.028E+00 - 1.066E+01 5.202E+01 2.632E+02 2.760E+03 3.210E+03 3.210E+03 -Q1B-Ace300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 4.987E-02 2.454E-01 8.792E-01 - 4.897E+00 1.617E+01 5.268E+01 3.023E+02 3.420E+02 3.420E+02 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_test.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_test.dat deleted file mode 100644 index 8918f02c..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/FJX_test.dat +++ /dev/null @@ -1,53 +0,0 @@ -Input file for stand-alone test version of Fast-J2 code -(ver 5.3-7/05) ->>>>>>>this version is keyed to test with EC T42 grid and 37-level model ------------------------------------------------------------------------ - 80 Day of year - 1 Number of steps to run - 12.0 Start time of day (UT) to calculate J's - 1.0 Time step (hours, if multiple steps) - 33 JLatitude - 1 Longitude -1000.0 Surface Pressure - 0.10 Surface Albedo - 10 Cloud's Mie index for OD below - Eta(a) Eta(b) Temp OD - 1 0.0000000 1.0000000 278.7 0.0 - 2 0.6588924 0.9882701 278.6 0.0 - 3 4.6733350 0.9676452 278.1 10.0 - 4 8.5536182 0.9518215 277.5 0.0 - 5 13.8591260 0.9319403 276.9 0.0 - 6 20.6377979 0.9078839 276.2 0.0 - 7 28.8769653 0.8796569 275.4 0.0 - 8 38.5091333 0.8473749 274.5 0.0 - 9 49.4177734 0.8112534 273.5 0.0 - 10 61.4431641 0.7715966 272.4 0.0 - 11 74.3880469 0.7287858 271.2 0.0 - 12 88.0235547 0.6832686 269.8 0.0 - 13 102.0950000 0.6355475 268.0 0.0 - 14 116.3275781 0.5861684 265.8 0.0 - 15 130.4321875 0.5357099 263.4 0.0 - 16 144.1112500 0.4847716 260.8 0.0 - 17 157.0644922 0.4339629 258.0 0.0 - 18 168.9946875 0.3838922 254.9 0.0 - 19 179.6135938 0.3351549 251.5 0.0 - 20 188.6475000 0.2883229 247.8 0.0 - 21 195.8432813 0.2439331 243.8 0.0 - 22 200.9740234 0.2024760 239.5 0.0 - 23 203.8448047 0.1643843 235.2 0.0 - 24 204.2986328 0.1300225 230.9 0.0 - 25 202.2220703 0.0996747 226.8 0.0 - 26 197.5510938 0.0735338 223.3 0.0 - 27 190.2769531 0.0516904 220.5 0.0 - 28 180.4518359 0.0341212 218.1 0.0 - 29 168.1947656 0.0206779 215.9 0.0 - 30 153.6973047 0.0110762 213.4 0.0 - 31 137.2294141 0.0048842 210.7 0.0 - 32 119.1452344 0.0015113 208.4 0.0 - 33 99.8888281 0.0001971 207.7 0.0 - 34 80.0000000 0.0000000 209.2 0.0 - 35 60.0000000 0.0000000 212.2 0.0 - 36 40.0000000 0.0000000 216.4 0.0 - 37 20.0000000 0.0000000 224.9 0.0 - 38 2.0000000 0.0000000 ------------------------------------------------------------------------ - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/README b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/README deleted file mode 100644 index 1b869aee..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/README +++ /dev/null @@ -1,3 +0,0 @@ -This directory contains the latest version of FastJX53.c. -It is the reference for FastJX53.c because only an "interface" to -the GMI code was implemented. diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.dat deleted file mode 100644 index a49b12d2..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.dat +++ /dev/null @@ -1,147 +0,0 @@ - 41 53 28 34 40 46 22 21 20 19 16 15 14 13 10 9 8 7 3 2 1 35 66 59 71 - 76 65 52 58 45 27 39 38 33 32 25 26 31 37 70 64 0 0 0 0 0 0 0 0 0 - 83 80 75 69 63 57 50 49 51 44 43 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 68 79 61 62 74 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 84 85 81 82 77 78 72 67 73 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 86 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 87 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 88 55 56 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 94 95 96 97 98 99 100 101 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 91 92 93 102 103 104 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 89 90 105 106 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 107 108 109 110 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 111 112 113 114 115 116 117 118 119 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 120 121 122 123 124 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 125 126 127 128 129 130 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 131 132 133 134 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 135 136 137 138 139 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - 140 141 142 143 144 145 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -NWWW,NWSRB,NSR,NODF 77 0 15 6 - 77 wavelength bins (nm): edges of bins - 177.49 178.30 179.26 180.38 181.65 183.08 184.65 186.37 - 188.24 190.25 192.42 194.73 197.20 198.50 200.00 202.50 - 204.00 206.50 209.50 212.50 215.50 218.50 221.50 225.00 - 229.00 233.00 237.50 242.50 248.00 254.00 260.00 265.50 - 270.50 275.50 280.00 283.50 286.50 289.00 291.00 293.00 - 295.00 296.75 298.25 299.55 300.50 301.50 302.50 303.50 - 304.50 305.50 306.50 307.45 308.50 309.45 310.50 311.50 - 312.45 313.50 314.50 315.70 317.20 318.70 320.30 322.50 - 326.95 334.95 345.00 355.05 365.03 375.00 389.95 412.45 - 437.55 485.10 560.10 635.10 760.20 850.00 -SOLAR FLUX - 1.023E+11 1.443E+11 1.624E+11 2.136E+11 2.998E+11 2.927E+11 3.082E+11 4.765E+11 - 6.149E+11 7.709E+11 9.205E+11 1.345E+12 7.772E+11 9.630E+11 1.930E+12 1.291E+12 - 2.593E+12 4.391E+12 8.905E+12 1.081E+13 1.153E+13 1.451E+13 2.131E+13 2.063E+13 - 2.298E+13 2.396E+13 2.822E+13 3.842E+13 3.790E+13 7.566E+13 1.072E+14 1.715E+14 - 1.277E+14 1.204E+14 1.214E+14 1.035E+14 1.229E+14 1.601E+14 1.540E+14 1.526E+14 - 1.481E+14 1.190E+14 8.872E+13 6.089E+13 7.177E+13 6.438E+13 9.648E+13 8.564E+13 - 9.661E+13 8.102E+13 8.878E+13 1.037E+14 8.216E+13 8.354E+13 1.308E+14 1.019E+14 - 1.135E+14 1.144E+14 1.297E+14 1.504E+14 1.733E+14 1.893E+14 2.728E+14 6.081E+14 - 1.296E+15 1.609E+15 1.766E+15 1.744E+15 2.097E+15 3.038E+15 6.791E+15 9.281E+15 - 2.224E+16 3.676E+16 3.960E+16 6.302E+16 4.013E+16 -SOLAR FLUX FRACTION IN EACH ODF INTERVAL of SR BAND (first 15 wavelength bins) - 0.0562098 0.0548974 0.1310001 0.2815141 0.2430998 0.2332788 6 (14,0)1774-1783 - 0.0451409 0.0632187 0.1538378 0.2485244 0.2947289 0.1945493 6 (13,0)1783-1792 - 0.0214714 0.0537082 0.0640064 0.2583904 0.3433215 0.2591021 6 (12,0)1792-1803 - 0.0170065 0.0260882 0.0446498 0.2352912 0.3747215 0.3022428 6 (11,0)1803-1816 - 0.0159927 0.0339670 0.1024221 0.2039374 0.3901620 0.2535187 6 (10,0)1816-1830 - 0.0282720 0.0649144 0.0978781 0.2467259 0.3058463 0.2563633 6 ( 9,0)1830-1846 - 0.0427360 0.0866815 0.2068776 0.3026235 0.1845225 0.1765588 6 ( 8,0)1846-1863 - 0.1009842 0.1230950 0.2430010 0.3038099 0.1389306 0.0901792 6 ( 7,0)1863-1882 - 0.0681366 0.1082614 0.2504070 0.3683407 0.1568642 0.0479901 6 ( 6,0)1882-1902 - 0.0510512 0.1058023 0.2874135 0.2992014 0.1640989 0.0924328 6 ( 5,0)1902-1924 - 0.0665129 0.1714459 0.2807559 0.1922221 0.1406821 0.1483812 6 ( 4,0)1924-1972 - 0.2762010 0.2468585 0.2104024 0.1905783 0.0759598 0.0000000 5 ( 3,0)1947-1972 - 0.2570941 0.2497652 0.1980173 0.1975341 0.0975893 0.0000000 5 ( 2,0)1972-1985 - 0.5136821 0.2429863 0.1415088 0.1018228 0.0000000 0.0000000 4 ( 1,0)1985-2000 - 0.6147517 0.3386017 0.0466466 0.0000000 0.0000000 0.0000000 3 ( 0,0)2000-2025 ------------read in stops here - -UCI standard model contains 77 bins including 15 S-R bands. -Each S-R band contains several sub-bins and totally 83 sub-bins are in - S-R bands. -The detail information of how to group UCI standard model into Fast-JX - 18 bins is explained in the following table. - - -Bin 1 2 3 4 5 6 S-R Wavelength - (nm) - group to Fast-J2 bin -1 1 1 1 0 0 0 (14,0) 177.49-178.30 -2 1 1 1 1 0 0 (13,0) 178.30-179.26 -3 1 1 1 1 0 0 (12,0) 179.26-180.38 -4 1 1 1 1 0 0 (11,0) 180.38-181.65 -5 2 2 2 1 0 0 (10,0) 181.65-183.08 -6 2 2 2 1 1 0 ( 9,0) 183.08-184.65 -7 2 2 2 1 1 0 ( 8,0) 184.65-186.37 -8 3 3 2 1 0 0 ( 7,0) 186.37-188.24 -9 3 3 3 2 1 0 ( 6,0) 188.24-190.25 -10 8 8 3 2 1 0 ( 5,0) 190.25-192.42 -11 4 4 3 2 2 1 ( 4,0) 192.42-194.73 -12 5 5 4 3 2 ( 3,0) 194.73-197.20 -13 5 5 4 3 2 ( 2,0) 197.20-198.50 -14 5 5 4 3 ( 1,0) 198.50-200.00 -15 5 5 3 ( 0,0) 200.00-202.50 -16 5 202.50-204.00 -17 5 204.00-206.50 -18 6 206.50-209.50 -19 7 209.50-212.50 -20 8 212.50-215.50 -21 11 215.50-218.50 -22 11 218.50-221.50 -23 10 221.50-225.00 -24 10 225.00-229.00 -25 10 229.00-233.00 -26 9 233.00-237.50 -27 9 237.50-242.50 -28 9 242.50-248.00 -29 9 248.00-254.00 -30 9 254.00-260.00 -31 9 260.00-265.50 -32 9 265.50-270.50 -33 9 270.50-275.50 -34 10 275.50-280.00 -35 10 280.00-283.50 -36 10 283.50-286.50 -37 11 286.50-289.00 -38 11 289.00-291.00 - -39 12 291.00-293.00 -40 12 293.00-295.00 -41 12 295.00-296.00 -42 12 296.00-298.30 -43 13 298.30-299.60 -44 13 299.6 -300.5 -45 13 300.5 -301.5 -46 13 301.5 -302.5 -47 13 302.5 -303.5 -48 13 303.5 -304.5 -49 13 304.5 -305.5 -50 13 305.5 -306.5 -51 13 306.6 -307.5 -52 14 307.5 -308.5 -53 14 308.5 -309.5 -54 14 309.5 -310.5 -55 14 310.5 -311.5 -56 14 311.5 -312.5 -57 15 312.5 -313.5 -58 15 313.5 -314.5 -59 15 314.5 -315.7 -60 15 315.7 -317.2 -61 15 317.2 -318.7 -62 15 318.7 -320.3 -63 16 320.3 -322.5 -64 16 322.5 -327.0 -65 16 327.0 -335.0 -66 16 335.0 -345.0 -67 17 345.0 -355.0 -68 17 355.0 -365.0 -69 17 365.0 -375.0 -70 17 375.0 -390.1 -71 17 390.1 -412.5 -72 18 412.5 -437.6 -73 18 437.6 -485.1 -74 18 485.1 -560.1 -75 18 560.1 -635.1 -76 18 635.1 -760.2 -77 18 760.2 -850.0 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.f deleted file mode 100644 index f709c537..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_bins.f +++ /dev/null @@ -1,328 +0,0 @@ - program FJX_bins -C -C ****************************************************************** -C * * -C * GENERATING SOLAR FLUX AVERAGED CROSS SECTION IN GIVEN BINS * -C * >>>>>>>from ref code 77-bin to 18-bin fast-JX v5.3 <<<<<<< * -C * * -C ****************************************************************** -C -C----------------------------------------------------------------------- -C -C Combines the 77-bin std Xsects (including XX SR ODF bins) = 145 total -C into the fast-J(2) bins (7 at trop wavels, 18 for strat+trop) -C according to a supplied "FJX_bins.dat" file for the Fast-JX code -C Output = FJX_05.dat -C -C history Standard model: Xin Zhu -C Fast-J & Distribution: Oliver Wild (9/98) -C Fast-J2: Huisheng Bian (8/02) -C new Fast-J(2) Prather (7/04) -C new Fast-JX v-5.3 Prather (6/05) -C -c open (10, file='fort10.x',status='OLD') -c open ( 2, file='FJX_bins.dat',status='OLD') -c open ( 3, file='FJX_spec.dat',status='NEW') - - -C----------------------------------------------------------------------- - include 'cmn_bins.f' - - character*8 TITJ(64) - data TITJ/ - 1'J-NO ','J-O2 ','J-O3 ','J-O3(1D)','J-H2COa ','J-H2COb ', - 2'J-H2O2 ','J-CH3OOH','J-NO2 ','J-NO3 ','J-N2O5 ','J-HNO2 ', - 3'J-HNO3 ','J-HNO4 ','J-ClNO3a','J-ClNO3b','J-Cl2 ','J-HOCl ', - 4'J-OClO ','J-Cl2O2 ','J-ClO ','J-BrO ','J-BrNO3 ','J-HOBr ', - 5'J-BrCl ','J-N2O ','J-CFCl3 ','J-CF2Cl2','J-F113 ','J-F114 ', - 6'J-F115 ','J-CCl4 ','J-CH3Cl ','J-MeCCL3','J-CH2Cl2','J-CHF2Cl', - 7'J-F123 ','J-F141b ','J-F142b ','J-CH3Br ','J-H1211 ','J-H1301 ', - 8'J-H2402 ','J-CH2Br2','J-CHBr3 ','J-CH3I ','J-CF3I ','J-OCS ', - 9'J-PAN ','J-CH3NO3','J-ActAld','J-MeVK ','J-MeAcr ','J-GlyAld', - A'J-MEKeto','J-EAld ','J-MGlyxl','J-Glyxla','J-Glyxlb','J-XXXX ', - B'J-C3H6O ','J Q2-Ac ','J Q1A-Ac','J Q1B-Ac'/ - -C---------77-bin spectral data----------UNIT=10---------------------------- - open (10, file='fort10.x',status='OLD') - - do J=1,40 - do K=1,3 - TQQ(K,J) = 0.0 - enddo - enddo - - read(10,'(A)') TITLE0 - WRITE(6,'(1X,A)') TITLE0 - read(10,'(10x,8i5)') NJVAL,NQQQ,NWWW,NW1,NW2,NWSRB,NSR,NODF - -c----NJVAL =no. J values -C----NQQQ = no. additional X-sects: # J-values = NQQQ+4+additional (p-dep) -C e.g., 2 additional J's from pressure dep q-yld (MeVK, Acetone) - - read(10,'(a)') - read(10,'(8e10.3)') (WBIN(IW),IW=1,NWWW+1) - do IW=1,NWWW - WL(IW) = 0.5*(WBIN(IW)+WBIN(IW+1)) - enddo - read(10,'(a)') - read(10,'(8e10.3)') (FL(IW),IW=1,NWWW) - read(10,'(a)') - do L = 1,NSR - read(10,'(6F10.1,I3)') (ODF(I,L),I=1,NODF), ISR(L) - enddo - read(10,'(a20)') TITLEJ(1,1) - read(10,'(a)') - TITLEJ(2,1) = ' ' - TITLEJ(3,1) = ' ' - do L = 1,NSR - read(10,'(7F10.1)') FNO(L),(QNO(I,L),I=1,NODF) - enddo - -C-------NO X-sections from oscillator strength: 8.85E-13=(pi*e^2)/(m*c^2) (cm) - do L = 1,NSR - K = L+NWSRB - if(FNO(L).GT.0.0) then - CNO = 8.85E-13*FNO(L) / (1.E7*(1./WBIN(K) - 1./WBIN(K+1))) - do I = 1,NODF - QNO(I,L) = CNO*QNO(I,L)/ODF(I,L) - enddo - endif - enddo -C--------O2: X-sections & S-R band opacity distribution functions - do K = 1, 3 - read(10,'(a20,f5.0)') TITLEJ(K,2),TQQ(K,2) - read(10,'(8e10.3)') (QO2(IW,K),IW=1,NWWW) - read(10,'(a)') - do L = 1,NSR - read(10,'(8e10.3)') (O2X(I,L,K),I=1,NODF) - enddo - enddo - do K = 1, 3 - read(10,'(A20,F5.0)') TITLEJ(K,3),TQQ(K,3) - read(10,'(8e10.3)') (QO3(IW,K),IW=1,NWWW) - enddo - do K = 1, 3 - read(10,'(A20,F5.0)') TITLEJ(K,4),TQQ(K,4) - read(10,'(8e10.3)') (Q1D(IW,K),IW=1,NWWW) - enddo -C-------rest of X-sections - do JQ=5,NQQQ - read(10,'(a20,f5.0)') TITLEJ(1,JQ),TQQ(1,JQ) - read(10,'(8e10.3)') (QQQ(IW,1,JQ),IW=1,NWWW) - read(10,'(a20,f5.0)') TITLEJ(2,JQ),TQQ(2,JQ) - read(10,'(8e10.3)') (QQQ(IW,2,JQ),IW=1,NWWW) - enddo - - write(6,'(I5,A10,2x,a20,2x,a20,2x,3F5.0)') - & (JQ,TITJ(JQ),TITLEJ(1,JQ),TITLEJ(2,JQ), - & TQQ(1,JQ),TQQ(2,JQ),TQQ(3,JQ), JQ=1,NJVAL) - write(6,'(a3,I2,A10,2x,a20,2x,a20,2x,3F5.0)') - & (' xx',JQ,' q-ylds',TITLEJ(1,JQ),TITLEJ(2,JQ), - & TQQ(1,JQ),TQQ(2,JQ),TQQ(3,JQ), JQ=NJVAL+1,NQQQ) - - close (10) - - NSPEC = NQQQ - NBIN = NWWW - -C****************now combine 77-bins+ODFs (145 bins) to get fast-J********* - - call COMB(18) - - stop - end - - - subroutine COMB(NN) -C----------------------------------------------------------------------- -C Combine x-sections from 'NBIN' to 'NN' bins (77 to 18 for Fast-J2) -C----------------------------------------------------------------------- - include 'cmn_bins.f' - integer NN,KT,IG,JG,NG(25,25) - real*8 RAYLAY -c -C-----Read in wavelength bins to combine: - open ( 2, file='FJX_bins.dat',status='OLD') - do IG = 1,NN - read(2,'(25I4)') (NG(JG,IG),JG=1,25) - enddo - close(2) -c - do K=NW1,NW2 -C----calculate true Rayleigh scattering -c POW=-4.0+0.3228-(3.89e-04*WL(K))-(94.26/WL(K)) -c if(WL(K).gt.550.0) POW=-4.04 -c QRL(K) = 4.02e-28*(WL(K)*0.001)**POW - - QRL(K) = RAYLAY(WL(K)) - - enddo -c -C----re-distribution of S-R sub-bins into one dimension - N=0 - do I=1,NSR - M=N - do J=1,ISR(I) - N=M+J - FFL(N)=FL(I)*ODF(J,I) -C----weight the wavelengths by approx. Rayleigh scattering (1/w^4) - WWL(N)=FL(I)*ODF(J,I)/WL(I)**4 - QQRL(N)=QRL(I) - QQNO(N)=QNO(J,I) - do K=1,3 - QQO2(N,K)=O2X(J,I,K) - QQO3(N,K)=QO3(I,K) - QQ1D(N,K)=Q1D(I,K) - enddo - do JQ=1,NQQQ - QQQQ(N,1,JQ)=QQQ(I,1,JQ) - QQQQ(N,2,JQ)=QQQ(I,2,JQ) - enddo - enddo - enddo -c -C----distribute the rest of 77 bins into one dimension above - NT = N + NBIN - NSR - WRITE(6,*) ' TOTAL BINS',NT,NSR - do I=N+1,NT - FFL(I)=FL(I-N+NSR) - WWL(I)=FL(I-N+NSR)/WL(I-N+NSR)**4 - QQRL(I)=QRL(I-N+NSR) - QQNO(I)=0.0 - do K=1,3 - QQO2(I,K)=QO2((I-N+NSR),K) - QQO3(I,K)=QO3((I-N+NSR),K) - QQ1D(I,K)=Q1D((I-N+NSR),K) - enddo - do JQ=1,NQQQ -c NQQQ instead - QQQQ(I,1,JQ)=QQQ((I-N+NSR),1,JQ) - QQQQ(I,2,JQ)=QQQ((I-N+NSR),2,JQ) - enddo - enddo -C - do I=1,NN - SFL(I)=0.D0 - SWL(I)=0.D0 - SQRL(I)=0.D0 - SQNO(I)=0.D0 - do K=1,3 - SQO2(I,K)=0.D0 - SQO3(I,K)=0.D0 - SQ1D(I,K)=0.D0 - enddo - do JQ=1,NQQQ - SQQQ(I,1,JQ)=0.D0 - SQQQ(I,2,JQ)=0.D0 - enddo - enddo -C -C----replace all X-sect_s by X-sect * Flux - do N=1,NT - do IG=1,NN - do JG=1,25 - if(N.EQ.NG(JG,IG)) then - call SUMM(IG,N) - endif - enddo - enddo - enddo -C - do I=1,NN - FL(I)=SFL(I) - WL(I)=1.0/SQRT(SQRT(SWL(I)/FL(I))) - QRL(I)=SQRL(I)/FL(I) - QQNO(I)=SQNO(I)/FL(I) - do K=1,3 - QO2(I,K)=SQO2(I,K)/FL(I) - Q1D(I,K)=SQ1D(I,K)/SQO3(I,K) - QO3(I,K)=SQO3(I,K)/FL(I) - enddo - do JQ=1,NQQQ - QQQ(I,1,JQ)=SQQQ(I,1,JQ)/FL(I) - QQQ(I,2,JQ)=SQQQ(I,2,JQ)/FL(I) - enddo - enddo - -C-----Open output files - open ( 3, file='FJX_spec.dat',status='NEW') - -c output in Fast-JX 18-wavelength format -c (JX_spec.dat) UCI fastJX-5.3: JPL02+irHNO4+IUPAC/NO2/VOC+Bltz (J-8.6, 6/05) - write(3,'(A)') TITLE0 - write(3,'(a10,5I5,a)') 'NW-JValues',NJVAL,NQQQ,NN,1,NN, - & ' NJVAL,NQQQ, NWWW, NW1:NW2=01:18 or 12:18' - write(3,1030) (WL(K),K=NW1,NN) - write(3,1040) (FL(K),K=NW1,NN) - write(3,1050) (QRL(K),K=NW1,NN) ! Rough values only - do KT=1,3 - write(3,1100) TITLEJ(KT,2)(1:7), nint(TQQ(KT,2)), - & (QO2(K,KT),K=NW1,NN) - enddo - do KT=1,3 - write(3,1100) TITLEJ(KT,3)(1:7), nint(TQQ(KT,3)), - & (QO3(K,KT),K=NW1,NN) - enddo - do KT=1,3 - write(3,1100) TITLEJ(KT,4)(1:7), nint(TQQ(KT,4)), - & (Q1D(K,KT),K=NW1,NN) - enddo - write(3,1070) (QQNO(K),K=NW1,NN) - write(3,1070) (QQNO(K),K=NW1,NN) - do JQ=5,NQQQ - do I=1,2 - if(TQQ(1,JQ).gt.TQQ(2,JQ)) then - J=mod(I,2)+1 - else - J=I - endif - write(3,1100) TITLEJ(J,JQ)(1:7), nint(TQQ(J,JQ)), - & (QQQ(K,J,JQ),K=NW1,NN) - enddo - enddo -c - 1030 format('w-eff (nm)',6f10.0/(10x,6f10.0)/(10x,6f10.0)) - 1040 format('SOL#/cm2/s',6(1pE10.3)/(10x,6(1pE10.3))/(10x,6(1pE10.3))) - 1050 format('Raylay cm2',6(1pE10.3)/(10x,6(1pE10.3))/(10x,6(1pE10.3))) - 1070 format('NO 300',6(1pE10.3)/(10x,6(1pE10.3))/(10x,6(1pE10.3))) - 1100 format(a7,i3,6(1pE10.3)/(10x,6(1pE10.3))/(10x,6(1pE10.3))) -c - close(3) - 99 continue - return - end - - - subroutine SUMM(I,N) - include 'cmn_bins.f' - SFL(I)=SFL(I)+FFL(N) - SWL(I)=SWL(I)+WWL(N) - SQRL(I)=SQRL(I)+QQRL(N)*FFL(N) - SQNO(I)=SQNO(I)+QQNO(N)*FFL(N) - do K=1,3 - SQO2(I,K)=SQO2(I,K)+QQO2(N,K)*FFL(N) - SQO3(I,K)=SQO3(I,K)+QQO3(N,K)*FFL(N) - SQ1D(I,K)=SQ1D(I,K)+QQ1D(N,K)*QQO3(N,K)*FFL(N) - enddo - do J=1,NQQQ - SQQQ(I,1,J)=SQQQ(I,1,J)+QQQQ(N,1,J)*FFL(N) - SQQQ(I,2,J)=SQQQ(I,2,J)+QQQQ(N,2,J)*FFL(N) - enddo - return - end - - - function RAYLAY(WAVE) - real*8 WAVE, RAYLAY -C-----CALCULATE RAYLEIGH CROSS-SECTION AT WAVE (ANGSTROM) -C---RAYLEIGH+RAMAN CROSS-SECTION (INCLUDE FOR ALL WAVELENGTHS) - if(WAVE.LT.170.) then - RAYLAY = 1.E-24 - else - WSQI = 1.E6/(WAVE*WAVE) - REFRM1 = 1.0E-6*(64.328+29498.1/(146.-WSQI)+255.4/(41.-WSQI)) - RAYLAY = 5.40E-21*(REFRM1*WSQI)**2 - endif - return - end - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_spec.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_spec.dat deleted file mode 100644 index 613f109c..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/FJX_spec.dat +++ /dev/null @@ -1,404 +0,0 @@ -(fort10_06b) UCI J-v8.4 (4/06) JPL02+irHNO4+IUPAC/NO2/VOC+Blitz +flux2006 -NW-JValues 62 64 18 1 18 NJVAL,NQQQ, NWWW, NW1:NW2=01:18 or 12:18 -w-eff (nm) 187. 191. 193. 196. 202. 208. - 211. 214. 261. 267. 277. 295. - 303. 310. 316. 333. 380. 574. -SOL#/cm2/s 1.391E+12 1.627E+12 1.664E+12 9.278E+11 7.842E+12 4.680E+12 - 9.918E+12 1.219E+13 6.364E+14 4.049E+14 3.150E+14 5.889E+14 - 7.678E+14 5.045E+14 8.902E+14 3.853E+15 1.547E+16 2.131E+17 -Raylay cm2 5.073E-25 4.479E-25 4.196E-25 3.906E-25 3.355E-25 2.929E-25 - 2.736E-25 2.581E-25 1.049E-25 9.492E-26 8.103E-26 6.131E-26 - 5.422E-26 4.923E-26 4.514E-26 3.643E-26 2.087E-26 3.848E-27 -O2 180 1.727E-21 1.989E-22 3.004E-23 9.833E-24 7.306E-24 6.835E-24 - 6.243E-24 5.804E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O2 260 2.273E-21 3.070E-22 4.943E-23 1.408E-23 7.688E-24 6.835E-24 - 6.243E-24 5.886E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O2 300 2.763E-21 4.269E-22 7.478E-23 2.100E-23 8.350E-24 6.835E-24 - 6.243E-24 5.992E-24 8.662E-26 5.040E-25 4.163E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -O3 180 5.849E-19 4.708E-19 4.154E-19 3.549E-19 3.230E-19 4.555E-19 - 6.287E-19 9.126E-19 8.846E-18 3.467E-18 1.495E-18 7.561E-19 - 2.367E-19 8.756E-20 3.690E-20 4.256E-21 1.806E-23 1.625E-21 -O3 260 5.916E-19 4.794E-19 4.246E-19 3.651E-19 3.332E-19 4.610E-19 - 6.325E-19 8.750E-19 8.857E-18 3.565E-18 1.555E-18 8.016E-19 - 2.572E-19 9.710E-20 4.136E-20 5.409E-21 2.784E-23 1.625E-21 -O3 300 5.884E-19 4.736E-19 4.183E-19 3.557E-19 3.302E-19 4.688E-19 - 6.372E-19 8.993E-19 8.863E-18 3.597E-18 1.597E-18 8.391E-19 - 2.778E-19 1.079E-19 4.720E-20 6.725E-21 4.845E-23 1.625E-21 -O3(1D) 180 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.926E-01 4.516E-01 8.621E-02 7.740E-02 0.000E+00 0.000E+00 -O3(1D) 260 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.934E-01 5.091E-01 1.472E-01 8.632E-02 0.000E+00 0.000E+00 -O3(1D) 300 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 9.000E-01 - 8.954E-01 5.723E-01 2.362E-01 9.937E-02 0.000E+00 0.000E+00 -NO 300 1.009E-18 1.156E-18 5.791E-19 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.482E-20 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -NO 300 1.009E-18 1.156E-18 5.791E-19 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.482E-20 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H2COa 223 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.945E-20 1.289E-20 1.969E-20 4.324E-21 5.105E-26 0.000E+00 -H2COa 293 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.850E-20 1.317E-20 1.895E-20 3.922E-21 4.467E-26 0.000E+00 -H2COb 223 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 6.397E-21 4.443E-21 9.027E-21 1.040E-20 1.960E-22 0.000E+00 -H2COb 293 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 6.086E-21 4.543E-21 8.717E-21 9.424E-21 1.903E-22 0.000E+00 -H2O2 200 2.120E-19 4.214E-19 4.925E-19 5.431E-19 4.449E-19 3.760E-19 - 3.459E-19 3.196E-19 5.333E-20 4.860E-20 3.421E-20 8.360E-21 - 5.008E-21 3.220E-21 2.115E-21 7.984E-22 2.101E-23 0.000E+00 -H2O2 300 2.046E-19 4.066E-19 4.752E-19 5.241E-19 4.293E-19 3.628E-19 - 3.338E-19 3.083E-19 5.466E-20 4.902E-20 3.437E-20 9.300E-21 - 5.735E-21 3.803E-21 2.583E-21 1.046E-21 2.715E-23 0.000E+00 -CH3OOH 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.746E-19 2.438E-19 2.745E-20 2.778E-20 2.214E-20 5.621E-21 - 3.573E-21 2.441E-21 1.755E-21 7.405E-22 4.261E-23 0.000E+00 -CH3OOH 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.746E-19 2.438E-19 2.745E-20 2.778E-20 2.214E-20 5.621E-21 - 3.573E-21 2.441E-21 1.755E-21 7.405E-22 4.261E-23 0.000E+00 -NO2 220 0.000E+00 0.000E+00 5.112E-21 0.000E+00 1.845E-19 3.942E-19 - 4.317E-19 4.464E-19 3.127E-20 1.011E-19 1.155E-19 1.053E-19 - 1.476E-19 1.878E-19 2.280E-19 3.257E-19 4.420E-19 1.968E-22 -NO2 298 0.000E+00 0.000E+00 5.040E-21 0.000E+00 1.828E-19 4.053E-19 - 4.544E-19 4.748E-19 3.376E-20 1.042E-19 1.171E-19 1.052E-19 - 1.493E-19 1.885E-19 2.281E-19 3.455E-19 4.612E-19 3.691E-22 -NO3 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.266E-19 -NO3 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.266E-19 -N2O5 225 0.000E+00 0.000E+00 7.943E-19 6.872E-19 7.111E-18 6.566E-18 - 5.183E-18 3.985E-18 2.695E-19 2.794E-19 2.822E-19 3.823E-20 - 1.998E-20 1.170E-20 7.246E-21 2.286E-21 1.173E-22 0.000E+00 -N2O5 300 0.000E+00 0.000E+00 7.943E-19 6.872E-19 7.111E-18 6.566E-18 - 5.183E-18 3.985E-18 2.695E-19 2.843E-19 2.968E-19 5.404E-20 - 3.317E-20 2.226E-20 1.551E-20 6.389E-21 5.481E-22 0.000E+00 -HNO2 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.175E-20 3.470E-20 1.093E-19 8.764E-20 0.000E+00 -HNO2 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 1.175E-20 3.470E-20 1.093E-19 8.764E-20 0.000E+00 -HNO3 200 7.671E-18 1.061E-17 1.043E-17 8.241E-18 3.790E-18 1.301E-18 - 6.914E-19 5.036E-19 1.629E-20 1.796E-20 1.854E-20 3.396E-21 - 1.377E-21 5.474E-22 2.100E-22 2.131E-23 8.822E-26 0.000E+00 -HNO3 300 7.781E-18 1.091E-17 1.090E-17 9.123E-18 4.474E-18 1.565E-18 - 8.458E-19 5.886E-19 1.875E-20 2.165E-20 2.305E-20 4.384E-21 - 1.923E-21 8.345E-22 3.586E-22 4.720E-23 2.683E-25 0.000E+00 -HNO4 297 3.105E-18 6.120E-18 6.954E-18 7.486E-18 4.751E-18 2.866E-18 - 2.220E-18 1.840E-18 2.806E-19 2.208E-19 1.538E-19 2.601E-20 - 1.103E-20 5.239E-21 2.793E-21 2.250E-22 0.000E+00 4.792E-23 -HNO4 298 3.105E-18 6.120E-18 6.954E-18 7.486E-18 4.751E-18 2.866E-18 - 2.220E-18 1.840E-18 2.806E-19 2.208E-19 1.538E-19 2.601E-20 - 1.103E-20 5.239E-21 2.793E-21 2.250E-22 0.000E+00 4.792E-23 -ClNO3a 210 1.194E-19 3.411E-19 6.382E-19 1.137E-18 1.621E-18 1.789E-18 - 1.936E-18 2.025E-18 2.000E-19 2.847E-19 2.070E-19 2.113E-20 - 1.125E-20 6.895E-21 4.722E-21 2.354E-21 9.486E-22 6.713E-24 -ClNO3a 296 1.282E-19 3.661E-19 6.817E-19 1.217E-18 1.691E-18 1.808E-18 - 1.933E-18 2.009E-18 2.313E-19 3.034E-19 2.143E-19 2.760E-20 - 1.542E-20 9.855E-21 6.949E-21 3.329E-21 1.168E-21 9.354E-24 -ClNO3b 210 7.960E-20 2.274E-19 4.255E-19 7.580E-19 1.080E-18 1.192E-18 - 1.291E-18 1.350E-18 1.333E-19 1.898E-19 1.380E-19 1.408E-20 - 7.500E-21 4.347E-21 2.460E-21 7.192E-22 2.663E-23 0.000E+00 -ClNO3b 296 8.550E-20 2.441E-19 4.544E-19 8.114E-19 1.127E-18 1.205E-18 - 1.289E-18 1.339E-18 1.542E-19 2.023E-19 1.429E-19 1.840E-20 - 1.028E-20 6.210E-21 3.618E-21 1.031E-21 3.292E-23 0.000E+00 -Cl2 200 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.777E-21 2.162E-20 4.789E-20 8.147E-20 - 1.387E-19 1.880E-19 2.284E-19 2.549E-19 6.256E-20 6.399E-22 -Cl2 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 5.189E-21 2.557E-20 5.321E-20 8.674E-20 - 1.403E-19 1.849E-19 2.205E-19 2.436E-19 6.516E-20 6.748E-22 -HOCl 297 0.000E+00 0.000E+00 6.024E-21 5.363E-21 5.123E-20 5.423E-20 - 5.793E-20 6.702E-20 1.021E-19 6.538E-20 5.427E-20 5.567E-20 - 6.067E-20 5.957E-20 5.378E-20 3.123E-20 6.548E-21 1.195E-23 -HOCl 298 0.000E+00 0.000E+00 6.024E-21 5.363E-21 5.123E-20 5.423E-20 - 5.793E-20 6.702E-20 1.021E-19 6.538E-20 5.427E-20 5.567E-20 - 6.067E-20 5.957E-20 5.378E-20 3.123E-20 6.548E-21 1.195E-23 -OClO 204 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.590E-19 4.774E-19 7.317E-19 1.163E-18 - 1.806E-18 2.524E-18 3.061E-18 4.703E-18 3.328E-18 3.958E-20 -OClO 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.590E-19 4.774E-19 7.317E-19 1.163E-18 - 1.806E-18 2.524E-18 3.061E-18 4.703E-18 3.328E-18 3.958E-20 -Cl2O2 229 1.769E-18 3.509E-18 4.077E-18 4.468E-18 3.491E-18 2.731E-18 - 2.406E-18 2.210E-18 3.736E-18 1.901E-18 1.277E-18 9.342E-19 - 6.254E-19 4.338E-19 3.062E-19 1.569E-19 2.717E-20 1.598E-22 -Cl2O2 230 1.769E-18 3.509E-18 4.077E-18 4.468E-18 3.491E-18 2.731E-18 - 2.406E-18 2.210E-18 3.736E-18 1.901E-18 1.277E-18 9.342E-19 - 6.254E-19 4.338E-19 3.062E-19 1.569E-19 2.717E-20 1.598E-22 -ClO 297 0.000E+00 0.000E+00 1.700E-20 1.348E-20 1.942E-19 3.038E-19 - 3.488E-19 3.899E-19 4.613E-18 3.043E-18 1.697E-18 1.304E-18 - 4.511E-19 1.512E-19 5.199E-20 2.434E-21 0.000E+00 0.000E+00 -ClO 298 0.000E+00 0.000E+00 1.700E-20 1.348E-20 1.942E-19 3.038E-19 - 3.488E-19 3.899E-19 4.613E-18 3.043E-18 1.697E-18 1.304E-18 - 4.511E-19 1.512E-19 5.199E-20 2.434E-21 0.000E+00 0.000E+00 -BrO 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.867E-18 3.589E-18 4.195E-18 6.168E-18 6.416E-19 0.000E+00 -BrO 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 1.867E-18 3.589E-18 4.195E-18 6.168E-18 6.416E-19 0.000E+00 -BrNO3 230 0.000E+00 0.000E+00 4.706E-19 4.130E-19 4.049E-18 3.829E-18 - 3.342E-18 3.003E-18 5.340E-19 5.991E-19 4.493E-19 2.069E-19 - 1.739E-19 1.487E-19 1.264E-19 8.798E-20 3.698E-20 1.433E-21 -BrNO3 298 0.000E+00 0.000E+00 5.742E-19 5.079E-19 4.810E-18 4.201E-18 - 3.465E-18 3.015E-18 5.525E-19 5.955E-19 4.506E-19 2.094E-19 - 1.702E-19 1.421E-19 1.203E-19 8.624E-20 3.697E-20 1.435E-21 -HOBr 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 1.275E-19 2.011E-19 2.203E-19 2.198E-19 - 1.727E-19 1.369E-19 1.158E-19 1.125E-19 6.205E-20 2.760E-21 -HOBr 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 1.275E-19 2.011E-19 2.203E-19 2.198E-19 - 1.727E-19 1.369E-19 1.158E-19 1.125E-19 6.205E-20 2.760E-21 -BrCl 295 0.000E+00 0.000E+00 2.231E-21 1.793E-21 2.467E-20 3.703E-20 - 4.155E-20 4.525E-20 2.449E-20 1.885E-20 1.089E-20 6.209E-21 - 8.067E-21 1.270E-20 2.234E-20 1.002E-19 3.069E-19 2.079E-20 -BrCl 298 0.000E+00 0.000E+00 2.231E-21 1.793E-21 2.467E-20 3.703E-20 - 4.155E-20 4.525E-20 2.449E-20 1.885E-20 1.089E-20 6.209E-21 - 8.067E-21 1.270E-20 2.234E-20 1.002E-19 3.069E-19 2.079E-20 -N2O 200 1.065E-19 8.370E-20 6.860E-20 5.030E-20 2.101E-20 6.196E-21 - 3.137E-21 2.461E-21 3.187E-25 1.033E-23 4.192E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -N2O 300 1.212E-19 9.913E-20 8.348E-20 6.438E-20 3.032E-20 1.110E-20 - 6.355E-21 4.604E-21 1.450E-24 4.001E-23 1.193E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CFCl3 210 2.235E-18 1.654E-18 1.341E-18 9.895E-19 4.775E-19 1.726E-19 - 9.677E-20 6.948E-20 3.726E-23 5.742E-22 1.696E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CFCl3 298 2.235E-18 1.654E-18 1.341E-18 9.895E-19 4.896E-19 2.040E-19 - 1.270E-19 9.334E-20 9.773E-23 1.292E-21 2.965E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CF2Cl2 210 9.761E-19 5.212E-19 3.336E-19 1.523E-19 3.679E-20 5.682E-21 - 2.471E-21 5.890E-21 1.860E-25 6.426E-24 2.757E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CF2Cl2 298 1.011E-18 5.853E-19 4.027E-19 2.183E-19 6.318E-20 1.272E-20 - 5.987E-21 8.765E-21 8.059E-25 2.473E-23 8.297E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F113 210 9.497E-19 5.917E-19 4.254E-19 2.482E-19 7.456E-20 1.707E-20 - 8.903E-21 1.083E-20 3.433E-24 5.693E-23 1.547E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F113 295 9.511E-19 5.959E-19 4.337E-19 2.628E-19 9.316E-20 2.669E-20 - 1.447E-20 1.388E-20 6.622E-24 1.039E-22 2.672E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F114 210 1.201E-19 5.463E-20 3.371E-20 1.594E-20 4.529E-21 9.476E-22 - 4.520E-22 6.984E-22 4.735E-26 2.382E-24 6.853E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F114 298 1.207E-19 5.582E-20 3.519E-20 1.815E-20 5.996E-21 1.606E-21 - 8.457E-22 9.362E-22 1.184E-25 5.777E-24 1.539E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F115 210 6.875E-21 2.992E-21 1.894E-21 1.021E-21 3.543E-22 1.135E-22 - 6.099E-23 6.161E-23 0.000E+00 5.814E-25 1.349E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F115 298 6.875E-21 2.992E-21 1.894E-21 1.021E-21 3.543E-22 1.135E-22 - 6.099E-23 6.161E-23 0.000E+00 5.814E-25 1.349E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CCl4 210 3.700E-18 1.712E-18 1.123E-18 7.233E-19 6.126E-19 4.759E-19 - 3.782E-19 2.865E-19 6.520E-22 7.169E-21 1.329E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CCl4 298 3.700E-18 1.712E-18 1.124E-18 7.237E-19 6.261E-19 5.193E-19 - 4.361E-19 3.497E-19 1.542E-21 1.199E-20 1.823E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Cl 210 2.839E-19 1.304E-19 8.153E-20 3.963E-20 1.112E-20 2.169E-21 - 9.976E-22 1.660E-21 1.051E-25 4.276E-24 1.401E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Cl 298 2.842E-19 1.310E-19 8.252E-20 4.131E-20 1.284E-20 3.138E-21 - 1.607E-21 2.031E-21 2.284E-25 9.236E-24 2.797E-23 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3CCl3210 2.720E-18 2.022E-18 1.681E-18 1.340E-18 7.225E-19 3.107E-19 - 1.821E-19 1.241E-19 6.301E-23 1.516E-21 3.926E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3CCl3298 2.720E-18 2.022E-18 1.682E-18 1.340E-18 7.436E-19 3.535E-19 - 2.234E-19 1.564E-19 2.108E-22 2.590E-21 5.500E-21 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Cl2 295 1.001E-18 5.807E-19 3.980E-19 2.147E-19 7.135E-20 2.123E-20 - 1.194E-20 1.227E-20 7.550E-24 1.014E-22 2.360E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Cl2 298 1.001E-18 5.807E-19 3.980E-19 2.147E-19 7.135E-20 2.123E-20 - 1.194E-20 1.227E-20 7.550E-24 1.014E-22 2.360E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHF2Cl 210 7.494E-21 2.752E-21 1.541E-21 6.772E-22 1.908E-22 3.775E-23 - 1.836E-23 2.980E-23 0.000E+00 0.000E+00 2.072E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHF2Cl 298 7.508E-21 2.783E-21 1.580E-21 7.388E-22 2.371E-22 6.205E-23 - 3.498E-23 4.067E-23 0.000E+00 0.000E+00 5.984E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F123 210 9.477E-19 5.104E-19 3.413E-19 1.845E-19 6.084E-20 1.632E-20 - 8.820E-21 9.596E-21 4.462E-24 6.962E-23 1.708E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F123 295 1.036E-18 6.020E-19 4.220E-19 2.466E-19 8.890E-20 2.668E-20 - 1.501E-20 1.435E-20 1.189E-23 1.412E-22 3.164E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F141b 210 1.070E-18 7.020E-19 5.165E-19 3.064E-19 1.026E-19 2.588E-20 - 1.298E-20 1.430E-20 2.940E-24 6.901E-23 2.167E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F141b 298 1.126E-18 7.473E-19 5.560E-19 3.445E-19 1.219E-19 3.311E-20 - 1.749E-20 1.724E-20 4.901E-24 1.135E-22 3.115E-22 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F142b 210 2.300E-20 8.701E-21 4.892E-21 2.158E-21 6.225E-22 1.325E-22 - 6.412E-23 9.552E-23 0.000E+00 1.808E-25 8.567E-25 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -F142b 298 2.842E-20 1.175E-20 6.994E-21 3.378E-21 1.063E-21 2.568E-22 - 1.309E-22 1.599E-22 0.000E+00 4.680E-25 1.974E-24 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Br 210 1.088E-18 5.032E-19 5.880E-19 6.974E-19 7.649E-19 6.880E-19 - 6.102E-19 5.213E-19 6.091E-21 3.141E-20 3.384E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH3Br 296 1.088E-18 5.032E-19 5.880E-19 6.974E-19 7.710E-19 7.004E-19 - 6.238E-19 5.365E-19 7.709E-21 3.416E-20 3.537E-20 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H1211 210 5.525E-19 6.381E-19 7.586E-19 9.286E-19 1.221E-18 1.287E-18 - 1.221E-18 1.107E-18 2.880E-20 8.647E-20 7.900E-20 2.574E-23 - 6.500E-24 2.067E-24 7.281E-25 6.002E-28 0.000E+00 0.000E+00 -H1211 298 5.083E-19 5.769E-19 6.841E-19 8.288E-19 1.109E-18 1.171E-18 - 1.110E-18 1.002E-18 3.538E-20 8.341E-20 7.245E-20 1.035E-22 - 2.614E-23 8.312E-24 2.928E-24 2.414E-27 0.000E+00 0.000E+00 -H1301 210 6.008E-20 8.104E-20 9.353E-20 1.082E-19 1.320E-19 1.358E-19 - 1.256E-19 1.096E-19 7.435E-22 5.808E-21 7.096E-21 1.158E-25 - 7.298E-27 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H1301 298 5.456E-20 7.322E-20 8.413E-20 9.672E-20 1.181E-19 1.235E-19 - 1.170E-19 1.049E-19 1.371E-21 6.950E-21 7.252E-21 3.859E-25 - 2.432E-26 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -H2402 210 1.120E-18 1.230E-18 1.268E-18 1.303E-18 1.288E-18 1.169E-18 - 1.064E-18 9.203E-19 2.046E-20 7.238E-20 6.550E-20 1.609E-23 - 4.515E-24 1.715E-24 8.065E-25 8.505E-28 0.000E+00 0.000E+00 -H2402 298 1.023E-18 1.133E-18 1.175E-18 1.220E-18 1.211E-18 1.098E-18 - 1.004E-18 8.982E-19 2.561E-20 7.202E-20 6.334E-20 4.022E-23 - 1.129E-23 4.288E-24 2.016E-24 2.126E-27 0.000E+00 0.000E+00 -CH2Br2 210 1.959E-18 1.953E-18 2.050E-18 2.218E-18 2.152E-18 2.272E-18 - 2.588E-18 3.086E-18 1.541E-19 4.674E-19 3.038E-19 7.403E-23 - 4.852E-24 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CH2Br2 298 1.985E-18 1.979E-18 2.078E-18 2.248E-18 2.209E-18 2.274E-18 - 2.409E-18 2.573E-18 1.722E-19 3.733E-19 2.365E-19 2.590E-22 - 2.022E-23 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -CHBr3 210 5.582E-18 4.311E-18 4.041E-18 3.938E-18 4.623E-18 4.751E-18 - 5.084E-18 5.538E-18 7.770E-19 9.248E-19 5.607E-19 7.371E-21 - 1.884E-21 5.808E-22 2.106E-22 2.441E-23 2.035E-25 0.000E+00 -CHBr3 296 5.645E-18 4.311E-18 3.957E-18 3.752E-18 4.281E-18 4.543E-18 - 4.825E-18 5.242E-18 8.941E-19 9.054E-19 5.341E-19 1.628E-20 - 4.870E-21 1.707E-21 7.074E-22 9.311E-23 9.691E-25 0.000E+00 -CH3I 210 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 3.728E-20 4.774E-20 8.199E-19 2.010E-19 6.431E-20 2.781E-20 - 8.253E-21 3.557E-21 1.826E-21 3.437E-22 2.347E-24 0.000E+00 -CH3I 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 3.728E-20 4.774E-20 8.383E-19 2.430E-19 9.306E-20 4.648E-20 - 1.511E-20 6.466E-21 3.293E-21 6.699E-22 9.781E-24 0.000E+00 -CF3I 210 7.810E-21 3.897E-21 2.406E-21 1.654E-21 1.770E-21 2.843E-21 - 4.166E-21 6.218E-21 5.767E-19 3.647E-19 2.023E-19 1.225E-19 - 4.277E-20 1.644E-20 7.396E-21 1.169E-21 1.219E-23 0.000E+00 -CF3I 300 7.810E-21 3.897E-21 2.406E-21 1.654E-21 1.770E-21 2.843E-21 - 4.166E-21 6.218E-21 5.173E-19 3.550E-19 2.274E-19 1.541E-19 - 6.499E-20 2.943E-20 1.453E-20 2.580E-21 3.848E-23 0.000E+00 -OCS 225 2.886E-20 2.996E-20 2.915E-20 2.338E-20 6.033E-20 1.226E-19 - 1.688E-19 2.184E-19 1.003E-20 4.131E-20 2.415E-20 9.441E-25 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -OCS 295 4.075E-20 4.032E-20 3.634E-20 2.433E-20 5.993E-20 1.216E-19 - 1.685E-19 2.189E-19 1.389E-20 4.620E-20 2.468E-20 3.027E-24 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -PAN 250 2.687E-19 7.661E-19 1.399E-18 2.529E-18 2.977E-18 2.201E-18 - 1.765E-18 1.322E-18 6.565E-20 9.407E-20 8.486E-20 2.438E-21 - 9.252E-22 4.355E-22 2.288E-22 5.480E-23 6.941E-25 0.000E+00 -PAN 298 2.951E-19 8.392E-19 1.520E-18 2.757E-18 3.144E-18 2.279E-18 - 1.834E-18 1.385E-18 7.911E-20 1.056E-19 9.185E-20 3.555E-21 - 1.399E-21 6.750E-22 3.627E-22 9.257E-23 1.265E-24 0.000E+00 -CH3NO3 240 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.337E-20 1.004E-20 6.638E-21 4.679E-21 - 2.022E-21 9.381E-22 3.730E-22 3.755E-23 0.000E+00 0.000E+00 -CH3NO3 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.788E-20 1.233E-20 8.359E-21 6.029E-21 - 2.735E-21 1.346E-21 5.734E-22 6.957E-23 0.000E+00 0.000E+00 -ActAld 297 0.000E+00 0.000E+00 2.422E-23 0.000E+00 3.974E-22 5.086E-22 - 4.875E-22 4.794E-22 1.893E-20 2.310E-20 2.384E-20 2.161E-20 - 1.460E-20 8.410E-21 3.335E-21 1.751E-22 0.000E+00 0.000E+00 -ActAld 298 0.000E+00 0.000E+00 2.422E-23 0.000E+00 3.974E-22 5.086E-22 - 4.875E-22 4.794E-22 1.893E-20 2.310E-20 2.384E-20 2.161E-20 - 1.460E-20 8.410E-21 3.335E-21 1.751E-22 0.000E+00 0.000E+00 -MeVK 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 8.241E-22 2.211E-21 3.811E-21 5.521E-21 - 7.955E-21 8.828E-21 7.236E-21 3.374E-21 1.790E-22 0.000E+00 -MeVK 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 8.241E-22 2.211E-21 3.811E-21 5.521E-21 - 7.955E-21 8.828E-21 7.236E-21 3.374E-21 1.790E-22 0.000E+00 -MeAcr 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.398E-23 7.595E-23 1.398E-22 2.107E-22 - 3.151E-22 3.995E-22 4.742E-22 5.222E-22 1.064E-22 0.000E+00 -MeAcr 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 2.398E-23 7.595E-23 1.398E-22 2.107E-22 - 3.151E-22 3.995E-22 4.742E-22 5.222E-22 1.064E-22 0.000E+00 -GlyAld 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.443E-20 1.829E-19 - 1.143E-19 6.872E-20 3.025E-20 3.387E-20 3.392E-20 2.784E-20 - 1.706E-20 9.411E-21 4.388E-21 4.937E-22 0.000E+00 0.000E+00 -GlyAld 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 8.443E-20 1.829E-19 - 1.143E-19 6.872E-20 3.025E-20 3.387E-20 3.392E-20 2.784E-20 - 1.706E-20 9.411E-21 4.388E-21 4.937E-22 0.000E+00 0.000E+00 -MEKeto 297 0.000E+00 0.000E+00 5.903E-22 0.000E+00 5.952E-21 1.749E-21 - 1.668E-21 1.837E-21 4.246E-20 4.757E-20 4.604E-20 4.170E-20 - 2.684E-20 1.570E-20 7.721E-21 8.142E-22 3.734E-25 0.000E+00 -MEKeto 298 0.000E+00 0.000E+00 5.903E-22 0.000E+00 5.952E-21 1.749E-21 - 1.668E-21 1.837E-21 4.246E-20 4.757E-20 4.604E-20 4.170E-20 - 2.684E-20 1.570E-20 7.721E-21 8.142E-22 3.734E-25 0.000E+00 -EAld 297 0.000E+00 0.000E+00 2.124E-23 0.000E+00 3.576E-22 5.328E-22 - 6.036E-22 6.848E-22 2.982E-20 4.517E-20 5.121E-20 5.548E-20 - 4.630E-20 3.578E-20 2.441E-20 5.853E-21 1.257E-23 0.000E+00 -EAld 298 0.000E+00 0.000E+00 2.124E-23 0.000E+00 3.576E-22 5.328E-22 - 6.036E-22 6.848E-22 2.982E-20 4.517E-20 5.121E-20 5.548E-20 - 4.630E-20 3.578E-20 2.441E-20 5.853E-21 1.257E-23 0.000E+00 -MGlyxl 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.483E-20 4.131E-20 4.375E-20 4.384E-20 - 3.465E-20 2.428E-20 1.788E-20 6.194E-21 2.237E-20 1.435E-21 -MGlyxl 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.483E-20 4.131E-20 4.375E-20 4.384E-20 - 3.465E-20 2.428E-20 1.788E-20 6.194E-21 2.237E-20 1.435E-21 -Glyxla 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 6.833E-21 1.009E-20 1.174E-20 1.333E-20 - 1.238E-20 1.117E-20 8.335E-21 2.625E-21 0.000E+00 0.000E+00 -Glyxla 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 6.833E-21 1.009E-20 1.174E-20 1.333E-20 - 1.238E-20 1.117E-20 8.335E-21 2.625E-21 0.000E+00 0.000E+00 -Glyxlb 297 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 5.914E-22 2.199E-22 -Glyxlb 298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 5.914E-22 2.199E-22 -XXXX 299 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -XXXX 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -C3H6O 220 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.819E-20 3.809E-20 3.492E-20 3.100E-20 - 1.944E-20 1.088E-20 5.532E-21 4.637E-22 3.425E-25 0.000E+00 -C3H6O 300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 3.851E-20 4.004E-20 3.775E-20 3.439E-20 - 2.255E-20 1.356E-20 7.273E-21 8.481E-22 6.682E-25 0.000E+00 -Q2-Acet240 3.000E-02 3.000E-02 3.000E-02 3.000E-02 3.000E-02 3.000E-02 - 3.000E-02 3.000E-02 3.000E-02 2.380E-02 1.144E-02 5.156E-03 - 1.931E-03 8.022E-04 4.144E-04 4.156E-05 0.000E+00 0.000E+00 -Q2-Acet300 2.000E-01 2.000E-01 2.000E-01 2.000E-01 2.000E-01 2.000E-01 - 2.000E-01 2.000E-01 2.000E-01 1.790E-01 1.250E-01 8.564E-02 - 5.100E-02 3.298E-02 2.214E-02 3.533E-03 0.000E+00 0.000E+00 -Q1A-Ace240 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.207E+00 4.133E+00 2.498E+01 9.452E+01 1.000E+02 1.000E+02 -Q1A-Ace300 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 - 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.000E+00 1.006E+00 - 1.223E+00 2.411E+00 6.656E+00 1.969E+01 2.100E+01 2.100E+01 -Q1B-Ace240 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 2.447E-02 1.841E-01 1.028E+00 - 1.066E+01 5.202E+01 2.632E+02 2.760E+03 3.210E+03 3.210E+03 -Q1B-Ace300 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 4.987E-02 2.454E-01 8.792E-01 - 4.897E+00 1.617E+01 5.268E+01 3.023E+02 3.420E+02 3.420E+02 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.in b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.in deleted file mode 100644 index 0102a040..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.in +++ /dev/null @@ -1,4465 +0,0 @@ -NO2-IUPAC IUPAC 4463 220.0 298.0 /total #/T1/T2 -WN ACS(T1) ACS(T2) -11730 0.00000E+00 0.00000E+00 -11740 0.00000E+00 0.00000E+00 -11750 0.00000E+00 0.00000E+00 -11760 0.00000E+00 0.00000E+00 -11770 0.00000E+00 0.00000E+00 -11780 0.00000E+00 0.00000E+00 -11790 0.00000E+00 0.00000E+00 -11800 0.00000E+00 0.00000E+00 -11810 0.00000E+00 0.00000E+00 -11820 0.00000E+00 0.00000E+00 -11830 0.00000E+00 0.00000E+00 -11840 0.00000E+00 0.00000E+00 -11850 0.00000E+00 0.00000E+00 -11860 0.00000E+00 0.00000E+00 -11870 0.00000E+00 0.00000E+00 -11880 0.00000E+00 0.00000E+00 -11890 0.00000E+00 0.00000E+00 -11900 0.00000E+00 0.00000E+00 -11910 0.00000E+00 0.00000E+00 -11920 0.00000E+00 0.00000E+00 -11930 0.00000E+00 0.00000E+00 -11940 0.00000E+00 0.00000E+00 -11950 0.00000E+00 0.00000E+00 -11960 0.00000E+00 0.00000E+00 -11970 0.00000E+00 0.00000E+00 -11980 0.00000E+00 0.00000E+00 -11990 0.00000E+00 0.00000E+00 -12000 0.00000E+00 0.00000E+00 -12010 0.00000E+00 0.00000E+00 -12020 0.00000E+00 0.00000E+00 -12030 0.00000E+00 0.00000E+00 -12040 0.00000E+00 0.00000E+00 -12050 0.00000E+00 0.00000E+00 -12060 0.00000E+00 0.00000E+00 -12070 0.00000E+00 0.00000E+00 -12080 0.00000E+00 0.00000E+00 -12090 0.00000E+00 0.00000E+00 -12100 0.00000E+00 0.00000E+00 -12110 0.00000E+00 0.00000E+00 -12120 0.00000E+00 0.00000E+00 -12130 0.00000E+00 0.00000E+00 -12140 0.00000E+00 0.00000E+00 -12150 0.00000E+00 0.00000E+00 -12160 0.00000E+00 0.00000E+00 -12170 0.00000E+00 0.00000E+00 -12180 0.00000E+00 0.00000E+00 -12190 0.00000E+00 0.00000E+00 -12200 0.00000E+00 0.00000E+00 -12210 0.00000E+00 0.00000E+00 -12220 0.00000E+00 0.00000E+00 -12230 0.00000E+00 0.00000E+00 -12240 0.00000E+00 0.00000E+00 -12250 0.00000E+00 0.00000E+00 -12260 0.00000E+00 0.00000E+00 -12270 0.00000E+00 0.00000E+00 -12280 0.00000E+00 0.00000E+00 -12290 0.00000E+00 0.00000E+00 -12300 0.00000E+00 0.00000E+00 -12310 0.00000E+00 0.00000E+00 -12320 0.00000E+00 0.00000E+00 -12330 0.00000E+00 0.00000E+00 -12340 0.00000E+00 0.00000E+00 -12350 0.00000E+00 0.00000E+00 -12360 0.00000E+00 0.00000E+00 -12370 0.00000E+00 0.00000E+00 -12380 0.00000E+00 0.00000E+00 -12390 0.00000E+00 0.00000E+00 -12400 0.00000E+00 0.00000E+00 -12410 0.00000E+00 0.00000E+00 -12420 0.00000E+00 0.00000E+00 -12430 0.00000E+00 0.00000E+00 -12440 0.00000E+00 0.00000E+00 -12450 0.00000E+00 0.00000E+00 -12460 0.00000E+00 0.00000E+00 -12470 0.00000E+00 0.00000E+00 -12480 0.00000E+00 0.00000E+00 -12490 0.00000E+00 0.00000E+00 -12500 0.00000E+00 0.00000E+00 -12510 0.00000E+00 0.00000E+00 -12520 0.00000E+00 0.00000E+00 -12530 0.00000E+00 0.00000E+00 -12540 0.00000E+00 0.00000E+00 -12550 0.00000E+00 0.00000E+00 -12560 0.00000E+00 0.00000E+00 -12570 0.00000E+00 0.00000E+00 -12580 0.00000E+00 0.00000E+00 -12590 0.00000E+00 0.00000E+00 -12600 0.00000E+00 0.00000E+00 -12610 0.00000E+00 0.00000E+00 -12620 0.00000E+00 0.00000E+00 -12630 0.00000E+00 0.00000E+00 -12640 0.00000E+00 0.00000E+00 -12650 0.00000E+00 0.00000E+00 -12660 0.00000E+00 0.00000E+00 -12670 0.00000E+00 0.00000E+00 -12680 0.00000E+00 0.00000E+00 -12690 0.00000E+00 0.00000E+00 -12700 0.00000E+00 0.00000E+00 -12710 0.00000E+00 0.00000E+00 -12720 0.00000E+00 0.00000E+00 -12730 0.00000E+00 0.00000E+00 -12740 0.00000E+00 0.00000E+00 -12750 0.00000E+00 0.00000E+00 -12760 0.00000E+00 0.00000E+00 -12770 0.00000E+00 0.00000E+00 -12780 0.00000E+00 0.00000E+00 -12790 0.00000E+00 0.00000E+00 -12800 0.00000E+00 0.00000E+00 -12810 0.00000E+00 0.00000E+00 -12820 0.00000E+00 0.00000E+00 -12830 0.00000E+00 0.00000E+00 -12840 0.00000E+00 0.00000E+00 -12850 0.00000E+00 0.00000E+00 -12860 0.00000E+00 0.00000E+00 -12870 0.00000E+00 0.00000E+00 -12880 0.00000E+00 0.00000E+00 -12890 0.00000E+00 0.00000E+00 -12900 0.00000E+00 0.00000E+00 -12910 0.00000E+00 0.00000E+00 -12920 0.00000E+00 0.00000E+00 -12930 0.00000E+00 0.00000E+00 -12940 0.00000E+00 0.00000E+00 -12950 0.00000E+00 0.00000E+00 -12960 0.00000E+00 0.00000E+00 -12970 0.00000E+00 0.00000E+00 -12980 0.00000E+00 0.00000E+00 -12990 0.00000E+00 0.00000E+00 -13000 0.00000E+00 0.00000E+00 -13010 0.00000E+00 0.00000E+00 -13020 0.00000E+00 0.00000E+00 -13030 0.00000E+00 0.00000E+00 -13040 0.00000E+00 0.00000E+00 -13050 0.00000E+00 0.00000E+00 -13060 0.00000E+00 0.00000E+00 -13070 0.00000E+00 0.00000E+00 -13080 0.00000E+00 0.00000E+00 -13090 0.00000E+00 0.00000E+00 -13100 0.00000E+00 0.00000E+00 -13110 0.00000E+00 0.00000E+00 -13120 0.00000E+00 0.00000E+00 -13130 0.00000E+00 0.00000E+00 -13140 0.00000E+00 0.00000E+00 -13150 0.00000E+00 0.00000E+00 -13160 0.00000E+00 0.00000E+00 -13170 0.00000E+00 0.00000E+00 -13180 0.00000E+00 0.00000E+00 -13190 0.00000E+00 0.00000E+00 -13200 0.00000E+00 0.00000E+00 -13210 0.00000E+00 0.00000E+00 -13220 0.00000E+00 0.00000E+00 -13230 0.00000E+00 0.00000E+00 -13240 0.00000E+00 0.00000E+00 -13250 0.00000E+00 0.00000E+00 -13260 0.00000E+00 0.00000E+00 -13270 0.00000E+00 0.00000E+00 -13280 0.00000E+00 0.00000E+00 -13290 0.00000E+00 0.00000E+00 -13300 0.00000E+00 0.00000E+00 -13310 0.00000E+00 0.00000E+00 -13320 0.00000E+00 0.00000E+00 -13330 0.00000E+00 0.00000E+00 -13340 0.00000E+00 0.00000E+00 -13350 0.00000E+00 0.00000E+00 -13360 0.00000E+00 0.00000E+00 -13370 0.00000E+00 0.00000E+00 -13380 0.00000E+00 0.00000E+00 -13390 0.00000E+00 0.00000E+00 -13400 0.00000E+00 0.00000E+00 -13410 0.00000E+00 0.00000E+00 -13420 0.00000E+00 0.00000E+00 -13430 0.00000E+00 0.00000E+00 -13440 0.00000E+00 0.00000E+00 -13450 0.00000E+00 0.00000E+00 -13460 0.00000E+00 0.00000E+00 -13470 0.00000E+00 0.00000E+00 -13480 0.00000E+00 0.00000E+00 -13490 0.00000E+00 0.00000E+00 -13500 0.00000E+00 0.00000E+00 -13510 0.00000E+00 0.00000E+00 -13520 0.00000E+00 0.00000E+00 -13530 0.00000E+00 0.00000E+00 -13540 0.00000E+00 0.00000E+00 -13550 0.00000E+00 0.00000E+00 -13560 0.00000E+00 0.00000E+00 -13570 0.00000E+00 0.00000E+00 -13580 0.00000E+00 0.00000E+00 -13590 0.00000E+00 0.00000E+00 -13600 0.00000E+00 0.00000E+00 -13610 0.00000E+00 0.00000E+00 -13620 0.00000E+00 0.00000E+00 -13630 0.00000E+00 0.00000E+00 -13640 0.00000E+00 0.00000E+00 -13650 0.00000E+00 0.00000E+00 -13660 0.00000E+00 0.00000E+00 -13670 0.00000E+00 0.00000E+00 -13680 0.00000E+00 0.00000E+00 -13690 0.00000E+00 0.00000E+00 -13700 0.00000E+00 0.00000E+00 -13710 0.00000E+00 0.00000E+00 -13720 0.00000E+00 0.00000E+00 -13730 0.00000E+00 0.00000E+00 -13740 0.00000E+00 0.00000E+00 -13750 0.00000E+00 0.00000E+00 -13760 0.00000E+00 0.00000E+00 -13770 0.00000E+00 0.00000E+00 -13780 0.00000E+00 0.00000E+00 -13790 0.00000E+00 0.00000E+00 -13800 0.00000E+00 0.00000E+00 -13810 0.00000E+00 0.00000E+00 -13820 0.00000E+00 0.00000E+00 -13830 0.00000E+00 0.00000E+00 -13840 0.00000E+00 0.00000E+00 -13850 0.00000E+00 0.00000E+00 -13860 0.00000E+00 0.00000E+00 -13870 0.00000E+00 0.00000E+00 -13880 0.00000E+00 0.00000E+00 -13890 0.00000E+00 0.00000E+00 -13900 0.00000E+00 0.00000E+00 -13910 0.00000E+00 0.00000E+00 -13920 0.00000E+00 0.00000E+00 -13930 0.00000E+00 0.00000E+00 -13940 0.00000E+00 0.00000E+00 -13950 0.00000E+00 0.00000E+00 -13960 0.00000E+00 0.00000E+00 -13970 0.00000E+00 0.00000E+00 -13980 0.00000E+00 0.00000E+00 -13990 0.00000E+00 0.00000E+00 -14000 0.00000E+00 0.00000E+00 -14010 0.00000E+00 0.00000E+00 -14020 0.00000E+00 0.00000E+00 -14030 0.00000E+00 0.00000E+00 -14040 0.00000E+00 0.00000E+00 -14050 0.00000E+00 0.00000E+00 -14060 0.00000E+00 0.00000E+00 -14070 0.00000E+00 0.00000E+00 -14080 0.00000E+00 0.00000E+00 -14090 0.00000E+00 0.00000E+00 -14100 0.00000E+00 0.00000E+00 -14110 0.00000E+00 0.00000E+00 -14120 0.00000E+00 0.00000E+00 -14130 0.00000E+00 0.00000E+00 -14140 0.00000E+00 0.00000E+00 -14150 0.00000E+00 0.00000E+00 -14160 0.00000E+00 0.00000E+00 -14170 0.00000E+00 0.00000E+00 -14180 0.00000E+00 0.00000E+00 -14190 0.00000E+00 0.00000E+00 -14200 0.00000E+00 0.00000E+00 -14210 0.00000E+00 0.00000E+00 -14220 0.00000E+00 0.00000E+00 -14230 0.00000E+00 0.00000E+00 -14240 0.00000E+00 0.00000E+00 -14250 0.00000E+00 0.00000E+00 -14260 0.00000E+00 0.00000E+00 -14270 0.00000E+00 0.00000E+00 -14280 0.00000E+00 0.00000E+00 -14290 0.00000E+00 0.00000E+00 -14300 0.00000E+00 0.00000E+00 -14310 0.00000E+00 0.00000E+00 -14320 0.00000E+00 0.00000E+00 -14330 0.00000E+00 0.00000E+00 -14340 0.00000E+00 0.00000E+00 -14350 0.00000E+00 0.00000E+00 -14360 0.00000E+00 0.00000E+00 -14370 0.00000E+00 0.00000E+00 -14380 0.00000E+00 0.00000E+00 -14390 0.00000E+00 0.00000E+00 -14400 0.00000E+00 0.00000E+00 -14410 0.00000E+00 0.00000E+00 -14420 0.00000E+00 0.00000E+00 -14430 0.00000E+00 0.00000E+00 -14440 0.00000E+00 0.00000E+00 -14450 0.00000E+00 0.00000E+00 -14460 0.00000E+00 0.00000E+00 -14470 0.00000E+00 0.00000E+00 -14480 0.00000E+00 0.00000E+00 -14490 0.00000E+00 0.00000E+00 -14500 0.00000E+00 0.00000E+00 -14510 0.00000E+00 0.00000E+00 -14520 0.00000E+00 0.00000E+00 -14530 0.00000E+00 0.00000E+00 -14540 0.00000E+00 0.00000E+00 -14550 0.00000E+00 0.00000E+00 -14560 0.00000E+00 0.00000E+00 -14570 0.00000E+00 0.00000E+00 -14580 0.00000E+00 0.00000E+00 -14590 0.00000E+00 0.00000E+00 -14600 0.00000E+00 0.00000E+00 -14610 0.00000E+00 0.00000E+00 -14620 0.00000E+00 0.00000E+00 -14630 0.00000E+00 0.00000E+00 -14640 0.00000E+00 0.00000E+00 -14650 0.00000E+00 0.00000E+00 -14660 0.00000E+00 0.00000E+00 -14670 0.00000E+00 0.00000E+00 -14680 0.00000E+00 0.00000E+00 -14690 0.00000E+00 0.00000E+00 -14700 0.00000E+00 0.00000E+00 -14710 0.00000E+00 0.00000E+00 -14720 0.00000E+00 0.00000E+00 -14730 0.00000E+00 0.00000E+00 -14740 0.00000E+00 0.00000E+00 -14750 0.00000E+00 0.00000E+00 -14760 0.00000E+00 0.00000E+00 -14770 0.00000E+00 0.00000E+00 -14780 0.00000E+00 0.00000E+00 -14790 0.00000E+00 0.00000E+00 -14800 0.00000E+00 0.00000E+00 -14810 0.00000E+00 0.00000E+00 -14820 0.00000E+00 0.00000E+00 -14830 0.00000E+00 0.00000E+00 -14840 0.00000E+00 0.00000E+00 -14850 0.00000E+00 0.00000E+00 -14860 0.00000E+00 0.00000E+00 -14870 0.00000E+00 0.00000E+00 -14880 0.00000E+00 0.00000E+00 -14890 0.00000E+00 0.00000E+00 -14900 0.00000E+00 0.00000E+00 -14910 0.00000E+00 0.00000E+00 -14920 0.00000E+00 0.00000E+00 -14930 0.00000E+00 0.00000E+00 -14940 0.00000E+00 0.00000E+00 -14950 0.00000E+00 0.00000E+00 -14960 0.00000E+00 0.00000E+00 -14970 0.00000E+00 0.00000E+00 -14980 0.00000E+00 0.00000E+00 -14990 0.00000E+00 0.00000E+00 -15000 0.00000E+00 0.00000E+00 -15010 0.00000E+00 0.00000E+00 -15020 0.00000E+00 0.00000E+00 -15030 0.00000E+00 0.00000E+00 -15040 0.00000E+00 0.00000E+00 -15050 0.00000E+00 0.00000E+00 -15060 0.00000E+00 0.00000E+00 -15070 0.00000E+00 0.00000E+00 -15080 0.00000E+00 0.00000E+00 -15090 0.00000E+00 0.00000E+00 -15100 0.00000E+00 0.00000E+00 -15110 0.00000E+00 0.00000E+00 -15120 0.00000E+00 0.00000E+00 -15130 0.00000E+00 0.00000E+00 -15140 0.00000E+00 0.00000E+00 -15150 0.00000E+00 0.00000E+00 -15160 0.00000E+00 0.00000E+00 -15170 0.00000E+00 0.00000E+00 -15180 0.00000E+00 0.00000E+00 -15190 0.00000E+00 0.00000E+00 -15200 0.00000E+00 0.00000E+00 -15210 0.00000E+00 0.00000E+00 -15220 0.00000E+00 0.00000E+00 -15230 0.00000E+00 0.00000E+00 -15240 0.00000E+00 0.00000E+00 -15250 0.00000E+00 0.00000E+00 -15260 0.00000E+00 0.00000E+00 -15270 0.00000E+00 0.00000E+00 -15280 0.00000E+00 0.00000E+00 -15290 0.00000E+00 0.00000E+00 -15300 0.00000E+00 0.00000E+00 -15310 0.00000E+00 0.00000E+00 -15320 0.00000E+00 0.00000E+00 -15330 0.00000E+00 0.00000E+00 -15340 0.00000E+00 0.00000E+00 -15350 0.00000E+00 0.00000E+00 -15360 0.00000E+00 0.00000E+00 -15370 0.00000E+00 0.00000E+00 -15380 0.00000E+00 0.00000E+00 -15390 0.00000E+00 0.00000E+00 -15400 0.00000E+00 0.00000E+00 -15410 0.00000E+00 0.00000E+00 -15420 0.00000E+00 0.00000E+00 -15430 0.00000E+00 0.00000E+00 -15440 0.00000E+00 0.00000E+00 -15450 0.00000E+00 0.00000E+00 -15460 0.00000E+00 0.00000E+00 -15470 0.00000E+00 0.00000E+00 -15480 0.00000E+00 0.00000E+00 -15490 0.00000E+00 0.00000E+00 -15500 0.00000E+00 0.00000E+00 -15510 0.00000E+00 0.00000E+00 -15520 0.00000E+00 0.00000E+00 -15530 0.00000E+00 0.00000E+00 -15540 0.00000E+00 0.00000E+00 -15550 0.00000E+00 0.00000E+00 -15560 0.00000E+00 0.00000E+00 -15570 0.00000E+00 0.00000E+00 -15580 0.00000E+00 0.00000E+00 -15590 0.00000E+00 0.00000E+00 -15600 0.00000E+00 0.00000E+00 -15610 0.00000E+00 0.00000E+00 -15620 0.00000E+00 0.00000E+00 -15630 0.00000E+00 0.00000E+00 -15640 0.00000E+00 0.00000E+00 -15650 0.00000E+00 0.00000E+00 -15660 0.00000E+00 0.00000E+00 -15670 0.00000E+00 0.00000E+00 -15680 0.00000E+00 0.00000E+00 -15690 0.00000E+00 0.00000E+00 -15700 0.00000E+00 0.00000E+00 -15710 0.00000E+00 0.00000E+00 -15720 0.00000E+00 0.00000E+00 -15730 0.00000E+00 0.00000E+00 -15740 0.00000E+00 0.00000E+00 -15750 0.00000E+00 0.00000E+00 -15760 0.00000E+00 0.00000E+00 -15770 0.00000E+00 0.00000E+00 -15780 0.00000E+00 0.00000E+00 -15790 0.00000E+00 0.00000E+00 -15800 0.00000E+00 0.00000E+00 -15810 0.00000E+00 0.00000E+00 -15820 0.00000E+00 0.00000E+00 -15830 0.00000E+00 0.00000E+00 -15840 0.00000E+00 0.00000E+00 -15850 0.00000E+00 0.00000E+00 -15860 0.00000E+00 0.00000E+00 -15870 0.00000E+00 0.00000E+00 -15880 0.00000E+00 0.00000E+00 -15890 0.00000E+00 0.00000E+00 -15900 0.00000E+00 0.00000E+00 -15910 0.00000E+00 0.00000E+00 -15920 0.00000E+00 0.00000E+00 -15930 0.00000E+00 0.00000E+00 -15940 0.00000E+00 0.00000E+00 -15950 0.00000E+00 0.00000E+00 -15960 0.00000E+00 0.00000E+00 -15970 0.00000E+00 0.00000E+00 -15980 0.00000E+00 0.00000E+00 -15990 0.00000E+00 0.00000E+00 -16000 0.00000E+00 0.00000E+00 -16010 0.00000E+00 0.00000E+00 -16020 0.00000E+00 0.00000E+00 -16030 0.00000E+00 0.00000E+00 -16040 0.00000E+00 0.00000E+00 -16050 0.00000E+00 0.00000E+00 -16060 0.00000E+00 0.00000E+00 -16070 0.00000E+00 0.00000E+00 -16080 0.00000E+00 0.00000E+00 -16090 0.00000E+00 0.00000E+00 -16100 0.00000E+00 0.00000E+00 -16110 0.00000E+00 0.00000E+00 -16120 0.00000E+00 0.00000E+00 -16130 0.00000E+00 0.00000E+00 -16140 0.00000E+00 0.00000E+00 -16150 0.00000E+00 0.00000E+00 -16160 0.00000E+00 0.00000E+00 -16170 0.00000E+00 0.00000E+00 -16180 0.00000E+00 0.00000E+00 -16190 0.00000E+00 0.00000E+00 -16200 0.00000E+00 0.00000E+00 -16210 0.00000E+00 0.00000E+00 -16220 0.00000E+00 0.00000E+00 -16230 0.00000E+00 0.00000E+00 -16240 0.00000E+00 0.00000E+00 -16250 0.00000E+00 0.00000E+00 -16260 0.00000E+00 0.00000E+00 -16270 0.00000E+00 0.00000E+00 -16280 0.00000E+00 0.00000E+00 -16290 0.00000E+00 0.00000E+00 -16300 0.00000E+00 0.00000E+00 -16310 0.00000E+00 0.00000E+00 -16320 0.00000E+00 0.00000E+00 -16330 0.00000E+00 0.00000E+00 -16340 0.00000E+00 0.00000E+00 -16350 0.00000E+00 0.00000E+00 -16360 0.00000E+00 0.00000E+00 -16370 0.00000E+00 0.00000E+00 -16380 0.00000E+00 0.00000E+00 -16390 0.00000E+00 0.00000E+00 -16400 0.00000E+00 0.00000E+00 -16410 0.00000E+00 0.00000E+00 -16420 0.00000E+00 0.00000E+00 -16430 0.00000E+00 0.00000E+00 -16440 0.00000E+00 0.00000E+00 -16450 0.00000E+00 0.00000E+00 -16460 0.00000E+00 0.00000E+00 -16470 0.00000E+00 0.00000E+00 -16480 0.00000E+00 0.00000E+00 -16490 0.00000E+00 0.00000E+00 -16500 0.00000E+00 0.00000E+00 -16510 0.00000E+00 0.00000E+00 -16520 0.00000E+00 0.00000E+00 -16530 0.00000E+00 0.00000E+00 -16540 0.00000E+00 0.00000E+00 -16550 0.00000E+00 0.00000E+00 -16560 0.00000E+00 0.00000E+00 -16570 0.00000E+00 0.00000E+00 -16580 0.00000E+00 0.00000E+00 -16590 0.00000E+00 0.00000E+00 -16600 0.00000E+00 0.00000E+00 -16610 0.00000E+00 0.00000E+00 -16620 0.00000E+00 0.00000E+00 -16630 0.00000E+00 0.00000E+00 -16640 0.00000E+00 0.00000E+00 -16650 0.00000E+00 0.00000E+00 -16660 0.00000E+00 0.00000E+00 -16670 0.00000E+00 0.00000E+00 -16680 0.00000E+00 0.00000E+00 -16690 0.00000E+00 0.00000E+00 -16700 0.00000E+00 0.00000E+00 -16710 0.00000E+00 0.00000E+00 -16720 0.00000E+00 0.00000E+00 -16730 0.00000E+00 0.00000E+00 -16740 0.00000E+00 0.00000E+00 -16750 0.00000E+00 0.00000E+00 -16760 0.00000E+00 0.00000E+00 -16770 0.00000E+00 0.00000E+00 -16780 0.00000E+00 0.00000E+00 -16790 0.00000E+00 0.00000E+00 -16800 0.00000E+00 0.00000E+00 -16810 0.00000E+00 0.00000E+00 -16820 0.00000E+00 0.00000E+00 -16830 0.00000E+00 0.00000E+00 -16840 0.00000E+00 0.00000E+00 -16850 0.00000E+00 0.00000E+00 -16860 0.00000E+00 0.00000E+00 -16870 0.00000E+00 0.00000E+00 -16880 0.00000E+00 0.00000E+00 -16890 0.00000E+00 0.00000E+00 -16900 0.00000E+00 0.00000E+00 -16910 0.00000E+00 0.00000E+00 -16920 0.00000E+00 0.00000E+00 -16930 0.00000E+00 0.00000E+00 -16940 0.00000E+00 0.00000E+00 -16950 0.00000E+00 0.00000E+00 -16960 0.00000E+00 0.00000E+00 -16970 0.00000E+00 0.00000E+00 -16980 0.00000E+00 0.00000E+00 -16990 0.00000E+00 0.00000E+00 -17000 0.00000E+00 0.00000E+00 -17010 0.00000E+00 0.00000E+00 -17020 0.00000E+00 0.00000E+00 -17030 0.00000E+00 0.00000E+00 -17040 0.00000E+00 0.00000E+00 -17050 0.00000E+00 0.00000E+00 -17060 0.00000E+00 0.00000E+00 -17070 0.00000E+00 0.00000E+00 -17080 0.00000E+00 0.00000E+00 -17090 0.00000E+00 0.00000E+00 -17100 0.00000E+00 0.00000E+00 -17110 0.00000E+00 0.00000E+00 -17120 0.00000E+00 0.00000E+00 -17130 0.00000E+00 0.00000E+00 -17140 0.00000E+00 0.00000E+00 -17150 0.00000E+00 0.00000E+00 -17160 0.00000E+00 0.00000E+00 -17170 0.00000E+00 0.00000E+00 -17180 0.00000E+00 0.00000E+00 -17190 0.00000E+00 0.00000E+00 -17200 0.00000E+00 0.00000E+00 -17210 0.00000E+00 0.00000E+00 -17220 0.00000E+00 0.00000E+00 -17230 0.00000E+00 0.00000E+00 -17240 0.00000E+00 0.00000E+00 -17250 0.00000E+00 0.00000E+00 -17260 0.00000E+00 0.00000E+00 -17270 0.00000E+00 0.00000E+00 -17280 0.00000E+00 0.00000E+00 -17290 0.00000E+00 0.00000E+00 -17300 0.00000E+00 0.00000E+00 -17310 0.00000E+00 0.00000E+00 -17320 0.00000E+00 0.00000E+00 -17330 0.00000E+00 0.00000E+00 -17340 0.00000E+00 0.00000E+00 -17350 0.00000E+00 0.00000E+00 -17360 0.00000E+00 0.00000E+00 -17370 0.00000E+00 0.00000E+00 -17380 0.00000E+00 0.00000E+00 -17390 0.00000E+00 0.00000E+00 -17400 0.00000E+00 0.00000E+00 -17410 0.00000E+00 0.00000E+00 -17420 0.00000E+00 0.00000E+00 -17430 0.00000E+00 0.00000E+00 -17440 0.00000E+00 0.00000E+00 -17450 0.00000E+00 0.00000E+00 -17460 0.00000E+00 0.00000E+00 -17470 0.00000E+00 0.00000E+00 -17480 0.00000E+00 0.00000E+00 -17490 0.00000E+00 0.00000E+00 -17500 0.00000E+00 0.00000E+00 -17510 0.00000E+00 0.00000E+00 -17520 0.00000E+00 0.00000E+00 -17530 0.00000E+00 0.00000E+00 -17540 0.00000E+00 0.00000E+00 -17550 0.00000E+00 0.00000E+00 -17560 0.00000E+00 0.00000E+00 -17570 0.00000E+00 0.00000E+00 -17580 0.00000E+00 0.00000E+00 -17590 0.00000E+00 0.00000E+00 -17600 0.00000E+00 0.00000E+00 -17610 0.00000E+00 0.00000E+00 -17620 0.00000E+00 0.00000E+00 -17630 0.00000E+00 0.00000E+00 -17640 0.00000E+00 0.00000E+00 -17650 0.00000E+00 0.00000E+00 -17660 0.00000E+00 0.00000E+00 -17670 0.00000E+00 0.00000E+00 -17680 0.00000E+00 0.00000E+00 -17690 0.00000E+00 0.00000E+00 -17700 0.00000E+00 0.00000E+00 -17710 0.00000E+00 0.00000E+00 -17720 0.00000E+00 0.00000E+00 -17730 0.00000E+00 0.00000E+00 -17740 0.00000E+00 0.00000E+00 -17750 0.00000E+00 0.00000E+00 -17760 0.00000E+00 0.00000E+00 -17770 0.00000E+00 0.00000E+00 -17780 0.00000E+00 0.00000E+00 -17790 0.00000E+00 0.00000E+00 -17800 0.00000E+00 0.00000E+00 -17810 0.00000E+00 0.00000E+00 -17820 0.00000E+00 0.00000E+00 -17830 0.00000E+00 0.00000E+00 -17840 0.00000E+00 0.00000E+00 -17850 0.00000E+00 0.00000E+00 -17860 0.00000E+00 0.00000E+00 -17870 0.00000E+00 0.00000E+00 -17880 0.00000E+00 0.00000E+00 -17890 0.00000E+00 0.00000E+00 -17900 0.00000E+00 0.00000E+00 -17910 0.00000E+00 0.00000E+00 -17920 0.00000E+00 0.00000E+00 -17930 0.00000E+00 0.00000E+00 -17940 0.00000E+00 0.00000E+00 -17950 0.00000E+00 0.00000E+00 -17960 0.00000E+00 0.00000E+00 -17970 0.00000E+00 0.00000E+00 -17980 0.00000E+00 0.00000E+00 -17990 0.00000E+00 0.00000E+00 -18000 0.00000E+00 0.00000E+00 -18010 0.00000E+00 0.00000E+00 -18020 0.00000E+00 0.00000E+00 -18030 0.00000E+00 0.00000E+00 -18040 0.00000E+00 0.00000E+00 -18050 0.00000E+00 0.00000E+00 -18060 0.00000E+00 0.00000E+00 -18070 0.00000E+00 0.00000E+00 -18080 0.00000E+00 0.00000E+00 -18090 0.00000E+00 0.00000E+00 -18100 0.00000E+00 0.00000E+00 -18110 0.00000E+00 0.00000E+00 -18120 0.00000E+00 0.00000E+00 -18130 0.00000E+00 0.00000E+00 -18140 0.00000E+00 0.00000E+00 -18150 0.00000E+00 0.00000E+00 -18160 0.00000E+00 0.00000E+00 -18170 0.00000E+00 0.00000E+00 -18180 0.00000E+00 0.00000E+00 -18190 0.00000E+00 0.00000E+00 -18200 0.00000E+00 0.00000E+00 -18210 0.00000E+00 0.00000E+00 -18220 0.00000E+00 0.00000E+00 -18230 0.00000E+00 0.00000E+00 -18240 0.00000E+00 0.00000E+00 -18250 0.00000E+00 0.00000E+00 -18260 0.00000E+00 0.00000E+00 -18270 0.00000E+00 0.00000E+00 -18280 0.00000E+00 0.00000E+00 -18290 0.00000E+00 0.00000E+00 -18300 0.00000E+00 0.00000E+00 -18310 0.00000E+00 0.00000E+00 -18320 0.00000E+00 0.00000E+00 -18330 0.00000E+00 0.00000E+00 -18340 0.00000E+00 0.00000E+00 -18350 0.00000E+00 0.00000E+00 -18360 0.00000E+00 0.00000E+00 -18370 0.00000E+00 0.00000E+00 -18380 0.00000E+00 0.00000E+00 -18390 0.00000E+00 0.00000E+00 -18400 0.00000E+00 0.00000E+00 -18410 0.00000E+00 0.00000E+00 -18420 0.00000E+00 0.00000E+00 -18430 0.00000E+00 0.00000E+00 -18440 0.00000E+00 0.00000E+00 -18450 0.00000E+00 0.00000E+00 -18460 0.00000E+00 0.00000E+00 -18470 0.00000E+00 0.00000E+00 -18480 0.00000E+00 0.00000E+00 -18490 0.00000E+00 0.00000E+00 -18500 0.00000E+00 0.00000E+00 -18510 0.00000E+00 0.00000E+00 -18520 0.00000E+00 0.00000E+00 -18530 0.00000E+00 0.00000E+00 -18540 0.00000E+00 0.00000E+00 -18550 0.00000E+00 0.00000E+00 -18560 0.00000E+00 0.00000E+00 -18570 0.00000E+00 0.00000E+00 -18580 0.00000E+00 0.00000E+00 -18590 0.00000E+00 0.00000E+00 -18600 0.00000E+00 0.00000E+00 -18610 0.00000E+00 0.00000E+00 -18620 0.00000E+00 0.00000E+00 -18630 0.00000E+00 0.00000E+00 -18640 0.00000E+00 0.00000E+00 -18650 0.00000E+00 0.00000E+00 -18660 0.00000E+00 0.00000E+00 -18670 0.00000E+00 0.00000E+00 -18680 0.00000E+00 0.00000E+00 -18690 0.00000E+00 0.00000E+00 -18700 0.00000E+00 0.00000E+00 -18710 0.00000E+00 0.00000E+00 -18720 0.00000E+00 0.00000E+00 -18730 0.00000E+00 0.00000E+00 -18740 0.00000E+00 0.00000E+00 -18750 0.00000E+00 0.00000E+00 -18760 0.00000E+00 0.00000E+00 -18770 0.00000E+00 0.00000E+00 -18780 0.00000E+00 0.00000E+00 -18790 0.00000E+00 0.00000E+00 -18800 0.00000E+00 0.00000E+00 -18810 0.00000E+00 0.00000E+00 -18820 0.00000E+00 0.00000E+00 -18830 0.00000E+00 0.00000E+00 -18840 0.00000E+00 0.00000E+00 -18850 0.00000E+00 0.00000E+00 -18860 0.00000E+00 0.00000E+00 -18870 0.00000E+00 0.00000E+00 -18880 0.00000E+00 0.00000E+00 -18890 0.00000E+00 0.00000E+00 -18900 0.00000E+00 0.00000E+00 -18910 0.00000E+00 0.00000E+00 -18920 0.00000E+00 0.00000E+00 -18930 0.00000E+00 0.00000E+00 -18940 0.00000E+00 0.00000E+00 -18950 0.00000E+00 0.00000E+00 -18960 0.00000E+00 0.00000E+00 -18970 0.00000E+00 0.00000E+00 -18980 0.00000E+00 0.00000E+00 -18990 0.00000E+00 0.00000E+00 -19000 0.00000E+00 0.00000E+00 -19010 0.00000E+00 0.00000E+00 -19020 0.00000E+00 0.00000E+00 -19030 0.00000E+00 0.00000E+00 -19040 0.00000E+00 0.00000E+00 -19050 0.00000E+00 0.00000E+00 -19060 0.00000E+00 0.00000E+00 -19070 0.00000E+00 0.00000E+00 -19080 0.00000E+00 0.00000E+00 -19090 0.00000E+00 0.00000E+00 -19100 0.00000E+00 0.00000E+00 -19110 0.00000E+00 0.00000E+00 -19120 0.00000E+00 0.00000E+00 -19130 0.00000E+00 0.00000E+00 -19140 0.00000E+00 0.00000E+00 -19150 0.00000E+00 0.00000E+00 -19160 0.00000E+00 0.00000E+00 -19170 0.00000E+00 0.00000E+00 -19180 0.00000E+00 0.00000E+00 -19190 0.00000E+00 0.00000E+00 -19200 0.00000E+00 0.00000E+00 -19210 0.00000E+00 0.00000E+00 -19220 0.00000E+00 0.00000E+00 -19230 0.00000E+00 0.00000E+00 -19240 0.00000E+00 0.00000E+00 -19250 0.00000E+00 0.00000E+00 -19260 0.00000E+00 0.00000E+00 -19270 0.00000E+00 0.00000E+00 -19280 0.00000E+00 0.00000E+00 -19290 0.00000E+00 0.00000E+00 -19300 0.00000E+00 0.00000E+00 -19310 0.00000E+00 0.00000E+00 -19320 0.00000E+00 0.00000E+00 -19330 0.00000E+00 0.00000E+00 -19340 0.00000E+00 0.00000E+00 -19350 0.00000E+00 0.00000E+00 -19360 0.00000E+00 0.00000E+00 -19370 0.00000E+00 0.00000E+00 -19380 0.00000E+00 0.00000E+00 -19390 0.00000E+00 0.00000E+00 -19400 0.00000E+00 0.00000E+00 -19410 0.00000E+00 0.00000E+00 -19420 0.00000E+00 0.00000E+00 -19430 0.00000E+00 0.00000E+00 -19440 0.00000E+00 0.00000E+00 -19450 0.00000E+00 0.00000E+00 -19460 0.00000E+00 0.00000E+00 -19470 0.00000E+00 0.00000E+00 -19480 0.00000E+00 0.00000E+00 -19490 0.00000E+00 0.00000E+00 -19500 0.00000E+00 0.00000E+00 -19510 0.00000E+00 0.00000E+00 -19520 0.00000E+00 0.00000E+00 -19530 0.00000E+00 0.00000E+00 -19540 0.00000E+00 0.00000E+00 -19550 0.00000E+00 0.00000E+00 -19560 0.00000E+00 0.00000E+00 -19570 0.00000E+00 0.00000E+00 -19580 0.00000E+00 0.00000E+00 -19590 0.00000E+00 0.00000E+00 -19600 0.00000E+00 0.00000E+00 -19610 0.00000E+00 0.00000E+00 -19620 0.00000E+00 0.00000E+00 -19630 0.00000E+00 0.00000E+00 -19640 0.00000E+00 0.00000E+00 -19650 0.00000E+00 0.00000E+00 -19660 0.00000E+00 0.00000E+00 -19670 0.00000E+00 0.00000E+00 -19680 0.00000E+00 0.00000E+00 -19690 0.00000E+00 0.00000E+00 -19700 0.00000E+00 0.00000E+00 -19710 0.00000E+00 0.00000E+00 -19720 0.00000E+00 0.00000E+00 -19730 0.00000E+00 0.00000E+00 -19740 0.00000E+00 0.00000E+00 -19750 0.00000E+00 0.00000E+00 -19760 0.00000E+00 0.00000E+00 -19770 0.00000E+00 0.00000E+00 -19780 0.00000E+00 0.00000E+00 -19790 0.00000E+00 0.00000E+00 -19800 0.00000E+00 0.00000E+00 -19810 0.00000E+00 0.00000E+00 -19820 0.00000E+00 0.00000E+00 -19830 0.00000E+00 0.00000E+00 -19840 0.00000E+00 0.00000E+00 -19850 0.00000E+00 0.00000E+00 -19860 0.00000E+00 0.00000E+00 -19870 0.00000E+00 0.00000E+00 -19880 0.00000E+00 0.00000E+00 -19890 0.00000E+00 0.00000E+00 -19900 0.00000E+00 0.00000E+00 -19910 0.00000E+00 0.00000E+00 -19920 0.00000E+00 0.00000E+00 -19930 0.00000E+00 0.00000E+00 -19940 0.00000E+00 0.00000E+00 -19950 0.00000E+00 0.00000E+00 -19960 0.00000E+00 0.00000E+00 -19970 0.00000E+00 0.00000E+00 -19980 0.00000E+00 0.00000E+00 -19990 0.00000E+00 0.00000E+00 -20000 0.00000E+00 0.00000E+00 -20010 0.00000E+00 0.00000E+00 -20020 0.00000E+00 0.00000E+00 -20030 0.00000E+00 0.00000E+00 -20040 0.00000E+00 0.00000E+00 -20050 0.00000E+00 0.00000E+00 -20060 0.00000E+00 0.00000E+00 -20070 0.00000E+00 0.00000E+00 -20080 0.00000E+00 0.00000E+00 -20090 0.00000E+00 0.00000E+00 -20100 0.00000E+00 0.00000E+00 -20110 0.00000E+00 0.00000E+00 -20120 0.00000E+00 0.00000E+00 -20130 0.00000E+00 0.00000E+00 -20140 0.00000E+00 0.00000E+00 -20150 0.00000E+00 0.00000E+00 -20160 0.00000E+00 0.00000E+00 -20170 0.00000E+00 0.00000E+00 -20180 0.00000E+00 0.00000E+00 -20190 0.00000E+00 0.00000E+00 -20200 0.00000E+00 0.00000E+00 -20210 0.00000E+00 0.00000E+00 -20220 0.00000E+00 0.00000E+00 -20230 0.00000E+00 0.00000E+00 -20240 0.00000E+00 0.00000E+00 -20250 0.00000E+00 0.00000E+00 -20260 0.00000E+00 0.00000E+00 -20270 0.00000E+00 0.00000E+00 -20280 0.00000E+00 0.00000E+00 -20290 0.00000E+00 0.00000E+00 -20300 0.00000E+00 0.00000E+00 -20310 0.00000E+00 0.00000E+00 -20320 0.00000E+00 0.00000E+00 -20330 0.00000E+00 0.00000E+00 -20340 0.00000E+00 0.00000E+00 -20350 0.00000E+00 0.00000E+00 -20360 0.00000E+00 0.00000E+00 -20370 0.00000E+00 0.00000E+00 -20380 0.00000E+00 0.00000E+00 -20390 0.00000E+00 0.00000E+00 -20400 0.00000E+00 0.00000E+00 -20410 0.00000E+00 0.00000E+00 -20420 0.00000E+00 0.00000E+00 -20430 0.00000E+00 0.00000E+00 -20440 0.00000E+00 0.00000E+00 -20450 0.00000E+00 0.00000E+00 -20460 0.00000E+00 0.00000E+00 -20470 0.00000E+00 0.00000E+00 -20480 0.00000E+00 0.00000E+00 -20490 0.00000E+00 0.00000E+00 -20500 0.00000E+00 0.00000E+00 -20510 0.00000E+00 0.00000E+00 -20520 0.00000E+00 0.00000E+00 -20530 0.00000E+00 0.00000E+00 -20540 0.00000E+00 0.00000E+00 -20550 0.00000E+00 0.00000E+00 -20560 0.00000E+00 0.00000E+00 -20570 0.00000E+00 0.00000E+00 -20580 0.00000E+00 0.00000E+00 -20590 0.00000E+00 0.00000E+00 -20600 0.00000E+00 0.00000E+00 -20610 0.00000E+00 0.00000E+00 -20620 0.00000E+00 0.00000E+00 -20630 0.00000E+00 0.00000E+00 -20640 0.00000E+00 0.00000E+00 -20650 0.00000E+00 0.00000E+00 -20660 0.00000E+00 0.00000E+00 -20670 0.00000E+00 0.00000E+00 -20680 0.00000E+00 0.00000E+00 -20690 0.00000E+00 0.00000E+00 -20700 0.00000E+00 0.00000E+00 -20710 0.00000E+00 0.00000E+00 -20720 0.00000E+00 0.00000E+00 -20730 0.00000E+00 0.00000E+00 -20740 0.00000E+00 0.00000E+00 -20750 0.00000E+00 0.00000E+00 -20760 0.00000E+00 0.00000E+00 -20770 0.00000E+00 0.00000E+00 -20780 0.00000E+00 0.00000E+00 -20790 0.00000E+00 0.00000E+00 -20800 0.00000E+00 0.00000E+00 -20810 0.00000E+00 0.00000E+00 -20820 0.00000E+00 0.00000E+00 -20830 0.00000E+00 0.00000E+00 -20840 0.00000E+00 0.00000E+00 -20850 0.00000E+00 0.00000E+00 -20860 0.00000E+00 0.00000E+00 -20870 0.00000E+00 0.00000E+00 -20880 0.00000E+00 0.00000E+00 -20890 0.00000E+00 0.00000E+00 -20900 0.00000E+00 0.00000E+00 -20910 0.00000E+00 0.00000E+00 -20920 0.00000E+00 0.00000E+00 -20930 0.00000E+00 0.00000E+00 -20940 0.00000E+00 0.00000E+00 -20950 0.00000E+00 0.00000E+00 -20960 0.00000E+00 0.00000E+00 -20970 0.00000E+00 0.00000E+00 -20980 0.00000E+00 0.00000E+00 -20990 0.00000E+00 0.00000E+00 -21000 0.00000E+00 0.00000E+00 -21010 0.00000E+00 0.00000E+00 -21020 0.00000E+00 0.00000E+00 -21030 0.00000E+00 0.00000E+00 -21040 0.00000E+00 0.00000E+00 -21050 0.00000E+00 0.00000E+00 -21060 0.00000E+00 0.00000E+00 -21070 0.00000E+00 0.00000E+00 -21080 0.00000E+00 0.00000E+00 -21090 0.00000E+00 0.00000E+00 -21100 0.00000E+00 0.00000E+00 -21110 0.00000E+00 0.00000E+00 -21120 0.00000E+00 0.00000E+00 -21130 0.00000E+00 0.00000E+00 -21140 0.00000E+00 0.00000E+00 -21150 0.00000E+00 0.00000E+00 -21160 0.00000E+00 0.00000E+00 -21170 0.00000E+00 0.00000E+00 -21180 0.00000E+00 0.00000E+00 -21190 0.00000E+00 0.00000E+00 -21200 0.00000E+00 0.00000E+00 -21210 0.00000E+00 0.00000E+00 -21220 0.00000E+00 0.00000E+00 -21230 0.00000E+00 0.00000E+00 -21240 0.00000E+00 0.00000E+00 -21250 0.00000E+00 0.00000E+00 -21260 0.00000E+00 0.00000E+00 -21270 0.00000E+00 0.00000E+00 -21280 0.00000E+00 0.00000E+00 -21290 0.00000E+00 0.00000E+00 -21300 0.00000E+00 0.00000E+00 -21310 0.00000E+00 0.00000E+00 -21320 0.00000E+00 0.00000E+00 -21330 0.00000E+00 0.00000E+00 -21340 0.00000E+00 0.00000E+00 -21350 0.00000E+00 0.00000E+00 -21360 0.00000E+00 0.00000E+00 -21370 0.00000E+00 0.00000E+00 -21380 0.00000E+00 0.00000E+00 -21390 0.00000E+00 0.00000E+00 -21400 0.00000E+00 0.00000E+00 -21410 0.00000E+00 0.00000E+00 -21420 0.00000E+00 0.00000E+00 -21430 0.00000E+00 0.00000E+00 -21440 0.00000E+00 0.00000E+00 -21450 0.00000E+00 0.00000E+00 -21460 0.00000E+00 0.00000E+00 -21470 0.00000E+00 0.00000E+00 -21480 0.00000E+00 0.00000E+00 -21490 0.00000E+00 0.00000E+00 -21500 0.00000E+00 0.00000E+00 -21510 0.00000E+00 0.00000E+00 -21520 0.00000E+00 0.00000E+00 -21530 0.00000E+00 0.00000E+00 -21540 0.00000E+00 0.00000E+00 -21550 0.00000E+00 0.00000E+00 -21560 0.00000E+00 0.00000E+00 -21570 0.00000E+00 0.00000E+00 -21580 0.00000E+00 0.00000E+00 -21590 0.00000E+00 0.00000E+00 -21600 0.00000E+00 0.00000E+00 -21610 0.00000E+00 0.00000E+00 -21620 0.00000E+00 0.00000E+00 -21630 0.00000E+00 0.00000E+00 -21640 0.00000E+00 0.00000E+00 -21650 0.00000E+00 0.00000E+00 -21660 0.00000E+00 0.00000E+00 -21670 0.00000E+00 0.00000E+00 -21680 0.00000E+00 0.00000E+00 -21690 0.00000E+00 0.00000E+00 -21700 0.00000E+00 0.00000E+00 -21710 0.00000E+00 0.00000E+00 -21720 0.00000E+00 0.00000E+00 -21730 0.00000E+00 0.00000E+00 -21740 0.00000E+00 0.00000E+00 -21750 0.00000E+00 0.00000E+00 -21760 0.00000E+00 0.00000E+00 -21770 0.00000E+00 0.00000E+00 -21780 0.00000E+00 0.00000E+00 -21790 0.00000E+00 0.00000E+00 -21800 0.00000E+00 0.00000E+00 -21810 0.00000E+00 0.00000E+00 -21820 0.00000E+00 0.00000E+00 -21830 0.00000E+00 0.00000E+00 -21840 0.00000E+00 0.00000E+00 -21850 0.00000E+00 0.00000E+00 -21860 0.00000E+00 0.00000E+00 -21870 0.00000E+00 0.00000E+00 -21880 0.00000E+00 0.00000E+00 -21890 0.00000E+00 0.00000E+00 -21900 0.00000E+00 0.00000E+00 -21910 0.00000E+00 0.00000E+00 -21920 0.00000E+00 0.00000E+00 -21930 0.00000E+00 0.00000E+00 -21940 0.00000E+00 0.00000E+00 -21950 0.00000E+00 0.00000E+00 -21960 0.00000E+00 0.00000E+00 -21970 0.00000E+00 0.00000E+00 -21980 0.00000E+00 0.00000E+00 -21990 0.00000E+00 0.00000E+00 -22000 0.00000E+00 0.00000E+00 -22010 0.00000E+00 0.00000E+00 -22020 0.00000E+00 0.00000E+00 -22030 0.00000E+00 0.00000E+00 -22040 0.00000E+00 0.00000E+00 -22050 0.00000E+00 0.00000E+00 -22060 0.00000E+00 0.00000E+00 -22070 0.00000E+00 0.00000E+00 -22080 0.00000E+00 0.00000E+00 -22090 0.00000E+00 0.00000E+00 -22100 0.00000E+00 0.00000E+00 -22110 0.00000E+00 0.00000E+00 -22120 0.00000E+00 0.00000E+00 -22130 0.00000E+00 0.00000E+00 -22140 0.00000E+00 0.00000E+00 -22150 0.00000E+00 0.00000E+00 -22160 0.00000E+00 0.00000E+00 -22170 0.00000E+00 0.00000E+00 -22180 0.00000E+00 0.00000E+00 -22190 0.00000E+00 0.00000E+00 -22200 0.00000E+00 0.00000E+00 -22210 0.00000E+00 0.00000E+00 -22220 0.00000E+00 0.00000E+00 -22230 0.00000E+00 0.00000E+00 -22240 0.00000E+00 0.00000E+00 -22250 0.00000E+00 0.00000E+00 -22260 0.00000E+00 0.00000E+00 -22270 0.00000E+00 0.00000E+00 -22280 0.00000E+00 0.00000E+00 -22290 0.00000E+00 0.00000E+00 -22300 0.00000E+00 0.00000E+00 -22310 0.00000E+00 0.00000E+00 -22320 0.00000E+00 0.00000E+00 -22330 0.00000E+00 0.00000E+00 -22340 0.00000E+00 0.00000E+00 -22350 0.00000E+00 0.00000E+00 -22360 0.00000E+00 0.00000E+00 -22370 0.00000E+00 0.00000E+00 -22380 0.00000E+00 0.00000E+00 -22390 0.00000E+00 0.00000E+00 -22400 0.00000E+00 0.00000E+00 -22410 0.00000E+00 0.00000E+00 -22420 0.00000E+00 0.00000E+00 -22430 0.00000E+00 0.00000E+00 -22440 0.00000E+00 0.00000E+00 -22450 0.00000E+00 0.00000E+00 -22460 0.00000E+00 0.00000E+00 -22470 0.00000E+00 0.00000E+00 -22480 0.00000E+00 0.00000E+00 -22490 0.00000E+00 0.00000E+00 -22500 0.00000E+00 0.00000E+00 -22510 0.00000E+00 0.00000E+00 -22520 0.00000E+00 0.00000E+00 -22530 0.00000E+00 0.00000E+00 -22540 0.00000E+00 0.00000E+00 -22550 0.00000E+00 0.00000E+00 -22560 0.00000E+00 0.00000E+00 -22570 0.00000E+00 0.00000E+00 -22580 0.00000E+00 0.00000E+00 -22590 0.00000E+00 0.00000E+00 -22600 0.00000E+00 0.00000E+00 -22610 0.00000E+00 0.00000E+00 -22620 0.00000E+00 0.00000E+00 -22630 0.00000E+00 0.00000E+00 -22640 0.00000E+00 0.00000E+00 -22650 0.00000E+00 0.00000E+00 -22660 0.00000E+00 0.00000E+00 -22670 0.00000E+00 0.00000E+00 -22680 0.00000E+00 0.00000E+00 -22690 0.00000E+00 0.00000E+00 -22700 0.00000E+00 0.00000E+00 -22710 0.00000E+00 0.00000E+00 -22720 0.00000E+00 0.00000E+00 -22730 0.00000E+00 0.00000E+00 -22740 0.00000E+00 0.00000E+00 -22750 0.00000E+00 0.00000E+00 -22760 0.00000E+00 0.00000E+00 -22770 0.00000E+00 0.00000E+00 -22780 0.00000E+00 0.00000E+00 -22790 0.00000E+00 0.00000E+00 -22800 0.00000E+00 0.00000E+00 -22810 0.00000E+00 0.00000E+00 -22820 0.00000E+00 0.00000E+00 -22830 0.00000E+00 0.00000E+00 -22840 0.00000E+00 0.00000E+00 -22850 0.00000E+00 0.00000E+00 -22860 0.00000E+00 0.00000E+00 -22870 0.00000E+00 0.00000E+00 -22880 0.00000E+00 0.00000E+00 -22890 0.00000E+00 0.00000E+00 -22900 0.00000E+00 0.00000E+00 -22910 0.00000E+00 0.00000E+00 -22920 0.00000E+00 0.00000E+00 -22930 0.00000E+00 0.00000E+00 -22940 0.00000E+00 0.00000E+00 -22950 0.00000E+00 0.00000E+00 -22960 0.00000E+00 0.00000E+00 -22970 0.00000E+00 0.00000E+00 -22980 0.00000E+00 0.00000E+00 -22990 0.00000E+00 0.00000E+00 -23000 0.00000E+00 0.00000E+00 -23010 0.00000E+00 0.00000E+00 -23020 0.00000E+00 0.00000E+00 -23030 0.00000E+00 0.00000E+00 -23040 0.00000E+00 0.00000E+00 -23050 0.00000E+00 0.00000E+00 -23060 0.00000E+00 0.00000E+00 -23070 0.00000E+00 0.00000E+00 -23080 0.00000E+00 0.00000E+00 -23090 0.00000E+00 0.00000E+00 -23100 0.00000E+00 0.00000E+00 -23110 0.00000E+00 0.00000E+00 -23120 0.00000E+00 0.00000E+00 -23130 0.00000E+00 0.00000E+00 -23140 0.00000E+00 0.00000E+00 -23150 0.00000E+00 0.00000E+00 -23160 0.00000E+00 0.00000E+00 -23170 0.00000E+00 0.00000E+00 -23180 0.00000E+00 0.00000E+00 -23190 0.00000E+00 0.00000E+00 -23200 0.00000E+00 0.00000E+00 -23210 0.00000E+00 0.00000E+00 -23220 0.00000E+00 0.00000E+00 -23230 0.00000E+00 0.00000E+00 -23240 0.00000E+00 0.00000E+00 -23250 0.00000E+00 0.00000E+00 -23260 0.00000E+00 0.00000E+00 -23270 0.00000E+00 0.00000E+00 -23280 0.00000E+00 0.00000E+00 -23290 0.00000E+00 0.00000E+00 -23300 0.00000E+00 0.00000E+00 -23310 0.00000E+00 0.00000E+00 -23320 0.00000E+00 0.00000E+00 -23330 0.00000E+00 0.00000E+00 -23340 0.00000E+00 0.00000E+00 -23350 0.00000E+00 0.00000E+00 -23360 0.00000E+00 0.00000E+00 -23370 0.00000E+00 0.00000E+00 -23380 0.00000E+00 0.00000E+00 -23390 0.00000E+00 0.00000E+00 -23400 0.00000E+00 0.00000E+00 -23410 0.00000E+00 0.00000E+00 -23420 0.00000E+00 0.00000E+00 -23430 0.00000E+00 0.00000E+00 -23440 0.00000E+00 0.00000E+00 -23450 0.00000E+00 0.00000E+00 -23460 0.00000E+00 0.00000E+00 -23470 0.00000E+00 0.00000E+00 -23480 0.00000E+00 0.00000E+00 -23490 0.00000E+00 0.00000E+00 -23500 0.00000E+00 0.00000E+00 -23510 0.00000E+00 0.00000E+00 -23520 0.00000E+00 0.00000E+00 -23530 0.00000E+00 0.00000E+00 -23540 0.00000E+00 0.00000E+00 -23550 0.00000E+00 0.00000E+00 -23560 0.00000E+00 0.00000E+00 -23570 0.00000E+00 0.00000E+00 -23580 0.00000E+00 0.00000E+00 -23590 1.02394E-22 2.09880E-22 -23600 3.03930E-22 6.22784E-22 -23610 5.06075E-22 1.03668E-21 -23620 7.08935E-22 1.45180E-21 -23630 9.12400E-22 1.86790E-21 -23640 1.11652E-21 2.28510E-21 -23650 1.32135E-21 2.70350E-21 -23660 1.52678E-21 3.12288E-21 -23670 1.73286E-21 3.54334E-21 -23680 1.93953E-21 3.96477E-21 -23690 2.14691E-21 4.38740E-21 -23700 2.35493E-21 4.81109E-21 -23710 2.56353E-21 5.23575E-21 -23720 2.77284E-21 5.66158E-21 -23730 2.98272E-21 6.08837E-21 -23740 3.19330E-21 6.51633E-21 -23750 3.40445E-21 6.94523E-21 -23760 3.68832E-21 7.52219E-21 -23770 4.00362E-21 8.16292E-21 -23780 4.31978E-21 8.80505E-21 -23790 4.63689E-21 9.44875E-21 -23800 4.95493E-21 1.00940E-20 -23810 5.27574E-21 1.07348E-20 -23820 5.63325E-21 1.12555E-20 -23830 5.99007E-21 1.17754E-20 -23840 6.34620E-21 1.22944E-20 -23850 6.70165E-21 1.28127E-20 -23860 7.05641E-21 1.33302E-20 -23870 7.37315E-21 1.39231E-20 -23880 7.62445E-21 1.46472E-20 -23890 7.87519E-21 1.53701E-20 -23900 8.12551E-21 1.60921E-20 -23910 8.37535E-21 1.68129E-20 -23920 8.62471E-21 1.75327E-20 -23930 9.00651E-21 1.83870E-20 -23940 9.45738E-21 1.93114E-20 -23950 9.90738E-21 2.02343E-20 -23960 1.03565E-20 2.11558E-20 -23970 1.08048E-20 2.20759E-20 -23980 1.12522E-20 2.29945E-20 -23990 1.16987E-20 2.39118E-20 -24000 1.21443E-20 2.48277E-20 -24010 1.25891E-20 2.57422E-20 -24020 1.30331E-20 2.66552E-20 -24030 1.34761E-20 2.75669E-20 -24040 1.39414E-20 2.85243E-20 -24050 1.45323E-20 2.97394E-20 -24060 1.51223E-20 3.09529E-20 -24070 1.57110E-20 3.21642E-20 -24080 1.62987E-20 3.33741E-20 -24090 1.68851E-20 3.45817E-20 -24100 1.76297E-20 3.61055E-20 -24110 1.86569E-20 3.81924E-20 -24120 1.96875E-20 4.02843E-20 -24130 2.07211E-20 4.23806E-20 -24140 2.17576E-20 4.44812E-20 -24150 2.27972E-20 4.65862E-20 -24160 2.43798E-20 4.81439E-20 -24170 2.64258E-20 4.92365E-20 -24180 2.84777E-20 5.03312E-20 -24190 3.05361E-20 5.14284E-20 -24200 3.25998E-20 5.25273E-20 -24210 3.46701E-20 5.36286E-20 -24220 3.60499E-20 5.54405E-20 -24230 3.71245E-20 5.75715E-20 -24240 3.82021E-20 5.97067E-20 -24250 3.92825E-20 6.18461E-20 -24260 4.03658E-20 6.39897E-20 -24270 4.14522E-20 6.61381E-20 -24280 4.25412E-20 6.82901E-20 -24290 4.36334E-20 7.04468E-20 -24300 4.47280E-20 7.26070E-20 -24310 4.58259E-20 7.47720E-20 -24320 4.69265E-20 7.69410E-20 -24330 4.80303E-20 7.91148E-20 -24340 5.00625E-20 8.12921E-20 -24350 5.21918E-20 8.34733E-20 -24360 5.43273E-20 8.56593E-20 -24370 5.64684E-20 8.78493E-20 -24380 5.86151E-20 9.00433E-20 -24390 6.07674E-20 9.22413E-20 -24400 6.26564E-20 9.51252E-20 -24410 6.45274E-20 9.80117E-20 -24420 6.63859E-20 1.00882E-19 -24430 6.82327E-20 1.03738E-19 -24440 7.00673E-20 1.06578E-19 -24450 7.18903E-20 1.09415E-19 -24460 7.37012E-20 1.13238E-19 -24470 7.55002E-20 1.17041E-19 -24480 7.72874E-20 1.20824E-19 -24490 7.90628E-20 1.24586E-19 -24500 8.08265E-20 1.28329E-19 -24510 8.26169E-20 1.32051E-19 -24520 8.63135E-20 1.35753E-19 -24530 8.99868E-20 1.39435E-19 -24540 9.36364E-20 1.43097E-19 -24550 9.72628E-20 1.46739E-19 -24560 1.00866E-19 1.50361E-19 -24570 1.04445E-19 1.53963E-19 -24580 1.08002E-19 1.57546E-19 -24590 1.11534E-19 1.61108E-19 -24600 1.15044E-19 1.64651E-19 -24610 1.18530E-19 1.68174E-19 -24620 1.21994E-19 1.71678E-19 -24630 1.25434E-19 1.75162E-19 -24640 1.30627E-19 1.81353E-19 -24650 1.35887E-19 1.87667E-19 -24660 1.41112E-19 1.93946E-19 -24670 1.46303E-19 2.00191E-19 -24680 1.51461E-19 2.06403E-19 -24690 1.56583E-19 2.12580E-19 -24700 1.62626E-19 2.19802E-19 -24710 1.68855E-19 2.27228E-19 -24720 1.75124E-19 2.34696E-19 -24730 1.81433E-19 2.42203E-19 -24740 1.87782E-19 2.49750E-19 -24750 1.94171E-19 2.57337E-19 -24760 2.03436E-19 2.66415E-19 -24770 2.13697E-19 2.76020E-19 -24780 2.24024E-19 2.85676E-19 -24790 2.34418E-19 2.95383E-19 -24800 2.44877E-19 3.05141E-19 -24810 2.55402E-19 3.14949E-19 -24820 2.67166E-19 3.24809E-19 -24830 2.79753E-19 3.34719E-19 -24840 2.92419E-19 3.44679E-19 -24850 3.05164E-19 3.54691E-19 -24860 3.17986E-19 3.64751E-19 -24870 3.30886E-19 3.74862E-19 -24880 3.44291E-19 3.86761E-19 -24890 3.58331E-19 4.00963E-19 -24900 3.72453E-19 4.15234E-19 -24910 3.86657E-19 4.29577E-19 -24920 4.00947E-19 4.43994E-19 -24930 4.15319E-19 4.58481E-19 -24940 4.30708E-19 4.73040E-19 -24950 4.49238E-19 4.87668E-19 -24960 4.67880E-19 5.02371E-19 -24970 4.86629E-19 5.17143E-19 -24980 5.05484E-19 5.31983E-19 -24990 5.24449E-19 5.46897E-19 -25000 5.43520E-19 5.61880E-19 -25010 5.50157E-19 5.67703E-19 -25020 5.56747E-19 5.73488E-19 -25030 5.63289E-19 5.79234E-19 -25040 5.69784E-19 5.84944E-19 -25050 5.76231E-19 5.90616E-19 -25060 5.82630E-19 5.96249E-19 -25070 5.87533E-19 6.00378E-19 -25080 5.91874E-19 6.03947E-19 -25090 5.96181E-19 6.07490E-19 -25100 6.00452E-19 6.11007E-19 -25110 6.04689E-19 6.14497E-19 -25120 6.08891E-19 6.17962E-19 -25130 6.10521E-19 6.19256E-19 -25140 6.08878E-19 6.17784E-19 -25150 6.07236E-19 6.16313E-19 -25160 6.05596E-19 6.14843E-19 -25170 6.03957E-19 6.13375E-19 -25180 6.02319E-19 6.11907E-19 -25190 6.00683E-19 6.10441E-19 -25200 5.99048E-19 6.08976E-19 -25210 5.97414E-19 6.07512E-19 -25220 5.95781E-19 6.06050E-19 -25230 5.94150E-19 6.04588E-19 -25240 5.92520E-19 6.03128E-19 -25250 5.90891E-19 6.01668E-19 -25260 5.89264E-19 6.00210E-19 -25270 5.87637E-19 5.98753E-19 -25280 5.86013E-19 5.97298E-19 -25290 5.84389E-19 5.95843E-19 -25300 5.82767E-19 5.94389E-19 -25310 5.81146E-19 5.92937E-19 -25320 5.80563E-19 5.92310E-19 -25330 5.81870E-19 5.93183E-19 -25340 5.83176E-19 5.94055E-19 -25350 5.84480E-19 5.94927E-19 -25360 5.85784E-19 5.95798E-19 -25370 5.87086E-19 5.96669E-19 -25380 5.88388E-19 5.97538E-19 -25390 5.89688E-19 5.98407E-19 -25400 5.90987E-19 5.99276E-19 -25410 5.92286E-19 6.00143E-19 -25420 5.93583E-19 6.01010E-19 -25430 5.94880E-19 6.01877E-19 -25440 5.96175E-19 6.02742E-19 -25450 5.97469E-19 6.03607E-19 -25460 5.98762E-19 6.04471E-19 -25470 6.00055E-19 6.05335E-19 -25480 6.01346E-19 6.06198E-19 -25490 6.02636E-19 6.07060E-19 -25500 6.03925E-19 6.07922E-19 -25510 6.05214E-19 6.08782E-19 -25520 6.06501E-19 6.09643E-19 -25530 6.07787E-19 6.10502E-19 -25540 6.09072E-19 6.11361E-19 -25550 6.10357E-19 6.12219E-19 -25560 6.11640E-19 6.13077E-19 -25570 6.12922E-19 6.13934E-19 -25580 6.14203E-19 6.14790E-19 -25590 6.15483E-19 6.15645E-19 -25600 6.16763E-19 6.16500E-19 -25610 6.18041E-19 6.17354E-19 -25620 6.19318E-19 6.18208E-19 -25630 6.20594E-19 6.19060E-19 -25640 6.21869E-19 6.19913E-19 -25650 6.21119E-19 6.19296E-19 -25660 6.20137E-19 6.18512E-19 -25670 6.19156E-19 6.17729E-19 -25680 6.18176E-19 6.16946E-19 -25690 6.17197E-19 6.16164E-19 -25700 6.16219E-19 6.15382E-19 -25710 6.15241E-19 6.14601E-19 -25720 6.14264E-19 6.13821E-19 -25730 6.13288E-19 6.13041E-19 -25740 6.12313E-19 6.12262E-19 -25750 6.11338E-19 6.11483E-19 -25760 6.10364E-19 6.10706E-19 -25770 6.09391E-19 6.09928E-19 -25780 6.08418E-19 6.09152E-19 -25790 6.07447E-19 6.08376E-19 -25800 6.06476E-19 6.07600E-19 -25810 6.05506E-19 6.06825E-19 -25820 6.04537E-19 6.06051E-19 -25830 6.03568E-19 6.05277E-19 -25840 6.02600E-19 6.04504E-19 -25850 6.01633E-19 6.03732E-19 -25860 6.00667E-19 6.02960E-19 -25870 5.99701E-19 6.02188E-19 -25880 5.98736E-19 6.01418E-19 -25890 5.97772E-19 6.00647E-19 -25900 5.96809E-19 5.99878E-19 -25910 5.95846E-19 5.99109E-19 -25920 5.94884E-19 5.98341E-19 -25930 5.93923E-19 5.97573E-19 -25940 5.92962E-19 5.96806E-19 -25950 5.92003E-19 5.96039E-19 -25960 5.91044E-19 5.95273E-19 -25970 5.90086E-19 5.94508E-19 -25980 5.89587E-19 5.94168E-19 -25990 5.89397E-19 5.94115E-19 -26000 5.89208E-19 5.94062E-19 -26010 5.89018E-19 5.94008E-19 -26020 5.88829E-19 5.93955E-19 -26030 5.88640E-19 5.93902E-19 -26040 5.88451E-19 5.93849E-19 -26050 5.88263E-19 5.93796E-19 -26060 5.88074E-19 5.93743E-19 -26070 5.87886E-19 5.93690E-19 -26080 5.87698E-19 5.93637E-19 -26090 5.87509E-19 5.93584E-19 -26100 5.87321E-19 5.93531E-19 -26110 5.87134E-19 5.93478E-19 -26120 5.86946E-19 5.93425E-19 -26130 5.86758E-19 5.93373E-19 -26140 5.86571E-19 5.93320E-19 -26150 5.86384E-19 5.93267E-19 -26160 5.86197E-19 5.93215E-19 -26170 5.86010E-19 5.93162E-19 -26180 5.85823E-19 5.93110E-19 -26190 5.85636E-19 5.93057E-19 -26200 5.85450E-19 5.93005E-19 -26210 5.85263E-19 5.92952E-19 -26220 5.85077E-19 5.92900E-19 -26230 5.84891E-19 5.92847E-19 -26240 5.84705E-19 5.92795E-19 -26250 5.84519E-19 5.92743E-19 -26260 5.84333E-19 5.92691E-19 -26270 5.84148E-19 5.92638E-19 -26280 5.83962E-19 5.92586E-19 -26290 5.83777E-19 5.92534E-19 -26300 5.83592E-19 5.92482E-19 -26310 5.83407E-19 5.92430E-19 -26320 5.83377E-19 5.92356E-19 -26330 5.83558E-19 5.92252E-19 -26340 5.83740E-19 5.92149E-19 -26350 5.83922E-19 5.92045E-19 -26360 5.84103E-19 5.91941E-19 -26370 5.84284E-19 5.91837E-19 -26380 5.84465E-19 5.91734E-19 -26390 5.84646E-19 5.91631E-19 -26400 5.84827E-19 5.91527E-19 -26410 5.85008E-19 5.91424E-19 -26420 5.85189E-19 5.91321E-19 -26430 5.85369E-19 5.91218E-19 -26440 5.85549E-19 5.91115E-19 -26450 5.85729E-19 5.91012E-19 -26460 5.85910E-19 5.90909E-19 -26470 5.86089E-19 5.90806E-19 -26480 5.86269E-19 5.90703E-19 -26490 5.86449E-19 5.90601E-19 -26500 5.86628E-19 5.90498E-19 -26510 5.86808E-19 5.90396E-19 -26520 5.86987E-19 5.90293E-19 -26530 5.87166E-19 5.90191E-19 -26540 5.87345E-19 5.90089E-19 -26550 5.87524E-19 5.89986E-19 -26560 5.87702E-19 5.89884E-19 -26570 5.87881E-19 5.89782E-19 -26580 5.88059E-19 5.89680E-19 -26590 5.88238E-19 5.89578E-19 -26600 5.88416E-19 5.89477E-19 -26610 5.88594E-19 5.89375E-19 -26620 5.88772E-19 5.89273E-19 -26630 5.88949E-19 5.89172E-19 -26640 5.89127E-19 5.89070E-19 -26650 5.89305E-19 5.88969E-19 -26660 5.89482E-19 5.88867E-19 -26670 5.89316E-19 5.88537E-19 -26680 5.88464E-19 5.87747E-19 -26690 5.87613E-19 5.86958E-19 -26700 5.86763E-19 5.86169E-19 -26710 5.85913E-19 5.85381E-19 -26720 5.85064E-19 5.84593E-19 -26730 5.84216E-19 5.83806E-19 -26740 5.83368E-19 5.83020E-19 -26750 5.82521E-19 5.82235E-19 -26760 5.81674E-19 5.81450E-19 -26770 5.80828E-19 5.80665E-19 -26780 5.79983E-19 5.79881E-19 -26790 5.79138E-19 5.79098E-19 -26800 5.78294E-19 5.78315E-19 -26810 5.77451E-19 5.77533E-19 -26820 5.76608E-19 5.76751E-19 -26830 5.75766E-19 5.75970E-19 -26840 5.74924E-19 5.75190E-19 -26850 5.74083E-19 5.74410E-19 -26860 5.73243E-19 5.73631E-19 -26870 5.72403E-19 5.72852E-19 -26880 5.71564E-19 5.72074E-19 -26890 5.70726E-19 5.71296E-19 -26900 5.69888E-19 5.70519E-19 -26910 5.69051E-19 5.69743E-19 -26920 5.68214E-19 5.68967E-19 -26930 5.67378E-19 5.68192E-19 -26940 5.66543E-19 5.67417E-19 -26950 5.65709E-19 5.66643E-19 -26960 5.64874E-19 5.65870E-19 -26970 5.64041E-19 5.65097E-19 -26980 5.63208E-19 5.64324E-19 -26990 5.62376E-19 5.63553E-19 -27000 5.61544E-19 5.62781E-19 -27010 5.60713E-19 5.62011E-19 -27020 5.59883E-19 5.61241E-19 -27030 5.59158E-19 5.60614E-19 -27040 5.58679E-19 5.60324E-19 -27050 5.58200E-19 5.60034E-19 -27060 5.57722E-19 5.59744E-19 -27070 5.57244E-19 5.59455E-19 -27080 5.56767E-19 5.59166E-19 -27090 5.56290E-19 5.58877E-19 -27100 5.55813E-19 5.58588E-19 -27110 5.55336E-19 5.58299E-19 -27120 5.54860E-19 5.58011E-19 -27130 5.54385E-19 5.57723E-19 -27140 5.53909E-19 5.57435E-19 -27150 5.53434E-19 5.57147E-19 -27160 5.52960E-19 5.56860E-19 -27170 5.52486E-19 5.56572E-19 -27180 5.52011E-19 5.56285E-19 -27190 5.51538E-19 5.55998E-19 -27200 5.51065E-19 5.55712E-19 -27210 5.50592E-19 5.55425E-19 -27220 5.50119E-19 5.55139E-19 -27230 5.49647E-19 5.54853E-19 -27240 5.49175E-19 5.54567E-19 -27250 5.48704E-19 5.54282E-19 -27260 5.48233E-19 5.53996E-19 -27270 5.47762E-19 5.53711E-19 -27280 5.47291E-19 5.53426E-19 -27290 5.46821E-19 5.53141E-19 -27300 5.46351E-19 5.52857E-19 -27310 5.45882E-19 5.52572E-19 -27320 5.45413E-19 5.52288E-19 -27330 5.44944E-19 5.52004E-19 -27340 5.44476E-19 5.51721E-19 -27350 5.44007E-19 5.51437E-19 -27360 5.43540E-19 5.51154E-19 -27370 5.43072E-19 5.50871E-19 -27380 5.42605E-19 5.50588E-19 -27390 5.42139E-19 5.50305E-19 -27400 5.41439E-19 5.49790E-19 -27410 5.40124E-19 5.48661E-19 -27420 5.38809E-19 5.47533E-19 -27430 5.37496E-19 5.46406E-19 -27440 5.36183E-19 5.45279E-19 -27450 5.34871E-19 5.44153E-19 -27460 5.33561E-19 5.43028E-19 -27470 5.32251E-19 5.41904E-19 -27480 5.30942E-19 5.40781E-19 -27490 5.29634E-19 5.39658E-19 -27500 5.28327E-19 5.38536E-19 -27510 5.27021E-19 5.37415E-19 -27520 5.25716E-19 5.36295E-19 -27530 5.24412E-19 5.35176E-19 -27540 5.23109E-19 5.34058E-19 -27550 5.21807E-19 5.32940E-19 -27560 5.20506E-19 5.31823E-19 -27570 5.19205E-19 5.30707E-19 -27580 5.17906E-19 5.29592E-19 -27590 5.16608E-19 5.28477E-19 -27600 5.15310E-19 5.27364E-19 -27610 5.14014E-19 5.26251E-19 -27620 5.12718E-19 5.25139E-19 -27630 5.11423E-19 5.24028E-19 -27640 5.10130E-19 5.22917E-19 -27650 5.08837E-19 5.21808E-19 -27660 5.07545E-19 5.20699E-19 -27670 5.06254E-19 5.19591E-19 -27680 5.04964E-19 5.18484E-19 -27690 5.03675E-19 5.17377E-19 -27700 5.02387E-19 5.16272E-19 -27710 5.01100E-19 5.15167E-19 -27720 4.99814E-19 5.14063E-19 -27730 4.98528E-19 5.12960E-19 -27740 4.97244E-19 5.11857E-19 -27750 4.95960E-19 5.10756E-19 -27760 4.94678E-19 5.09655E-19 -27770 4.93396E-19 5.08555E-19 -27780 4.92303E-19 5.07645E-19 -27790 4.91865E-19 5.07399E-19 -27800 4.91427E-19 5.07153E-19 -27810 4.90990E-19 5.06907E-19 -27820 4.90553E-19 5.06662E-19 -27830 4.90117E-19 5.06416E-19 -27840 4.89680E-19 5.06171E-19 -27850 4.89245E-19 5.05926E-19 -27860 4.88809E-19 5.05681E-19 -27870 4.88374E-19 5.05437E-19 -27880 4.87939E-19 5.05192E-19 -27890 4.87504E-19 5.04948E-19 -27900 4.87070E-19 5.04704E-19 -27910 4.86635E-19 5.04460E-19 -27920 4.86202E-19 5.04216E-19 -27930 4.85768E-19 5.03972E-19 -27940 4.85335E-19 5.03729E-19 -27950 4.84902E-19 5.03485E-19 -27960 4.84470E-19 5.03242E-19 -27970 4.84038E-19 5.02999E-19 -27980 4.83606E-19 5.02756E-19 -27990 4.83174E-19 5.02514E-19 -28000 4.82743E-19 5.02271E-19 -28010 4.82312E-19 5.02029E-19 -28020 4.81881E-19 5.01787E-19 -28030 4.81451E-19 5.01545E-19 -28040 4.81021E-19 5.01303E-19 -28050 4.80591E-19 5.01062E-19 -28060 4.80162E-19 5.00820E-19 -28070 4.79733E-19 5.00579E-19 -28080 4.79304E-19 5.00338E-19 -28090 4.78875E-19 5.00097E-19 -28100 4.78447E-19 4.99857E-19 -28110 4.78019E-19 4.99616E-19 -28120 4.77591E-19 4.99376E-19 -28130 4.77164E-19 4.99135E-19 -28140 4.76737E-19 4.98895E-19 -28150 4.76311E-19 4.98656E-19 -28160 4.75884E-19 4.98416E-19 -28170 4.75405E-19 4.98108E-19 -28180 4.74437E-19 4.97170E-19 -28190 4.73470E-19 4.96234E-19 -28200 4.72504E-19 4.95298E-19 -28210 4.71539E-19 4.94363E-19 -28220 4.70574E-19 4.93428E-19 -28230 4.69610E-19 4.92494E-19 -28240 4.68647E-19 4.91561E-19 -28250 4.67684E-19 4.90628E-19 -28260 4.66722E-19 4.89696E-19 -28270 4.65761E-19 4.88765E-19 -28280 4.64800E-19 4.87834E-19 -28290 4.63840E-19 4.86904E-19 -28300 4.62881E-19 4.85975E-19 -28310 4.61922E-19 4.85047E-19 -28320 4.60964E-19 4.84119E-19 -28330 4.60007E-19 4.83191E-19 -28340 4.59051E-19 4.82265E-19 -28350 4.58095E-19 4.81339E-19 -28360 4.57139E-19 4.80413E-19 -28370 4.56185E-19 4.79488E-19 -28380 4.55231E-19 4.78564E-19 -28390 4.54278E-19 4.77641E-19 -28400 4.53325E-19 4.76718E-19 -28410 4.52374E-19 4.75796E-19 -28420 4.51422E-19 4.74875E-19 -28430 4.50472E-19 4.73954E-19 -28440 4.49522E-19 4.73034E-19 -28450 4.48573E-19 4.72114E-19 -28460 4.47624E-19 4.71195E-19 -28470 4.46676E-19 4.70277E-19 -28480 4.45729E-19 4.69359E-19 -28490 4.44783E-19 4.68443E-19 -28500 4.43837E-19 4.67526E-19 -28510 4.42892E-19 4.66611E-19 -28520 4.41947E-19 4.65696E-19 -28530 4.41003E-19 4.64781E-19 -28540 4.40060E-19 4.63868E-19 -28550 4.39118E-19 4.62954E-19 -28560 4.38176E-19 4.62042E-19 -28570 4.37234E-19 4.61130E-19 -28580 4.36134E-19 4.60087E-19 -28590 4.35008E-19 4.59022E-19 -28600 4.33883E-19 4.57958E-19 -28610 4.32759E-19 4.56895E-19 -28620 4.31635E-19 4.55832E-19 -28630 4.30512E-19 4.54770E-19 -28640 4.29391E-19 4.53709E-19 -28650 4.28269E-19 4.52649E-19 -28660 4.27149E-19 4.51590E-19 -28670 4.26029E-19 4.50531E-19 -28680 4.24910E-19 4.49473E-19 -28690 4.23792E-19 4.48415E-19 -28700 4.22675E-19 4.47359E-19 -28710 4.21558E-19 4.46303E-19 -28720 4.20443E-19 4.45248E-19 -28730 4.19328E-19 4.44193E-19 -28740 4.18213E-19 4.43140E-19 -28750 4.17100E-19 4.42087E-19 -28760 4.15987E-19 4.41035E-19 -28770 4.14875E-19 4.39983E-19 -28780 4.13764E-19 4.38933E-19 -28790 4.12654E-19 4.37883E-19 -28800 4.11544E-19 4.36833E-19 -28810 4.10436E-19 4.35785E-19 -28820 4.09328E-19 4.34737E-19 -28830 4.08220E-19 4.33690E-19 -28840 4.07114E-19 4.32644E-19 -28850 4.06008E-19 4.31598E-19 -28860 4.04903E-19 4.30553E-19 -28870 4.03799E-19 4.29509E-19 -28880 4.02695E-19 4.28465E-19 -28890 4.01593E-19 4.27423E-19 -28900 4.00491E-19 4.26381E-19 -28910 3.99390E-19 4.25339E-19 -28920 3.98290E-19 4.24299E-19 -28930 3.97190E-19 4.23259E-19 -28940 3.96091E-19 4.22220E-19 -28950 3.94993E-19 4.21181E-19 -28960 3.93895E-19 4.20144E-19 -28970 3.92799E-19 4.19107E-19 -28980 3.91703E-19 4.18070E-19 -28990 3.90961E-19 4.17334E-19 -29000 3.90652E-19 4.16966E-19 -29010 3.90343E-19 4.16597E-19 -29020 3.90034E-19 4.16229E-19 -29030 3.89725E-19 4.15861E-19 -29040 3.89417E-19 4.15493E-19 -29050 3.89109E-19 4.15126E-19 -29060 3.88801E-19 4.14758E-19 -29070 3.88493E-19 4.14391E-19 -29080 3.88185E-19 4.14025E-19 -29090 3.87878E-19 4.13658E-19 -29100 3.87571E-19 4.13292E-19 -29110 3.87264E-19 4.12926E-19 -29120 3.86957E-19 4.12560E-19 -29130 3.86651E-19 4.12195E-19 -29140 3.86344E-19 4.11830E-19 -29150 3.86038E-19 4.11465E-19 -29160 3.85732E-19 4.11100E-19 -29170 3.85427E-19 4.10736E-19 -29180 3.85121E-19 4.10372E-19 -29190 3.84816E-19 4.10008E-19 -29200 3.84511E-19 4.09644E-19 -29210 3.84206E-19 4.09280E-19 -29220 3.83902E-19 4.08917E-19 -29230 3.83597E-19 4.08554E-19 -29240 3.83293E-19 4.08192E-19 -29250 3.82989E-19 4.07829E-19 -29260 3.82685E-19 4.07467E-19 -29270 3.82381E-19 4.07105E-19 -29280 3.82078E-19 4.06743E-19 -29290 3.81775E-19 4.06382E-19 -29300 3.81472E-19 4.06020E-19 -29310 3.81169E-19 4.05660E-19 -29320 3.80867E-19 4.05299E-19 -29330 3.80564E-19 4.04938E-19 -29340 3.80262E-19 4.04578E-19 -29350 3.79960E-19 4.04218E-19 -29360 3.79659E-19 4.03858E-19 -29370 3.79357E-19 4.03499E-19 -29380 3.79056E-19 4.03140E-19 -29390 3.78755E-19 4.02781E-19 -29400 3.78454E-19 4.02422E-19 -29410 3.78153E-19 4.02063E-19 -29420 3.77303E-19 4.01176E-19 -29430 3.76335E-19 4.00176E-19 -29440 3.75367E-19 3.99176E-19 -29450 3.74401E-19 3.98177E-19 -29460 3.73435E-19 3.97179E-19 -29470 3.72470E-19 3.96182E-19 -29480 3.71505E-19 3.95185E-19 -29490 3.70541E-19 3.94189E-19 -29500 3.69578E-19 3.93193E-19 -29510 3.68615E-19 3.92199E-19 -29520 3.67653E-19 3.91204E-19 -29530 3.66692E-19 3.90211E-19 -29540 3.65731E-19 3.89218E-19 -29550 3.64771E-19 3.88226E-19 -29560 3.63812E-19 3.87235E-19 -29570 3.62853E-19 3.86244E-19 -29580 3.61895E-19 3.85254E-19 -29590 3.60938E-19 3.84264E-19 -29600 3.59981E-19 3.83276E-19 -29610 3.59025E-19 3.82288E-19 -29620 3.58069E-19 3.81300E-19 -29630 3.57115E-19 3.80313E-19 -29640 3.56160E-19 3.79327E-19 -29650 3.55207E-19 3.78342E-19 -29660 3.54254E-19 3.77357E-19 -29670 3.53302E-19 3.76373E-19 -29680 3.52350E-19 3.75390E-19 -29690 3.51399E-19 3.74407E-19 -29700 3.50449E-19 3.73425E-19 -29710 3.49499E-19 3.72444E-19 -29720 3.48550E-19 3.71463E-19 -29730 3.47602E-19 3.70483E-19 -29740 3.46654E-19 3.69503E-19 -29750 3.45707E-19 3.68524E-19 -29760 3.44760E-19 3.67546E-19 -29770 3.43814E-19 3.66569E-19 -29780 3.42869E-19 3.65592E-19 -29790 3.41924E-19 3.64616E-19 -29800 3.40980E-19 3.63640E-19 -29810 3.40037E-19 3.62666E-19 -29820 3.39095E-19 3.61691E-19 -29830 3.38152E-19 3.60718E-19 -29840 3.37211E-19 3.59745E-19 -29850 3.36270E-19 3.58773E-19 -29860 3.35411E-19 3.57872E-19 -29870 3.34559E-19 3.56977E-19 -29880 3.33707E-19 3.56083E-19 -29890 3.32856E-19 3.55189E-19 -29900 3.32006E-19 3.54296E-19 -29910 3.31156E-19 3.53404E-19 -29920 3.30307E-19 3.52512E-19 -29930 3.29458E-19 3.51621E-19 -29940 3.28610E-19 3.50731E-19 -29950 3.27763E-19 3.49841E-19 -29960 3.26916E-19 3.48951E-19 -29970 3.26069E-19 3.48063E-19 -29980 3.25223E-19 3.47175E-19 -29990 3.24378E-19 3.46287E-19 -30000 3.23533E-19 3.45400E-19 -30010 3.22689E-19 3.44514E-19 -30020 3.21846E-19 3.43628E-19 -30030 3.21003E-19 3.42743E-19 -30040 3.20160E-19 3.41858E-19 -30050 3.19318E-19 3.40974E-19 -30060 3.18477E-19 3.40091E-19 -30070 3.17636E-19 3.39208E-19 -30080 3.16796E-19 3.38325E-19 -30090 3.15956E-19 3.37444E-19 -30100 3.15117E-19 3.36563E-19 -30110 3.14278E-19 3.35682E-19 -30120 3.13440E-19 3.34802E-19 -30130 3.12603E-19 3.33923E-19 -30140 3.11766E-19 3.33044E-19 -30150 3.10930E-19 3.32166E-19 -30160 3.10094E-19 3.31289E-19 -30170 3.09259E-19 3.30412E-19 -30180 3.08424E-19 3.29535E-19 -30190 3.07590E-19 3.28659E-19 -30200 3.06756E-19 3.27784E-19 -30210 3.05923E-19 3.26909E-19 -30220 3.05091E-19 3.26035E-19 -30230 3.04259E-19 3.25162E-19 -30240 3.03428E-19 3.24289E-19 -30250 3.02597E-19 3.23417E-19 -30260 3.01766E-19 3.22545E-19 -30270 3.00937E-19 3.21673E-19 -30280 3.00108E-19 3.20803E-19 -30290 2.99279E-19 3.19933E-19 -30300 2.98451E-19 3.19063E-19 -30310 2.97852E-19 3.18331E-19 -30320 2.97354E-19 3.17659E-19 -30330 2.96856E-19 3.16987E-19 -30340 2.96358E-19 3.16315E-19 -30350 2.95861E-19 3.15644E-19 -30360 2.95364E-19 3.14973E-19 -30370 2.94867E-19 3.14303E-19 -30380 2.94371E-19 3.13633E-19 -30390 2.93875E-19 3.12964E-19 -30400 2.93379E-19 3.12295E-19 -30410 2.92884E-19 3.11626E-19 -30420 2.92388E-19 3.10958E-19 -30430 2.91894E-19 3.10291E-19 -30440 2.91399E-19 3.09623E-19 -30450 2.90905E-19 3.08957E-19 -30460 2.90411E-19 3.08290E-19 -30470 2.89918E-19 3.07625E-19 -30480 2.89425E-19 3.06959E-19 -30490 2.88932E-19 3.06294E-19 -30500 2.88439E-19 3.05629E-19 -30510 2.87947E-19 3.04965E-19 -30520 2.87455E-19 3.04302E-19 -30530 2.86964E-19 3.03638E-19 -30540 2.86473E-19 3.02976E-19 -30550 2.85982E-19 3.02313E-19 -30560 2.85491E-19 3.01651E-19 -30570 2.85001E-19 3.00990E-19 -30580 2.84511E-19 3.00329E-19 -30590 2.84021E-19 2.99668E-19 -30600 2.83532E-19 2.99008E-19 -30610 2.83043E-19 2.98348E-19 -30620 2.82554E-19 2.97689E-19 -30630 2.82066E-19 2.97030E-19 -30640 2.81578E-19 2.96371E-19 -30650 2.81090E-19 2.95713E-19 -30660 2.80603E-19 2.95056E-19 -30670 2.80116E-19 2.94398E-19 -30680 2.79629E-19 2.93742E-19 -30690 2.79143E-19 2.93085E-19 -30700 2.78657E-19 2.92429E-19 -30710 2.78171E-19 2.91774E-19 -30720 2.77685E-19 2.91119E-19 -30730 2.77200E-19 2.90464E-19 -30740 2.76715E-19 2.89810E-19 -30750 2.76231E-19 2.89156E-19 -30760 2.75747E-19 2.88503E-19 -30770 2.75258E-19 2.87845E-19 -30780 2.74711E-19 2.87134E-19 -30790 2.74164E-19 2.86422E-19 -30800 2.73618E-19 2.85712E-19 -30810 2.73072E-19 2.85001E-19 -30820 2.72527E-19 2.84292E-19 -30830 2.71982E-19 2.83582E-19 -30840 2.71437E-19 2.82873E-19 -30850 2.70892E-19 2.82165E-19 -30860 2.70348E-19 2.81457E-19 -30870 2.69805E-19 2.80750E-19 -30880 2.69261E-19 2.80043E-19 -30890 2.68718E-19 2.79336E-19 -30900 2.68175E-19 2.78630E-19 -30910 2.67633E-19 2.77924E-19 -30920 2.67091E-19 2.77219E-19 -30930 2.66549E-19 2.76514E-19 -30940 2.66008E-19 2.75810E-19 -30950 2.65467E-19 2.75106E-19 -30960 2.64927E-19 2.74403E-19 -30970 2.64386E-19 2.73700E-19 -30980 2.63846E-19 2.72997E-19 -30990 2.63307E-19 2.72295E-19 -31000 2.62768E-19 2.71594E-19 -31010 2.62229E-19 2.70892E-19 -31020 2.61690E-19 2.70192E-19 -31030 2.61152E-19 2.69492E-19 -31040 2.60614E-19 2.68792E-19 -31050 2.60077E-19 2.68092E-19 -31060 2.59540E-19 2.67394E-19 -31070 2.59003E-19 2.66695E-19 -31080 2.58467E-19 2.65997E-19 -31090 2.57931E-19 2.65300E-19 -31100 2.57395E-19 2.64603E-19 -31110 2.56860E-19 2.63906E-19 -31120 2.56324E-19 2.63210E-19 -31130 2.55790E-19 2.62514E-19 -31140 2.55255E-19 2.61819E-19 -31150 2.54721E-19 2.61124E-19 -31160 2.54188E-19 2.60430E-19 -31170 2.53654E-19 2.59736E-19 -31180 2.53121E-19 2.59042E-19 -31190 2.52589E-19 2.58349E-19 -31200 2.52056E-19 2.57656E-19 -31210 2.51524E-19 2.56964E-19 -31220 2.50993E-19 2.56273E-19 -31230 2.50462E-19 2.55581E-19 -31240 2.49931E-19 2.54890E-19 -31250 2.49400E-19 2.54200E-19 -31260 2.48790E-19 2.53426E-19 -31270 2.48180E-19 2.52653E-19 -31280 2.47571E-19 2.51880E-19 -31290 2.46962E-19 2.51107E-19 -31300 2.46353E-19 2.50335E-19 -31310 2.45745E-19 2.49564E-19 -31320 2.45137E-19 2.48793E-19 -31330 2.44530E-19 2.48023E-19 -31340 2.43923E-19 2.47253E-19 -31350 2.43316E-19 2.46483E-19 -31360 2.42710E-19 2.45714E-19 -31370 2.42104E-19 2.44946E-19 -31380 2.41499E-19 2.44178E-19 -31390 2.40894E-19 2.43410E-19 -31400 2.40289E-19 2.42643E-19 -31410 2.39685E-19 2.41877E-19 -31420 2.39081E-19 2.41111E-19 -31430 2.38477E-19 2.40345E-19 -31440 2.37874E-19 2.39580E-19 -31450 2.37271E-19 2.38815E-19 -31460 2.36669E-19 2.38052E-19 -31470 2.36067E-19 2.37288E-19 -31480 2.35466E-19 2.36525E-19 -31490 2.34864E-19 2.35762E-19 -31500 2.34264E-19 2.35000E-19 -31510 2.33663E-19 2.34238E-19 -31520 2.33063E-19 2.33477E-19 -31530 2.32463E-19 2.32716E-19 -31540 2.31864E-19 2.31956E-19 -31550 2.31265E-19 2.31196E-19 -31560 2.30666E-19 2.30437E-19 -31570 2.30068E-19 2.29679E-19 -31580 2.29470E-19 2.28920E-19 -31590 2.28873E-19 2.28162E-19 -31600 2.28276E-19 2.27405E-19 -31610 2.27679E-19 2.26648E-19 -31620 2.27083E-19 2.25892E-19 -31630 2.26487E-19 2.25136E-19 -31640 2.25891E-19 2.24380E-19 -31650 2.25296E-19 2.23626E-19 -31660 2.24702E-19 2.22871E-19 -31670 2.24107E-19 2.22117E-19 -31680 2.23513E-19 2.21364E-19 -31690 2.22919E-19 2.20611E-19 -31700 2.22326E-19 2.19858E-19 -31710 2.21733E-19 2.19106E-19 -31720 2.21141E-19 2.18354E-19 -31730 2.20549E-19 2.17603E-19 -31740 2.19957E-19 2.16853E-19 -31750 2.19343E-19 2.16178E-19 -31760 2.18697E-19 2.15619E-19 -31770 2.18051E-19 2.15060E-19 -31780 2.17405E-19 2.14501E-19 -31790 2.16759E-19 2.13943E-19 -31800 2.16114E-19 2.13385E-19 -31810 2.15470E-19 2.12827E-19 -31820 2.14826E-19 2.12270E-19 -31830 2.14182E-19 2.11713E-19 -31840 2.13539E-19 2.11157E-19 -31850 2.12896E-19 2.10601E-19 -31860 2.12253E-19 2.10045E-19 -31870 2.11611E-19 2.09489E-19 -31880 2.10969E-19 2.08934E-19 -31890 2.10328E-19 2.08380E-19 -31900 2.09687E-19 2.07825E-19 -31910 2.09047E-19 2.07271E-19 -31920 2.08406E-19 2.06717E-19 -31930 2.07767E-19 2.06164E-19 -31940 2.07127E-19 2.05611E-19 -31950 2.06489E-19 2.05058E-19 -31960 2.05850E-19 2.04506E-19 -31970 2.05212E-19 2.03954E-19 -31980 2.04574E-19 2.03402E-19 -31990 2.03937E-19 2.02851E-19 -32000 2.03300E-19 2.02300E-19 -32010 2.02663E-19 2.01749E-19 -32020 2.02027E-19 2.01199E-19 -32030 2.01392E-19 2.00649E-19 -32040 2.00756E-19 2.00100E-19 -32050 2.00121E-19 1.99550E-19 -32060 1.99487E-19 1.99002E-19 -32070 1.98853E-19 1.98453E-19 -32080 1.98219E-19 1.97905E-19 -32090 1.97586E-19 1.97357E-19 -32100 1.96953E-19 1.96809E-19 -32110 1.96320E-19 1.96262E-19 -32120 1.95688E-19 1.95715E-19 -32130 1.95056E-19 1.95169E-19 -32140 1.94425E-19 1.94623E-19 -32150 1.93794E-19 1.94077E-19 -32160 1.93163E-19 1.93531E-19 -32170 1.92533E-19 1.92986E-19 -32180 1.91903E-19 1.92441E-19 -32190 1.91274E-19 1.91897E-19 -32200 1.90645E-19 1.91353E-19 -32210 1.90016E-19 1.90809E-19 -32220 1.89388E-19 1.90266E-19 -32230 1.88760E-19 1.89722E-19 -32240 1.88133E-19 1.89180E-19 -32250 1.87505E-19 1.88637E-19 -32260 1.86894E-19 1.88097E-19 -32270 1.86346E-19 1.87563E-19 -32280 1.85799E-19 1.87029E-19 -32290 1.85252E-19 1.86495E-19 -32300 1.84706E-19 1.85962E-19 -32310 1.84160E-19 1.85430E-19 -32320 1.83614E-19 1.84897E-19 -32330 1.83068E-19 1.84365E-19 -32340 1.82523E-19 1.83833E-19 -32350 1.81978E-19 1.83302E-19 -32360 1.81434E-19 1.82771E-19 -32370 1.80890E-19 1.82240E-19 -32380 1.80346E-19 1.81709E-19 -32390 1.79802E-19 1.81179E-19 -32400 1.79259E-19 1.80649E-19 -32410 1.78716E-19 1.80120E-19 -32420 1.78174E-19 1.79591E-19 -32430 1.77632E-19 1.79062E-19 -32440 1.77090E-19 1.78533E-19 -32450 1.76549E-19 1.78005E-19 -32460 1.76007E-19 1.77477E-19 -32470 1.75467E-19 1.76950E-19 -32480 1.74926E-19 1.76423E-19 -32490 1.74386E-19 1.75896E-19 -32500 1.73846E-19 1.75369E-19 -32510 1.73307E-19 1.74843E-19 -32520 1.72768E-19 1.74317E-19 -32530 1.72229E-19 1.73792E-19 -32540 1.71690E-19 1.73266E-19 -32550 1.71152E-19 1.72741E-19 -32560 1.70614E-19 1.72217E-19 -32570 1.70077E-19 1.71692E-19 -32580 1.69540E-19 1.71168E-19 -32590 1.69003E-19 1.70645E-19 -32600 1.68466E-19 1.70121E-19 -32610 1.67930E-19 1.69598E-19 -32620 1.67394E-19 1.69076E-19 -32630 1.66859E-19 1.68553E-19 -32640 1.66324E-19 1.68031E-19 -32650 1.65789E-19 1.67510E-19 -32660 1.65254E-19 1.66988E-19 -32670 1.64720E-19 1.66467E-19 -32680 1.64186E-19 1.65946E-19 -32690 1.63653E-19 1.65426E-19 -32700 1.63119E-19 1.64906E-19 -32710 1.62586E-19 1.64386E-19 -32720 1.62054E-19 1.63866E-19 -32730 1.61522E-19 1.63347E-19 -32740 1.60990E-19 1.62828E-19 -32750 1.60458E-19 1.62310E-19 -32760 1.59927E-19 1.61792E-19 -32770 1.59396E-19 1.61274E-19 -32780 1.58865E-19 1.60756E-19 -32790 1.58324E-19 1.60223E-19 -32800 1.57761E-19 1.59656E-19 -32810 1.57198E-19 1.59089E-19 -32820 1.56635E-19 1.58523E-19 -32830 1.56073E-19 1.57957E-19 -32840 1.55511E-19 1.57391E-19 -32850 1.54949E-19 1.56825E-19 -32860 1.54387E-19 1.56260E-19 -32870 1.53826E-19 1.55696E-19 -32880 1.53266E-19 1.55131E-19 -32890 1.52705E-19 1.54567E-19 -32900 1.52145E-19 1.54003E-19 -32910 1.51586E-19 1.53440E-19 -32920 1.51026E-19 1.52877E-19 -32930 1.50467E-19 1.52314E-19 -32940 1.49909E-19 1.51752E-19 -32950 1.49350E-19 1.51190E-19 -32960 1.48792E-19 1.50628E-19 -32970 1.48235E-19 1.50067E-19 -32980 1.47677E-19 1.49506E-19 -32990 1.47120E-19 1.48945E-19 -33000 1.46564E-19 1.48385E-19 -33010 1.46007E-19 1.47825E-19 -33020 1.45451E-19 1.47265E-19 -33030 1.44896E-19 1.46706E-19 -33040 1.44340E-19 1.46147E-19 -33050 1.43785E-19 1.45588E-19 -33060 1.43231E-19 1.45030E-19 -33070 1.42677E-19 1.44472E-19 -33080 1.42123E-19 1.43915E-19 -33090 1.41569E-19 1.43357E-19 -33100 1.41016E-19 1.42800E-19 -33110 1.40463E-19 1.42244E-19 -33120 1.39910E-19 1.41687E-19 -33130 1.39358E-19 1.41132E-19 -33140 1.38806E-19 1.40576E-19 -33150 1.38254E-19 1.40021E-19 -33160 1.37703E-19 1.39466E-19 -33170 1.37152E-19 1.38911E-19 -33180 1.36601E-19 1.38357E-19 -33190 1.36051E-19 1.37803E-19 -33200 1.35501E-19 1.37249E-19 -33210 1.34952E-19 1.36696E-19 -33220 1.34402E-19 1.36143E-19 -33230 1.33853E-19 1.35591E-19 -33240 1.33305E-19 1.35038E-19 -33250 1.32756E-19 1.34486E-19 -33260 1.32208E-19 1.33935E-19 -33270 1.31661E-19 1.33384E-19 -33280 1.31113E-19 1.32833E-19 -33290 1.30566E-19 1.32282E-19 -33300 1.30020E-19 1.31732E-19 -33310 1.29474E-19 1.31182E-19 -33320 1.28927E-19 1.30632E-19 -33330 1.28382E-19 1.30083E-19 -33340 1.27938E-19 1.29618E-19 -33350 1.27546E-19 1.29195E-19 -33360 1.27154E-19 1.28773E-19 -33370 1.26763E-19 1.28351E-19 -33380 1.26371E-19 1.27929E-19 -33390 1.25980E-19 1.27507E-19 -33400 1.25589E-19 1.27086E-19 -33410 1.25198E-19 1.26664E-19 -33420 1.24808E-19 1.26244E-19 -33430 1.24418E-19 1.25823E-19 -33440 1.24028E-19 1.25402E-19 -33450 1.23638E-19 1.24982E-19 -33460 1.23248E-19 1.24562E-19 -33470 1.22859E-19 1.24143E-19 -33480 1.22470E-19 1.23723E-19 -33490 1.22081E-19 1.23304E-19 -33500 1.21693E-19 1.22885E-19 -33510 1.21304E-19 1.22466E-19 -33520 1.20916E-19 1.22048E-19 -33530 1.20528E-19 1.21630E-19 -33540 1.20140E-19 1.21212E-19 -33550 1.19753E-19 1.20794E-19 -33560 1.19366E-19 1.20377E-19 -33570 1.18979E-19 1.19960E-19 -33580 1.18592E-19 1.19543E-19 -33590 1.18205E-19 1.19126E-19 -33600 1.17819E-19 1.18710E-19 -33610 1.17433E-19 1.18293E-19 -33620 1.17047E-19 1.17877E-19 -33630 1.16662E-19 1.17462E-19 -33640 1.16276E-19 1.17046E-19 -33650 1.15891E-19 1.16631E-19 -33660 1.15506E-19 1.16216E-19 -33670 1.15121E-19 1.15801E-19 -33680 1.14737E-19 1.15387E-19 -33690 1.14353E-19 1.14973E-19 -33700 1.13969E-19 1.14559E-19 -33710 1.13585E-19 1.14145E-19 -33720 1.13201E-19 1.13732E-19 -33730 1.12818E-19 1.13318E-19 -33740 1.12435E-19 1.12905E-19 -33750 1.12052E-19 1.12493E-19 -33760 1.11669E-19 1.12080E-19 -33770 1.11287E-19 1.11668E-19 -33780 1.10905E-19 1.11256E-19 -33790 1.10523E-19 1.10844E-19 -33800 1.10141E-19 1.10433E-19 -33810 1.09759E-19 1.10021E-19 -33820 1.09378E-19 1.09610E-19 -33830 1.08997E-19 1.09199E-19 -33840 1.08616E-19 1.08789E-19 -33850 1.08235E-19 1.08379E-19 -33860 1.07855E-19 1.07968E-19 -33870 1.07475E-19 1.07559E-19 -33880 1.07095E-19 1.07149E-19 -33890 1.06715E-19 1.06740E-19 -33900 1.06345E-19 1.06341E-19 -33910 1.06024E-19 1.05993E-19 -33920 1.05702E-19 1.05645E-19 -33930 1.05380E-19 1.05298E-19 -33940 1.05059E-19 1.04950E-19 -33950 1.04738E-19 1.04603E-19 -33960 1.04417E-19 1.04256E-19 -33970 1.04096E-19 1.03910E-19 -33980 1.03776E-19 1.03563E-19 -33990 1.03455E-19 1.03217E-19 -34000 1.03135E-19 1.02871E-19 -34010 1.02815E-19 1.02525E-19 -34020 1.02495E-19 1.02179E-19 -34030 1.02176E-19 1.01833E-19 -34040 1.01856E-19 1.01488E-19 -34050 1.01537E-19 1.01143E-19 -34060 1.01218E-19 1.00798E-19 -34070 1.00899E-19 1.00453E-19 -34080 1.00581E-19 1.00109E-19 -34090 1.00262E-19 9.97647E-20 -34100 9.99440E-20 9.94205E-20 -34110 9.96259E-20 9.90767E-20 -34120 9.93079E-20 9.87329E-20 -34130 9.89902E-20 9.83895E-20 -34140 9.86727E-20 9.80462E-20 -34150 9.83553E-20 9.77030E-20 -34160 9.80381E-20 9.73602E-20 -34170 9.77212E-20 9.70175E-20 -34180 9.74044E-20 9.66750E-20 -34190 9.70878E-20 9.63327E-20 -34200 9.67713E-20 9.59906E-20 -34210 9.64551E-20 9.56487E-20 -34220 9.61390E-20 9.53070E-20 -34230 9.58232E-20 9.49656E-20 -34240 9.55075E-20 9.46243E-20 -34250 9.51920E-20 9.42832E-20 -34260 9.48766E-20 9.39423E-20 -34270 9.45615E-20 9.36017E-20 -34280 9.42465E-20 9.32611E-20 -34290 9.39318E-20 9.29209E-20 -34300 9.36172E-20 9.25808E-20 -34310 9.33028E-20 9.22408E-20 -34320 9.29886E-20 9.19012E-20 -34330 9.26745E-20 9.15616E-20 -34340 9.23607E-20 9.12224E-20 -34350 9.20471E-20 9.08833E-20 -34360 9.17335E-20 9.05443E-20 -34370 9.14202E-20 9.02057E-20 -34380 9.11071E-20 8.98671E-20 -34390 9.07941E-20 8.95288E-20 -34400 9.04814E-20 8.91907E-20 -34410 9.01688E-20 8.88527E-20 -34420 8.98564E-20 8.85150E-20 -34430 8.95442E-20 8.81775E-20 -34440 8.92322E-20 8.78402E-20 -34450 8.89203E-20 8.75030E-20 -34460 8.86087E-20 8.71661E-20 -34470 8.82972E-20 8.68294E-20 -34480 8.79858E-20 8.64928E-20 -34490 8.76491E-20 8.61784E-20 -34500 8.73029E-20 8.58725E-20 -34510 8.69568E-20 8.55667E-20 -34520 8.66110E-20 8.52612E-20 -34530 8.62654E-20 8.49558E-20 -34540 8.59200E-20 8.46506E-20 -34550 8.55747E-20 8.43456E-20 -34560 8.52296E-20 8.40407E-20 -34570 8.48847E-20 8.37360E-20 -34580 8.45401E-20 8.34316E-20 -34590 8.41957E-20 8.31273E-20 -34600 8.38514E-20 8.28231E-20 -34610 8.35074E-20 8.25192E-20 -34620 8.31635E-20 8.22153E-20 -34630 8.28199E-20 8.19118E-20 -34640 8.24764E-20 8.16083E-20 -34650 8.21332E-20 8.13051E-20 -34660 8.17901E-20 8.10019E-20 -34670 8.14473E-20 8.06991E-20 -34680 8.11046E-20 8.03963E-20 -34690 8.07621E-20 8.00937E-20 -34700 8.04199E-20 7.97914E-20 -34710 8.00778E-20 7.94892E-20 -34720 7.97359E-20 7.91871E-20 -34730 7.93942E-20 7.88852E-20 -34740 7.90528E-20 7.85835E-20 -34750 7.87115E-20 7.82820E-20 -34760 7.83704E-20 7.79806E-20 -34770 7.80295E-20 7.76795E-20 -34780 7.76888E-20 7.73785E-20 -34790 7.73483E-20 7.70777E-20 -34800 7.70081E-20 7.67770E-20 -34810 7.66680E-20 7.64766E-20 -34820 7.63280E-20 7.61762E-20 -34830 7.59883E-20 7.58761E-20 -34840 7.56488E-20 7.55762E-20 -34850 7.53095E-20 7.52763E-20 -34860 7.49704E-20 7.49767E-20 -34870 7.46314E-20 7.46773E-20 -34880 7.42926E-20 7.43780E-20 -34890 7.39542E-20 7.40789E-20 -34900 7.36158E-20 7.37800E-20 -34910 7.32776E-20 7.34812E-20 -34920 7.29397E-20 7.31826E-20 -34930 7.26019E-20 7.28842E-20 -34940 7.22643E-20 7.25860E-20 -34950 7.19269E-20 7.22878E-20 -34960 7.15897E-20 7.19899E-20 -34970 7.12527E-20 7.16922E-20 -34980 7.09159E-20 7.13946E-20 -34990 7.05793E-20 7.10972E-20 -35000 7.02428E-20 7.08000E-20 -35010 6.99066E-20 7.05029E-20 -35020 6.95706E-20 7.02061E-20 -35030 6.92348E-20 6.99094E-20 -35040 6.88991E-20 6.96128E-20 -35050 6.85637E-20 6.93164E-20 -35060 6.82283E-20 6.90202E-20 -35070 6.78933E-20 6.87241E-20 -35080 6.75584E-20 6.84283E-20 -35090 6.72481E-20 6.81426E-20 -35100 6.70208E-20 6.78909E-20 -35110 6.67936E-20 6.76393E-20 -35120 6.65665E-20 6.73879E-20 -35130 6.63396E-20 6.71366E-20 -35140 6.61127E-20 6.68855E-20 -35150 6.58861E-20 6.66346E-20 -35160 6.56595E-20 6.63837E-20 -35170 6.54330E-20 6.61330E-20 -35180 6.52068E-20 6.58825E-20 -35190 6.49806E-20 6.56321E-20 -35200 6.47546E-20 6.53818E-20 -35210 6.45286E-20 6.51317E-20 -35220 6.43029E-20 6.48817E-20 -35230 6.40772E-20 6.46319E-20 -35240 6.38517E-20 6.43822E-20 -35250 6.36262E-20 6.41326E-20 -35260 6.34010E-20 6.38832E-20 -35270 6.31758E-20 6.36339E-20 -35280 6.29508E-20 6.33848E-20 -35290 6.27259E-20 6.31358E-20 -35300 6.25011E-20 6.28869E-20 -35310 6.22765E-20 6.26382E-20 -35320 6.20520E-20 6.23897E-20 -35330 6.18276E-20 6.21413E-20 -35340 6.16033E-20 6.18930E-20 -35350 6.13792E-20 6.16448E-20 -35360 6.11552E-20 6.13968E-20 -35370 6.09313E-20 6.11489E-20 -35380 6.07076E-20 6.09012E-20 -35390 6.04840E-20 6.06537E-20 -35400 6.02604E-20 6.04062E-20 -35410 6.00371E-20 6.01589E-20 -35420 5.98138E-20 5.99117E-20 -35430 5.95907E-20 5.96647E-20 -35440 5.93677E-20 5.94178E-20 -35450 5.91449E-20 5.91711E-20 -35460 5.89221E-20 5.89244E-20 -35470 5.86995E-20 5.86780E-20 -35480 5.84770E-20 5.84317E-20 -35490 5.82546E-20 5.81855E-20 -35500 5.80324E-20 5.79394E-20 -35510 5.78103E-20 5.76935E-20 -35520 5.75883E-20 5.74478E-20 -35530 5.73664E-20 5.72021E-20 -35540 5.71447E-20 5.69566E-20 -35550 5.69230E-20 5.67112E-20 -35560 5.67016E-20 5.64660E-20 -35570 5.64802E-20 5.62210E-20 -35580 5.62589E-20 5.59760E-20 -35590 5.60379E-20 5.57312E-20 -35600 5.58169E-20 5.54865E-20 -35610 5.55960E-20 5.52420E-20 -35620 5.53753E-20 5.49976E-20 -35630 5.51546E-20 5.47533E-20 -35640 5.49341E-20 5.45092E-20 -35650 5.47137E-20 5.42652E-20 -35660 5.44935E-20 5.40214E-20 -35670 5.42734E-20 5.37777E-20 -35680 5.40534E-20 5.35341E-20 -35690 5.38335E-20 5.32906E-20 -35700 5.36137E-20 5.30473E-20 -35710 5.33941E-20 5.28041E-20 -35720 5.31952E-20 5.25916E-20 -35730 5.30118E-20 5.24020E-20 -35740 5.28286E-20 5.22125E-20 -35750 5.26455E-20 5.20231E-20 -35760 5.24624E-20 5.18338E-20 -35770 5.22795E-20 5.16446E-20 -35780 5.20966E-20 5.14555E-20 -35790 5.19139E-20 5.12666E-20 -35800 5.17313E-20 5.10777E-20 -35810 5.15488E-20 5.08889E-20 -35820 5.13664E-20 5.07002E-20 -35830 5.11840E-20 5.05117E-20 -35840 5.10018E-20 5.03232E-20 -35850 5.08197E-20 5.01349E-20 -35860 5.06376E-20 4.99466E-20 -35870 5.04557E-20 4.97585E-20 -35880 5.02739E-20 4.95705E-20 -35890 5.00922E-20 4.93825E-20 -35900 4.99106E-20 4.91947E-20 -35910 4.97291E-20 4.90070E-20 -35920 4.95477E-20 4.88194E-20 -35930 4.93663E-20 4.86318E-20 -35940 4.91851E-20 4.84444E-20 -35950 4.90040E-20 4.82571E-20 -35960 4.88230E-20 4.80700E-20 -35970 4.86421E-20 4.78829E-20 -35980 4.84613E-20 4.76959E-20 -35990 4.82806E-20 4.75090E-20 -36000 4.81000E-20 4.73222E-20 -36010 4.79195E-20 4.71355E-20 -36020 4.77391E-20 4.69490E-20 -36030 4.75588E-20 4.67625E-20 -36040 4.73786E-20 4.65761E-20 -36050 4.71985E-20 4.63899E-20 -36060 4.70184E-20 4.62037E-20 -36070 4.68385E-20 4.60176E-20 -36080 4.66588E-20 4.58317E-20 -36090 4.64790E-20 4.56458E-20 -36100 4.62994E-20 4.54601E-20 -36110 4.61199E-20 4.52745E-20 -36120 4.59405E-20 4.50889E-20 -36130 4.57612E-20 4.49035E-20 -36140 4.55820E-20 4.47181E-20 -36150 4.54029E-20 4.45329E-20 -36160 4.52239E-20 4.43478E-20 -36170 4.50450E-20 4.41628E-20 -36180 4.48662E-20 4.39778E-20 -36190 4.46875E-20 4.37930E-20 -36200 4.45088E-20 4.36083E-20 -36210 4.43303E-20 4.34236E-20 -36220 4.41519E-20 4.32391E-20 -36230 4.39736E-20 4.30547E-20 -36240 4.37953E-20 4.28704E-20 -36250 4.36172E-20 4.26862E-20 -36260 4.34392E-20 4.25021E-20 -36270 4.32613E-20 4.23181E-20 -36280 4.30835E-20 4.21342E-20 -36290 4.29057E-20 4.19504E-20 -36300 4.27281E-20 4.17667E-20 -36310 4.25506E-20 4.15831E-20 -36320 4.23731E-20 4.13996E-20 -36330 4.21958E-20 4.12162E-20 -36340 4.20185E-20 4.10328E-20 -36350 4.18414E-20 4.08497E-20 -36360 4.16644E-20 4.06666E-20 -36370 4.14884E-20 4.04903E-20 -36380 4.13130E-20 4.03179E-20 -36390 4.11378E-20 4.01458E-20 -36400 4.09626E-20 3.99736E-20 -36410 4.07876E-20 3.98016E-20 -36420 4.06126E-20 3.96297E-20 -36430 4.04378E-20 3.94578E-20 -36440 4.02630E-20 3.92860E-20 -36450 4.00883E-20 3.91144E-20 -36460 3.99138E-20 3.89428E-20 -36470 3.97393E-20 3.87714E-20 -36480 3.95649E-20 3.86000E-20 -36490 3.93906E-20 3.84287E-20 -36500 3.92164E-20 3.82575E-20 -36510 3.90423E-20 3.80864E-20 -36520 3.88683E-20 3.79154E-20 -36530 3.86944E-20 3.77445E-20 -36540 3.85206E-20 3.75737E-20 -36550 3.83469E-20 3.74030E-20 -36560 3.81733E-20 3.72324E-20 -36570 3.79998E-20 3.70619E-20 -36580 3.78264E-20 3.68914E-20 -36590 3.76530E-20 3.67210E-20 -36600 3.74798E-20 3.65508E-20 -36610 3.73066E-20 3.63807E-20 -36620 3.71336E-20 3.62106E-20 -36630 3.69606E-20 3.60406E-20 -36640 3.67878E-20 3.58707E-20 -36650 3.66150E-20 3.57010E-20 -36660 3.64424E-20 3.55313E-20 -36670 3.62698E-20 3.53617E-20 -36680 3.60972E-20 3.51921E-20 -36690 3.59249E-20 3.50227E-20 -36700 3.57526E-20 3.48534E-20 -36710 3.55804E-20 3.46842E-20 -36720 3.54083E-20 3.45150E-20 -36730 3.52363E-20 3.43460E-20 -36740 3.50644E-20 3.41770E-20 -36750 3.48925E-20 3.40081E-20 -36760 3.47208E-20 3.38394E-20 -36770 3.45491E-20 3.36707E-20 -36780 3.43776E-20 3.35021E-20 -36790 3.42061E-20 3.33336E-20 -36800 3.40348E-20 3.31652E-20 -36810 3.38635E-20 3.29969E-20 -36820 3.36923E-20 3.28287E-20 -36830 3.35212E-20 3.26605E-20 -36840 3.33503E-20 3.24925E-20 -36850 3.31794E-20 3.23245E-20 -36860 3.30086E-20 3.21567E-20 -36870 3.28379E-20 3.19889E-20 -36880 3.26673E-20 3.18213E-20 -36890 3.24967E-20 3.16537E-20 -36900 3.23263E-20 3.14862E-20 -36910 3.21560E-20 3.13188E-20 -36920 3.19857E-20 3.11515E-20 -36930 3.18156E-20 3.09843E-20 -36940 3.16455E-20 3.08171E-20 -36950 3.14755E-20 3.06500E-20 -36960 3.13056E-20 3.04831E-20 -36970 3.11358E-20 3.03162E-20 -36980 3.09661E-20 3.01495E-20 -36990 3.07965E-20 2.99828E-20 -37000 3.06270E-20 2.98162E-20 -37010 3.04576E-20 2.96497E-20 -37020 3.02883E-20 2.94833E-20 -37030 3.01191E-20 2.93170E-20 -37040 2.99551E-20 2.91680E-20 -37050 2.98035E-20 2.90602E-20 -37060 2.96520E-20 2.89524E-20 -37070 2.95006E-20 2.88447E-20 -37080 2.93493E-20 2.87370E-20 -37090 2.91981E-20 2.86294E-20 -37100 2.90469E-20 2.85218E-20 -37110 2.88958E-20 2.84143E-20 -37120 2.87448E-20 2.83069E-20 -37130 2.85939E-20 2.81995E-20 -37140 2.84431E-20 2.80922E-20 -37150 2.82923E-20 2.79849E-20 -37160 2.81417E-20 2.78777E-20 -37170 2.79910E-20 2.77706E-20 -37180 2.78406E-20 2.76635E-20 -37190 2.76901E-20 2.75564E-20 -37200 2.75398E-20 2.74495E-20 -37210 2.73895E-20 2.73426E-20 -37220 2.72393E-20 2.72357E-20 -37230 2.70892E-20 2.71289E-20 -37240 2.69392E-20 2.70221E-20 -37250 2.67893E-20 2.69154E-20 -37260 2.66394E-20 2.68088E-20 -37270 2.64896E-20 2.67022E-20 -37280 2.63399E-20 2.65957E-20 -37290 2.61903E-20 2.64892E-20 -37300 2.60407E-20 2.63828E-20 -37310 2.58913E-20 2.62765E-20 -37320 2.57419E-20 2.61702E-20 -37330 2.55926E-20 2.60640E-20 -37340 2.54434E-20 2.59578E-20 -37350 2.52943E-20 2.58517E-20 -37360 2.51452E-20 2.57456E-20 -37370 2.49962E-20 2.56396E-20 -37380 2.48473E-20 2.55336E-20 -37390 2.46985E-20 2.54278E-20 -37400 2.45497E-20 2.53219E-20 -37410 2.44011E-20 2.52161E-20 -37420 2.42525E-20 2.51104E-20 -37430 2.41040E-20 2.50048E-20 -37440 2.39556E-20 2.48991E-20 -37450 2.38072E-20 2.47936E-20 -37460 2.36589E-20 2.46881E-20 -37470 2.35108E-20 2.45827E-20 -37480 2.33626E-20 2.44773E-20 -37490 2.32146E-20 2.43719E-20 -37500 2.30667E-20 2.42667E-20 -37510 2.29188E-20 2.41615E-20 -37520 2.27710E-20 2.40563E-20 -37530 2.26233E-20 2.39512E-20 -37540 2.24756E-20 2.38461E-20 -37550 2.23281E-20 2.37412E-20 -37560 2.21806E-20 2.36362E-20 -37570 2.20332E-20 2.35313E-20 -37580 2.18859E-20 2.34265E-20 -37590 2.17387E-20 2.33217E-20 -37600 2.15915E-20 2.32170E-20 -37610 2.14444E-20 2.31124E-20 -37620 2.12974E-20 2.30078E-20 -37630 2.11505E-20 2.29032E-20 -37640 2.10036E-20 2.27987E-20 -37650 2.08568E-20 2.26943E-20 -37660 2.07101E-20 2.25899E-20 -37670 2.05635E-20 2.24856E-20 -37680 2.04170E-20 2.23813E-20 -37690 2.02705E-20 2.22771E-20 -37700 2.01241E-20 2.21729E-20 -37710 1.99778E-20 2.20688E-20 -37720 1.98316E-20 2.19648E-20 -37730 1.96855E-20 2.18608E-20 -37740 1.95464E-20 2.17627E-20 -37750 1.94172E-20 2.16728E-20 -37760 1.92882E-20 2.15831E-20 -37770 1.91591E-20 2.14933E-20 -37780 1.90302E-20 2.14036E-20 -37790 1.89013E-20 2.13139E-20 -37800 1.87725E-20 2.12243E-20 -37810 1.86437E-20 2.11348E-20 -37820 1.85151E-20 2.10453E-20 -37830 1.83865E-20 2.09558E-20 -37840 1.82579E-20 2.08664E-20 -37850 1.81294E-20 2.07770E-20 -37860 1.80010E-20 2.06877E-20 -37870 1.78727E-20 2.05984E-20 -37880 1.77445E-20 2.05092E-20 -37890 1.76162E-20 2.04200E-20 -37900 1.74881E-20 2.03309E-20 -37910 1.73601E-20 2.02418E-20 -37920 1.72321E-20 2.01527E-20 -37930 1.71041E-20 2.00637E-20 -37940 1.69763E-20 1.99748E-20 -37950 1.68485E-20 1.98859E-20 -37960 1.67208E-20 1.97971E-20 -37970 1.65931E-20 1.97083E-20 -37980 1.64655E-20 1.96195E-20 -37990 1.63380E-20 1.95308E-20 -38000 1.62105E-20 1.94421E-20 -38010 1.60832E-20 1.93535E-20 -38020 1.59558E-20 1.92649E-20 -38030 1.58285E-20 1.91764E-20 -38040 1.57014E-20 1.90879E-20 -38050 1.55742E-20 1.89995E-20 -38060 1.54472E-20 1.89111E-20 -38070 1.53202E-20 1.88228E-20 -38080 1.51933E-20 1.87345E-20 -38090 1.50664E-20 1.86462E-20 -38100 1.49396E-20 1.85580E-20 -38110 1.48129E-20 1.84698E-20 -38120 1.46863E-20 1.83817E-20 -38130 1.45597E-20 1.82937E-20 -38140 1.44331E-20 1.82057E-20 -38150 1.43067E-20 1.81177E-20 -38160 1.41803E-20 1.80298E-20 -38170 1.40540E-20 1.79419E-20 -38180 1.39277E-20 1.78541E-20 -38190 1.38015E-20 1.77663E-20 -38200 1.36754E-20 1.76785E-20 -38210 1.35493E-20 1.75908E-20 -38220 1.34233E-20 1.75032E-20 -38230 1.32974E-20 1.74156E-20 -38240 1.31715E-20 1.73280E-20 -38250 1.30458E-20 1.72405E-20 -38260 1.29200E-20 1.71531E-20 -38270 1.27943E-20 1.70656E-20 -38280 1.26687E-20 1.69782E-20 -38290 1.25432E-20 1.68909E-20 -38300 1.24178E-20 1.68037E-20 -38310 1.22923E-20 1.67164E-20 -38320 1.21670E-20 1.66292E-20 -38330 1.20418E-20 1.65421E-20 -38340 1.19165E-20 1.64550E-20 -38350 1.17914E-20 1.63679E-20 -38360 1.16663E-20 1.62809E-20 -38370 1.15413E-20 1.61940E-20 -38380 1.14164E-20 1.61070E-20 -38390 1.12915E-20 1.60202E-20 -38400 1.11667E-20 1.59333E-20 -38410 1.10419E-20 1.58466E-20 -38420 1.09172E-20 1.57598E-20 -38430 1.07926E-20 1.56731E-20 -38440 1.06680E-20 1.55865E-20 -38450 1.05436E-20 1.54999E-20 -38460 1.04191E-20 1.54133E-20 -38470 1.03771E-20 1.53485E-20 -38480 1.03501E-20 1.52877E-20 -38490 1.03231E-20 1.52270E-20 -38500 1.02961E-20 1.51662E-20 -38510 1.02691E-20 1.51055E-20 -38520 1.02422E-20 1.50449E-20 -38530 1.02152E-20 1.49842E-20 -38540 1.01883E-20 1.49236E-20 -38550 1.01613E-20 1.48630E-20 -38560 1.01344E-20 1.48025E-20 -38570 1.01075E-20 1.47420E-20 -38580 1.00807E-20 1.46815E-20 -38590 1.00538E-20 1.46210E-20 -38600 1.00269E-20 1.45606E-20 -38610 1.00001E-20 1.45002E-20 -38620 9.97328E-21 1.44399E-20 -38630 9.94646E-21 1.43795E-20 -38640 9.91967E-21 1.43193E-20 -38650 9.89288E-21 1.42590E-20 -38660 9.86611E-21 1.41988E-20 -38670 9.83936E-21 1.41385E-20 -38680 9.81262E-21 1.40784E-20 -38690 9.78589E-21 1.40182E-20 -38700 9.75917E-21 1.39581E-20 -38710 9.73247E-21 1.38981E-20 -38720 9.70578E-21 1.38380E-20 -38730 9.67911E-21 1.37780E-20 -38740 9.65245E-21 1.37180E-20 -38750 9.62581E-21 1.36581E-20 -38760 9.59917E-21 1.35981E-20 -38770 9.57256E-21 1.35383E-20 -38780 9.54595E-21 1.34784E-20 -38790 9.51936E-21 1.34186E-20 -38800 9.49278E-21 1.33588E-20 -38810 9.46622E-21 1.32990E-20 -38820 9.43967E-21 1.32393E-20 -38830 9.41313E-21 1.31796E-20 -38840 9.38661E-21 1.31199E-20 -38850 9.36011E-21 1.30602E-20 -38860 9.33360E-21 1.30006E-20 -38870 9.30713E-21 1.29410E-20 -38880 9.28065E-21 1.28815E-20 -38890 9.25421E-21 1.28220E-20 -38900 9.22776E-21 1.27625E-20 -38910 9.20134E-21 1.27030E-20 -38920 9.17492E-21 1.26436E-20 -38930 9.14853E-21 1.25842E-20 -38940 9.12214E-21 1.25248E-20 -38950 9.09576E-21 1.24655E-20 -38960 9.06940E-21 1.24062E-20 -38970 9.04306E-21 1.23469E-20 -38980 9.01673E-21 1.22876E-20 -38990 8.99041E-21 1.22284E-20 -39000 8.96410E-21 1.21692E-20 -39010 8.93781E-21 1.21101E-20 -39020 8.91153E-21 1.20509E-20 -39030 8.88526E-21 1.19918E-20 -39040 8.85901E-21 1.19328E-20 -39050 8.83278E-21 1.18738E-20 -39060 8.80655E-21 1.18147E-20 -39070 8.78034E-21 1.17558E-20 -39080 8.75414E-21 1.16968E-20 -39090 8.72796E-21 1.16379E-20 -39100 8.70179E-21 1.15790E-20 -39110 8.67563E-21 1.15202E-20 -39120 8.64949E-21 1.14614E-20 -39130 8.62336E-21 1.14026E-20 -39140 8.59724E-21 1.13438E-20 -39150 8.57113E-21 1.12850E-20 -39160 8.54505E-21 1.12264E-20 -39170 8.51896E-21 1.11677E-20 -39180 8.49290E-21 1.11090E-20 -39190 8.46686E-21 1.10504E-20 -39200 8.44082E-21 1.09918E-20 -39210 8.41479E-21 1.09333E-20 -39220 8.41683E-21 1.09208E-20 -39230 8.45582E-21 1.09689E-20 -39240 8.49480E-21 1.10169E-20 -39250 8.53376E-21 1.10650E-20 -39260 8.57269E-21 1.11130E-20 -39270 8.61161E-21 1.11610E-20 -39280 8.65050E-21 1.12090E-20 -39290 8.68938E-21 1.12569E-20 -39300 8.72824E-21 1.13048E-20 -39310 8.76707E-21 1.13527E-20 -39320 8.80589E-21 1.14006E-20 -39330 8.84470E-21 1.14485E-20 -39340 8.88347E-21 1.14963E-20 -39350 8.92223E-21 1.15441E-20 -39360 8.96098E-21 1.15919E-20 -39370 8.99969E-21 1.16396E-20 -39380 9.03839E-21 1.16874E-20 -39390 9.07708E-21 1.17351E-20 -39400 9.11574E-21 1.17827E-20 -39410 9.15438E-21 1.18304E-20 -39420 9.19299E-21 1.18780E-20 -39430 9.23161E-21 1.19256E-20 -39440 9.27018E-21 1.19732E-20 -39450 9.30874E-21 1.20208E-20 -39460 9.34728E-21 1.20683E-20 -39470 9.38581E-21 1.21158E-20 -39480 9.42432E-21 1.21633E-20 -39490 9.46280E-21 1.22108E-20 -39500 9.50127E-21 1.22582E-20 -39510 9.53971E-21 1.23056E-20 -39520 9.57814E-21 1.23530E-20 -39530 9.61654E-21 1.24004E-20 -39540 9.65493E-21 1.24477E-20 -39550 9.69330E-21 1.24951E-20 -39560 9.73165E-21 1.25424E-20 -39570 9.76998E-21 1.25896E-20 -39580 9.80829E-21 1.26369E-20 -39590 9.84658E-21 1.26841E-20 -39600 9.88485E-21 1.27313E-20 -39610 9.92310E-21 1.27785E-20 -39620 9.96133E-21 1.28256E-20 -39630 9.99955E-21 1.28728E-20 -39640 1.00377E-20 1.29199E-20 -39650 1.00759E-20 1.29670E-20 -39660 1.01141E-20 1.30140E-20 -39670 1.01522E-20 1.30610E-20 -39680 1.01903E-20 1.31081E-20 -39690 1.02284E-20 1.31550E-20 -39700 1.02665E-20 1.32020E-20 -39710 1.03046E-20 1.32490E-20 -39720 1.03426E-20 1.32959E-20 -39730 1.03806E-20 1.33428E-20 -39740 1.04186E-20 1.33896E-20 -39750 1.04566E-20 1.34365E-20 -39760 1.04946E-20 1.34833E-20 -39770 1.05325E-20 1.35301E-20 -39780 1.05704E-20 1.35769E-20 -39790 1.06083E-20 1.36236E-20 -39800 1.06462E-20 1.36704E-20 -39810 1.06841E-20 1.37171E-20 -39820 1.07220E-20 1.37637E-20 -39830 1.07598E-20 1.38104E-20 -39840 1.07976E-20 1.38570E-20 -39850 1.08354E-20 1.39036E-20 -39860 1.08732E-20 1.39502E-20 -39870 1.09109E-20 1.39968E-20 -39880 1.09487E-20 1.40433E-20 -39890 1.09864E-20 1.40898E-20 -39900 1.10241E-20 1.41363E-20 -39910 1.10617E-20 1.41828E-20 -39920 1.10994E-20 1.42293E-20 -39930 1.11370E-20 1.42757E-20 -39940 1.11747E-20 1.43221E-20 -39950 1.12123E-20 1.43685E-20 -39960 1.12499E-20 1.44148E-20 -39970 1.12874E-20 1.44611E-20 -39980 1.13250E-20 1.45074E-20 -39990 1.13625E-20 1.45537E-20 -40000 1.14000E-20 1.46000E-20 -40010 1.16686E-20 1.48861E-20 -40020 1.19372E-20 1.51722E-20 -40030 1.22056E-20 1.54581E-20 -40040 1.24739E-20 1.57439E-20 -40050 1.27421E-20 1.60295E-20 -40060 1.30101E-20 1.63149E-20 -40070 1.32780E-20 1.66003E-20 -40080 1.35457E-20 1.68854E-20 -40090 1.38133E-20 1.71704E-20 -40100 1.40808E-20 1.74553E-20 -40110 1.43482E-20 1.77401E-20 -40120 1.46153E-20 1.80247E-20 -40130 1.48824E-20 1.83092E-20 -40140 1.51494E-20 1.85935E-20 -40150 1.54162E-20 1.88778E-20 -40160 1.56829E-20 1.91618E-20 -40170 1.59494E-20 1.94457E-20 -40180 1.62159E-20 1.97295E-20 -40190 1.64821E-20 2.00130E-20 -40200 1.67482E-20 2.02965E-20 -40210 1.70143E-20 2.05798E-20 -40220 1.72802E-20 2.08631E-20 -40230 1.75459E-20 2.11461E-20 -40240 1.78116E-20 2.14291E-20 -40250 1.80770E-20 2.17117E-20 -40260 1.83424E-20 2.19944E-20 -40270 1.86076E-20 2.22770E-20 -40280 1.88727E-20 2.25593E-20 -40290 1.91377E-20 2.28415E-20 -40300 1.94025E-20 2.31235E-20 -40310 1.96672E-20 2.34055E-20 -40320 1.99318E-20 2.36873E-20 -40330 2.01962E-20 2.39690E-20 -40340 2.04604E-20 2.42504E-20 -40350 2.07247E-20 2.45319E-20 -40360 2.09887E-20 2.48131E-20 -40370 2.12526E-20 2.50942E-20 -40380 2.15164E-20 2.53752E-20 -40390 2.17800E-20 2.56560E-20 -40400 2.20436E-20 2.59366E-20 -40410 2.23069E-20 2.62172E-20 -40420 2.25702E-20 2.64976E-20 -40430 2.28333E-20 2.67778E-20 -40440 2.30963E-20 2.70579E-20 -40450 2.33592E-20 2.73379E-20 -40460 2.36219E-20 2.76178E-20 -40470 2.38846E-20 2.78975E-20 -40480 2.41470E-20 2.81771E-20 -40490 2.44094E-20 2.84565E-20 -40500 2.46716E-20 2.87358E-20 -40510 2.49337E-20 2.90149E-20 -40520 2.51957E-20 2.92940E-20 -40530 2.54575E-20 2.95729E-20 -40540 2.57192E-20 2.98516E-20 -40550 2.59807E-20 3.01302E-20 -40560 2.62422E-20 3.04087E-20 -40570 2.65035E-20 3.06870E-20 -40580 2.67647E-20 3.09652E-20 -40590 2.70258E-20 3.12433E-20 -40600 2.72867E-20 3.15212E-20 -40610 2.75475E-20 3.17989E-20 -40620 2.78081E-20 3.20766E-20 -40630 2.80687E-20 3.23541E-20 -40640 2.83292E-20 3.26315E-20 -40650 2.85894E-20 3.29087E-20 -40660 2.88495E-20 3.31858E-20 -40670 2.91096E-20 3.34628E-20 -40680 2.93695E-20 3.37396E-20 -40690 2.96293E-20 3.40164E-20 -40700 2.98890E-20 3.42929E-20 -40710 3.01485E-20 3.45693E-20 -40720 3.04079E-20 3.48456E-20 -40730 3.06672E-20 3.51218E-20 -40740 3.09263E-20 3.53977E-20 -40750 3.11852E-20 3.56736E-20 -40760 3.14441E-20 3.59493E-20 -40770 3.17029E-20 3.62250E-20 -40780 3.19616E-20 3.65005E-20 -40790 3.22200E-20 3.67758E-20 -40800 3.24784E-20 3.70509E-20 -40810 3.27367E-20 3.73260E-20 -40820 3.30874E-20 3.77006E-20 -40830 3.35975E-20 3.82467E-20 -40840 3.41071E-20 3.87924E-20 -40850 3.46166E-20 3.93378E-20 -40860 3.51259E-20 3.98830E-20 -40870 3.56349E-20 4.04280E-20 -40880 3.61437E-20 4.09727E-20 -40890 3.66522E-20 4.15170E-20 -40900 3.71604E-20 4.20611E-20 -40910 3.76684E-20 4.26050E-20 -40920 3.81762E-20 4.31486E-20 -40930 3.86836E-20 4.36918E-20 -40940 3.91910E-20 4.42350E-20 -40950 3.96979E-20 4.47778E-20 -40960 4.02047E-20 4.53203E-20 -40970 4.07112E-20 4.58626E-20 -40980 4.12174E-20 4.64045E-20 -40990 4.17235E-20 4.69464E-20 -41000 4.22292E-20 4.74878E-20 -41010 4.27348E-20 4.80290E-20 -41020 4.32401E-20 4.85700E-20 -41030 4.37452E-20 4.91107E-20 -41040 4.42499E-20 4.96510E-20 -41050 4.47543E-20 5.01911E-20 -41060 4.52588E-20 5.07312E-20 -41070 4.57629E-20 5.12709E-20 -41080 4.62665E-20 5.18101E-20 -41090 4.67702E-20 5.23493E-20 -41100 4.72734E-20 5.28880E-20 -41110 4.77765E-20 5.34266E-20 -41120 4.82795E-20 5.39651E-20 -41130 4.87819E-20 5.45030E-20 -41140 4.92843E-20 5.50408E-20 -41150 4.97865E-20 5.55785E-20 -41160 5.02883E-20 5.61157E-20 -41170 5.07898E-20 5.66527E-20 -41180 5.12912E-20 5.71894E-20 -41190 5.17924E-20 5.77259E-20 -41200 5.22931E-20 5.82620E-20 -41210 5.27939E-20 5.87981E-20 -41220 5.32942E-20 5.93338E-20 -41230 5.37943E-20 5.98692E-20 -41240 5.42942E-20 6.04044E-20 -41250 5.47939E-20 6.09394E-20 -41260 5.52934E-20 6.14741E-20 -41270 5.57925E-20 6.20085E-20 -41280 5.62914E-20 6.25426E-20 -41290 5.67901E-20 6.30764E-20 -41300 5.72885E-20 6.36101E-20 -41310 5.77868E-20 6.41435E-20 -41320 5.82848E-20 6.46767E-20 -41330 5.87825E-20 6.52095E-20 -41340 5.92801E-20 6.57422E-20 -41350 5.97773E-20 6.62745E-20 -41360 6.02743E-20 6.68066E-20 -41370 6.07711E-20 6.73385E-20 -41380 6.12675E-20 6.78699E-20 -41390 6.17639E-20 6.84013E-20 -41400 6.22599E-20 6.89323E-20 -41410 6.27556E-20 6.94631E-20 -41420 6.32512E-20 6.99936E-20 -41430 6.37465E-20 7.05239E-20 -41440 6.42417E-20 7.10540E-20 -41450 6.47366E-20 7.15839E-20 -41460 6.52311E-20 7.21133E-20 -41470 6.57254E-20 7.26425E-20 -41480 6.62198E-20 7.31717E-20 -41490 6.67136E-20 7.37005E-20 -41500 6.72071E-20 7.42288E-20 -41510 6.77006E-20 7.47571E-20 -41520 6.81939E-20 7.52852E-20 -41530 6.86867E-20 7.58129E-20 -41540 6.91794E-20 7.63403E-20 -41550 6.96720E-20 7.68677E-20 -41560 7.01643E-20 7.73947E-20 -41570 7.06561E-20 7.79212E-20 -41580 7.11479E-20 7.84478E-20 -41590 7.16395E-20 7.89741E-20 -41600 7.21307E-20 7.95000E-20 -41610 7.26217E-20 8.00256E-20 -41620 7.31127E-20 8.05513E-20 -41630 7.36033E-20 8.10765E-20 -41640 7.40937E-20 8.16015E-20 -41650 7.45836E-20 8.21260E-20 -41660 7.50736E-20 8.26505E-20 -41670 7.56698E-20 8.33159E-20 -41680 7.64796E-20 8.42638E-20 -41690 7.72886E-20 8.52110E-20 -41700 7.80974E-20 8.61578E-20 -41710 7.89057E-20 8.71041E-20 -41720 7.97138E-20 8.80501E-20 -41730 8.05215E-20 8.89957E-20 -41740 8.13285E-20 8.99404E-20 -41750 8.21355E-20 9.08852E-20 -41760 8.29418E-20 9.18292E-20 -41770 8.37478E-20 9.27727E-20 -41780 8.45534E-20 9.37159E-20 -41790 8.53587E-20 9.46586E-20 -41800 8.61637E-20 9.56010E-20 -41810 8.69683E-20 9.65429E-20 -41820 8.77722E-20 9.74841E-20 -41830 8.85761E-20 9.84252E-20 -41840 8.93793E-20 9.93656E-20 -41850 9.01822E-20 1.00306E-19 -41860 9.09848E-20 1.01245E-19 -41870 9.17870E-20 1.02184E-19 -41880 9.25888E-20 1.03123E-19 -41890 9.33903E-20 1.04061E-19 -41900 9.41915E-20 1.04999E-19 -41910 9.49920E-20 1.05936E-19 -41920 9.57925E-20 1.06873E-19 -41930 9.65923E-20 1.07810E-19 -41940 9.73917E-20 1.08746E-19 -41950 9.81909E-20 1.09681E-19 -41960 9.89896E-20 1.10616E-19 -41970 9.97881E-20 1.11551E-19 -41980 1.00586E-19 1.12485E-19 -41990 1.01384E-19 1.13419E-19 -42000 1.02181E-19 1.14352E-19 -42010 1.02978E-19 1.15285E-19 -42020 1.03774E-19 1.16218E-19 -42030 1.04570E-19 1.17150E-19 -42040 1.05366E-19 1.18081E-19 -42050 1.06161E-19 1.19012E-19 -42060 1.06956E-19 1.19943E-19 -42070 1.07751E-19 1.20873E-19 -42080 1.08545E-19 1.21803E-19 -42090 1.09339E-19 1.22732E-19 -42100 1.10133E-19 1.23661E-19 -42110 1.10926E-19 1.24590E-19 -42120 1.11718E-19 1.25518E-19 -42130 1.12511E-19 1.26445E-19 -42140 1.13303E-19 1.27372E-19 -42150 1.14094E-19 1.28299E-19 -42160 1.14885E-19 1.29225E-19 -42170 1.15676E-19 1.30151E-19 -42180 1.16467E-19 1.31077E-19 -42190 1.17257E-19 1.32001E-19 -42200 1.18046E-19 1.32926E-19 -42210 1.18836E-19 1.33850E-19 -42220 1.19625E-19 1.34774E-19 -42230 1.20413E-19 1.35697E-19 -42240 1.21201E-19 1.36620E-19 -42250 1.21989E-19 1.37542E-19 -42260 1.22777E-19 1.38464E-19 -42270 1.23564E-19 1.39385E-19 -42280 1.24350E-19 1.40306E-19 -42290 1.25137E-19 1.41227E-19 -42300 1.25923E-19 1.42147E-19 -42310 1.26709E-19 1.43067E-19 -42320 1.27494E-19 1.43986E-19 -42330 1.28279E-19 1.44905E-19 -42340 1.29063E-19 1.45823E-19 -42350 1.29847E-19 1.46741E-19 -42360 1.30631E-19 1.47659E-19 -42370 1.31414E-19 1.48576E-19 -42380 1.32197E-19 1.49493E-19 -42390 1.32980E-19 1.50409E-19 -42400 1.33762E-19 1.51325E-19 -42410 1.34544E-19 1.52240E-19 -42420 1.35326E-19 1.53155E-19 -42430 1.36107E-19 1.54069E-19 -42440 1.36888E-19 1.54984E-19 -42450 1.37668E-19 1.55897E-19 -42460 1.38448E-19 1.56810E-19 -42470 1.39228E-19 1.57723E-19 -42480 1.40007E-19 1.58635E-19 -42490 1.40786E-19 1.59547E-19 -42500 1.41565E-19 1.60459E-19 -42510 1.42343E-19 1.61370E-19 -42520 1.43121E-19 1.62280E-19 -42530 1.43898E-19 1.63191E-19 -42540 1.44675E-19 1.64100E-19 -42550 1.45452E-19 1.65010E-19 -42560 1.46568E-19 1.66136E-19 -42570 1.47842E-19 1.67364E-19 -42580 1.49115E-19 1.68590E-19 -42590 1.50388E-19 1.69817E-19 -42600 1.51660E-19 1.71043E-19 -42610 1.52931E-19 1.72268E-19 -42620 1.54202E-19 1.73493E-19 -42630 1.55472E-19 1.74717E-19 -42640 1.56742E-19 1.75940E-19 -42650 1.58011E-19 1.77163E-19 -42660 1.59280E-19 1.78386E-19 -42670 1.60548E-19 1.79607E-19 -42680 1.61815E-19 1.80828E-19 -42690 1.63082E-19 1.82049E-19 -42700 1.64348E-19 1.83269E-19 -42710 1.65613E-19 1.84489E-19 -42720 1.66878E-19 1.85707E-19 -42730 1.68143E-19 1.86926E-19 -42740 1.69407E-19 1.88144E-19 -42750 1.70669E-19 1.89361E-19 -42760 1.71932E-19 1.90577E-19 -42770 1.73194E-19 1.91794E-19 -42780 1.74455E-19 1.93009E-19 -42790 1.75716E-19 1.94224E-19 -42800 1.76977E-19 1.95439E-19 -42810 1.78236E-19 1.96652E-19 -42820 1.79495E-19 1.97865E-19 -42830 1.80754E-19 1.99078E-19 -42840 1.82012E-19 2.00290E-19 -42850 1.83269E-19 2.01502E-19 -42860 1.84526E-19 2.02713E-19 -42870 1.85782E-19 2.03923E-19 -42880 1.87037E-19 2.05133E-19 -42890 1.88292E-19 2.06342E-19 -42900 1.89546E-19 2.07551E-19 -42910 1.90801E-19 2.08759E-19 -42920 1.92054E-19 2.09967E-19 -42930 1.93306E-19 2.11174E-19 -42940 1.94558E-19 2.12380E-19 -42950 1.95809E-19 2.13586E-19 -42960 1.97060E-19 2.14791E-19 -42970 1.98311E-19 2.15996E-19 -42980 1.99560E-19 2.17200E-19 -42990 2.00810E-19 2.18404E-19 -43000 2.02058E-19 2.19607E-19 -43010 2.03306E-19 2.20809E-19 -43020 2.04553E-19 2.22011E-19 -43030 2.05800E-19 2.23213E-19 -43040 2.07046E-19 2.24414E-19 -43050 2.08292E-19 2.25614E-19 -43060 2.09537E-19 2.26814E-19 -43070 2.10782E-19 2.28013E-19 -43080 2.12026E-19 2.29212E-19 -43090 2.13269E-19 2.30410E-19 -43100 2.14512E-19 2.31607E-19 -43110 2.15754E-19 2.32804E-19 -43120 2.16996E-19 2.34001E-19 -43130 2.18236E-19 2.35196E-19 -43140 2.19477E-19 2.36391E-19 -43150 2.20717E-19 2.37587E-19 -43160 2.21956E-19 2.38781E-19 -43170 2.23195E-19 2.39975E-19 -43180 2.24433E-19 2.41167E-19 -43190 2.25670E-19 2.42360E-19 -43200 2.26908E-19 2.43552E-19 -43210 2.28144E-19 2.44743E-19 -43220 2.29380E-19 2.45934E-19 -43230 2.30615E-19 2.47124E-19 -43240 2.31850E-19 2.48315E-19 -43250 2.33084E-19 2.49504E-19 -43260 2.34317E-19 2.50692E-19 -43270 2.35550E-19 2.51880E-19 -43280 2.36783E-19 2.53068E-19 -43290 2.38015E-19 2.54255E-19 -43300 2.39246E-19 2.55442E-19 -43310 2.40477E-19 2.56627E-19 -43320 2.41707E-19 2.57813E-19 -43330 2.42936E-19 2.58997E-19 -43340 2.44165E-19 2.60182E-19 -43350 2.45394E-19 2.61365E-19 -43360 2.46622E-19 2.62549E-19 -43370 2.47849E-19 2.63732E-19 -43380 2.49076E-19 2.64914E-19 -43390 2.50302E-19 2.66095E-19 -43400 2.51528E-19 2.67276E-19 -43410 2.52753E-19 2.68456E-19 -43420 2.53977E-19 2.69636E-19 -43430 2.55201E-19 2.70816E-19 -43440 2.56424E-19 2.71994E-19 -43450 2.57647E-19 2.73173E-19 -43460 2.58870E-19 2.74351E-19 -43470 2.60091E-19 2.75528E-19 -43480 2.61300E-19 2.76710E-19 -43490 2.62447E-19 2.77914E-19 -43500 2.63594E-19 2.79118E-19 -43510 2.64741E-19 2.80322E-19 -43520 2.65887E-19 2.81525E-19 -43530 2.67032E-19 2.82727E-19 -43540 2.68177E-19 2.83930E-19 -43550 2.69322E-19 2.85131E-19 -43560 2.70466E-19 2.86332E-19 -43570 2.71609E-19 2.87532E-19 -43580 2.72752E-19 2.88731E-19 -43590 2.73894E-19 2.89931E-19 -43600 2.75036E-19 2.91130E-19 -43610 2.76177E-19 2.92328E-19 -43620 2.77318E-19 2.93525E-19 -43630 2.78458E-19 2.94722E-19 -43640 2.79597E-19 2.95918E-19 -43650 2.80737E-19 2.97114E-19 -43660 2.81876E-19 2.98310E-19 -43670 2.83014E-19 2.99504E-19 -43680 2.84151E-19 3.00699E-19 -43690 2.85288E-19 3.01892E-19 -43700 2.86425E-19 3.03085E-19 -43710 2.87561E-19 3.04278E-19 -43720 2.88697E-19 3.05470E-19 -43730 2.89831E-19 3.06661E-19 -43740 2.90966E-19 3.07853E-19 -43750 2.92100E-19 3.09043E-19 -43760 2.93234E-19 3.10233E-19 -43770 2.94366E-19 3.11422E-19 -43780 2.95499E-19 3.12611E-19 -43790 2.96631E-19 3.13799E-19 -43800 2.97762E-19 3.14987E-19 -43810 2.98893E-19 3.16174E-19 -43820 3.00023E-19 3.17361E-19 -43830 3.01153E-19 3.18547E-19 -43840 3.02282E-19 3.19732E-19 -43850 3.03411E-19 3.20917E-19 -43860 3.04540E-19 3.22102E-19 -43870 3.05667E-19 3.23285E-19 -43880 3.06794E-19 3.24469E-19 -43890 3.07921E-19 3.25652E-19 -43900 3.09048E-19 3.26834E-19 -43910 3.10173E-19 3.28016E-19 -43920 3.11299E-19 3.29197E-19 -43930 3.12423E-19 3.30378E-19 -43940 3.13548E-19 3.31558E-19 -43950 3.14671E-19 3.32738E-19 -43960 3.15794E-19 3.33917E-19 -43970 3.16917E-19 3.35095E-19 -43980 3.18039E-19 3.36273E-19 -43990 3.19161E-19 3.37450E-19 -44000 3.20282E-19 3.38627E-19 -44010 3.21402E-19 3.39803E-19 -44020 3.22523E-19 3.40980E-19 -44030 3.23642E-19 3.42155E-19 -44040 3.24761E-19 3.43329E-19 -44050 3.25880E-19 3.44504E-19 -44060 3.26998E-19 3.45678E-19 -44070 3.28115E-19 3.46850E-19 -44080 3.29232E-19 3.48023E-19 -44090 3.30349E-19 3.49196E-19 -44100 3.31465E-19 3.50367E-19 -44110 3.32581E-19 3.51538E-19 -44120 3.33695E-19 3.52708E-19 -44130 3.34810E-19 3.53879E-19 -44140 3.35924E-19 3.55048E-19 -44150 3.37038E-19 3.56217E-19 -44160 3.38151E-19 3.57386E-19 -44170 3.39263E-19 3.58554E-19 -44180 3.40375E-19 3.59721E-19 -44190 3.41487E-19 3.60888E-19 -44200 3.42598E-19 3.62054E-19 -44210 3.43708E-19 3.63220E-19 -44220 3.44818E-19 3.64385E-19 -44230 3.45928E-19 3.65549E-19 -44240 3.47036E-19 3.66713E-19 -44250 3.48145E-19 3.67877E-19 -44260 3.49253E-19 3.69040E-19 -44270 3.50361E-19 3.70203E-19 -44280 3.51468E-19 3.71365E-19 -44290 3.52574E-19 3.72527E-19 -44300 3.53680E-19 3.73688E-19 -44310 3.54786E-19 3.74848E-19 -44320 3.55891E-19 3.76008E-19 -44330 3.56995E-19 3.77168E-19 -44340 3.58099E-19 3.78326E-19 -44350 3.59202E-19 3.79485E-19 -44360 3.60305E-19 3.80643E-19 -44370 3.61408E-19 3.81800E-19 -44380 3.62510E-19 3.82957E-19 -44390 3.63612E-19 3.84114E-19 -44400 3.64713E-19 3.85269E-19 -44410 3.65813E-19 3.86425E-19 -44420 3.66913E-19 3.87579E-19 -44430 3.68013E-19 3.88734E-19 -44440 3.69112E-19 3.89887E-19 -44450 3.69998E-19 3.90832E-19 -44460 3.70713E-19 3.91609E-19 -44470 3.71428E-19 3.92386E-19 -44480 3.72143E-19 3.93163E-19 -44490 3.72858E-19 3.93939E-19 -44500 3.73572E-19 3.94715E-19 -44510 3.74286E-19 3.95490E-19 -44520 3.74999E-19 3.96265E-19 -44530 3.75713E-19 3.97040E-19 -44540 3.76426E-19 3.97814E-19 -44550 3.77138E-19 3.98588E-19 -44560 3.77850E-19 3.99362E-19 -44570 3.78562E-19 4.00136E-19 -44580 3.79274E-19 4.00909E-19 -44590 3.79985E-19 4.01681E-19 -44600 3.80696E-19 4.02454E-19 -44610 3.81407E-19 4.03226E-19 -44620 3.82117E-19 4.03997E-19 -44630 3.82828E-19 4.04769E-19 -44640 3.83537E-19 4.05540E-19 -44650 3.84247E-19 4.06310E-19 -44660 3.84956E-19 4.07081E-19 -44670 3.85665E-19 4.07851E-19 -44680 3.86373E-19 4.08620E-19 -44690 3.87081E-19 4.09390E-19 -44700 3.87789E-19 4.10158E-19 -44710 3.88497E-19 4.10927E-19 -44720 3.89204E-19 4.11695E-19 -44730 3.89911E-19 4.12463E-19 -44740 3.90617E-19 4.13231E-19 -44750 3.91323E-19 4.13998E-19 -44760 3.92029E-19 4.14764E-19 -44770 3.92735E-19 4.15531E-19 -44780 3.93440E-19 4.16297E-19 -44790 3.94145E-19 4.17063E-19 -44800 3.94850E-19 4.17829E-19 -44810 3.95554E-19 4.18594E-19 -44820 3.96259E-19 4.19359E-19 -44830 3.96962E-19 4.20123E-19 -44840 3.97666E-19 4.20887E-19 -44850 3.98369E-19 4.21651E-19 -44860 3.99071E-19 4.22414E-19 -44870 3.99774E-19 4.23177E-19 -44880 4.00476E-19 4.23940E-19 -44890 4.01178E-19 4.24702E-19 -44900 4.01880E-19 4.25465E-19 -44910 4.02581E-19 4.26226E-19 -44920 4.03282E-19 4.26988E-19 -44930 4.03982E-19 4.27749E-19 -44940 4.04682E-19 4.28509E-19 -44950 4.05383E-19 4.29270E-19 -44960 4.06082E-19 4.30030E-19 -44970 4.06782E-19 4.30790E-19 -44980 4.07481E-19 4.31549E-19 -44990 4.08179E-19 4.32308E-19 -45000 4.08878E-19 4.33067E-19 -45010 4.09576E-19 4.33825E-19 -45020 4.10274E-19 4.34583E-19 -45030 4.10971E-19 4.35341E-19 -45040 4.11668E-19 4.36098E-19 -45050 4.12365E-19 4.36855E-19 -45060 4.13062E-19 4.37612E-19 -45070 4.13758E-19 4.38368E-19 -45080 4.14454E-19 4.39124E-19 -45090 4.15150E-19 4.39880E-19 -45100 4.15845E-19 4.40635E-19 -45110 4.16540E-19 4.41390E-19 -45120 4.17235E-19 4.42145E-19 -45130 4.17929E-19 4.42899E-19 -45140 4.18623E-19 4.43653E-19 -45150 4.19317E-19 4.44407E-19 -45160 4.20011E-19 4.45160E-19 -45170 4.20704E-19 4.45913E-19 -45180 4.21397E-19 4.46666E-19 -45190 4.22089E-19 4.47418E-19 -45200 4.22781E-19 4.48170E-19 -45210 4.23474E-19 4.48922E-19 -45220 4.24165E-19 4.49673E-19 -45230 4.24856E-19 4.50424E-19 -45240 4.25547E-19 4.51174E-19 -45250 4.26238E-19 4.51925E-19 -45260 4.26928E-19 4.52675E-19 -45270 4.27619E-19 4.53424E-19 -45280 4.28309E-19 4.54174E-19 -45290 4.28998E-19 4.54923E-19 -45300 4.29687E-19 4.55671E-19 -45310 4.30376E-19 4.56420E-19 -45320 4.31065E-19 4.57168E-19 -45330 4.31753E-19 4.57915E-19 -45340 4.32441E-19 4.58663E-19 -45350 4.33129E-19 4.59410E-19 -45360 4.33816E-19 4.60157E-19 -45370 4.34503E-19 4.60903E-19 -45380 4.35190E-19 4.61649E-19 -45390 4.35876E-19 4.62395E-19 -45400 4.36563E-19 4.63140E-19 -45410 4.37248E-19 4.63885E-19 -45420 4.37934E-19 4.64630E-19 -45430 4.38619E-19 4.65374E-19 -45440 4.39304E-19 4.66118E-19 -45450 4.39989E-19 4.66862E-19 -45460 4.40393E-19 4.67313E-19 -45470 4.40565E-19 4.67522E-19 -45480 4.40736E-19 4.67729E-19 -45490 4.40907E-19 4.67937E-19 -45500 4.41078E-19 4.68145E-19 -45510 4.41249E-19 4.68353E-19 -45520 4.41420E-19 4.68560E-19 -45530 4.41591E-19 4.68768E-19 -45540 4.41761E-19 4.68975E-19 -45550 4.41932E-19 4.69182E-19 -45560 4.42103E-19 4.69390E-19 -45570 4.42273E-19 4.69597E-19 -45580 4.42444E-19 4.69804E-19 -45590 4.42614E-19 4.70011E-19 -45600 4.42784E-19 4.70218E-19 -45610 4.42954E-19 4.70424E-19 -45620 4.43125E-19 4.70631E-19 -45630 4.43295E-19 4.70837E-19 -45640 4.43465E-19 4.71044E-19 -45650 4.43634E-19 4.71250E-19 -45660 4.43804E-19 4.71457E-19 -45670 4.43974E-19 4.71663E-19 -45680 4.44144E-19 4.71869E-19 -45690 4.44313E-19 4.72075E-19 -45700 4.44483E-19 4.72281E-19 -45710 4.44652E-19 4.72487E-19 -45720 4.44822E-19 4.72693E-19 -45730 4.44991E-19 4.72898E-19 -45740 4.45160E-19 4.73104E-19 -45750 4.45330E-19 4.73309E-19 -45760 4.45499E-19 4.73515E-19 -45770 4.45668E-19 4.73720E-19 -45780 4.45837E-19 4.73925E-19 -45790 4.46005E-19 4.74130E-19 -45800 4.46174E-19 4.74335E-19 -45810 4.46343E-19 4.74540E-19 -45820 4.46512E-19 4.74745E-19 -45830 4.46680E-19 4.74950E-19 -45840 4.46849E-19 4.75155E-19 -45850 4.47017E-19 4.75359E-19 -45860 4.47185E-19 4.75564E-19 -45870 4.47354E-19 4.75768E-19 -45880 4.47522E-19 4.75972E-19 -45890 4.47690E-19 4.76177E-19 -45900 4.47858E-19 4.76381E-19 -45910 4.48026E-19 4.76585E-19 -45920 4.48194E-19 4.76789E-19 -45930 4.48362E-19 4.76993E-19 -45940 4.48530E-19 4.77197E-19 -45950 4.48697E-19 4.77400E-19 -45960 4.48865E-19 4.77604E-19 -45970 4.49033E-19 4.77807E-19 -45980 4.49200E-19 4.78011E-19 -45990 4.49367E-19 4.78214E-19 -46000 4.49535E-19 4.78417E-19 -46010 4.49702E-19 4.78621E-19 -46020 4.49869E-19 4.78824E-19 -46030 4.50036E-19 4.79027E-19 -46040 4.50203E-19 4.79230E-19 -46050 4.50370E-19 4.79432E-19 -46060 4.50537E-19 4.79635E-19 -46070 4.50704E-19 4.79838E-19 -46080 4.50871E-19 4.80040E-19 -46090 4.51038E-19 4.80243E-19 -46100 4.51204E-19 4.80445E-19 -46110 4.51371E-19 4.80647E-19 -46120 4.51537E-19 4.80850E-19 -46130 4.51704E-19 4.81052E-19 -46140 4.51870E-19 4.81254E-19 -46150 4.52036E-19 4.81456E-19 -46160 4.52202E-19 4.81657E-19 -46170 4.52368E-19 4.81859E-19 -46180 4.52534E-19 4.82061E-19 -46190 4.52700E-19 4.82263E-19 -46200 4.52866E-19 4.82464E-19 -46210 4.53032E-19 4.82666E-19 -46220 4.53198E-19 4.82867E-19 -46230 4.53363E-19 4.83068E-19 -46240 4.53529E-19 4.83269E-19 -46250 4.53695E-19 4.83470E-19 -46260 4.53860E-19 4.83671E-19 -46270 4.54025E-19 4.83872E-19 -46280 4.54191E-19 4.84073E-19 -46290 4.54356E-19 4.84274E-19 -46300 4.54521E-19 4.84474E-19 -46310 4.54686E-19 4.84675E-19 -46320 4.54851E-19 4.84875E-19 -46330 4.55016E-19 4.85076E-19 -46340 4.55181E-19 4.85276E-19 -46350 4.55346E-19 4.85476E-19 -46360 4.55511E-19 4.85676E-19 -46370 4.55675E-19 4.85876E-19 -46380 4.55840E-19 4.86076E-19 -46390 4.56005E-19 4.86276E-19 -46400 4.56169E-19 4.86476E-19 -46410 4.56333E-19 4.86676E-19 -46420 4.56498E-19 4.86875E-19 -46430 4.56662E-19 4.87075E-19 -46440 4.56826E-19 4.87274E-19 -46450 4.56990E-19 4.87473E-19 -46460 4.57154E-19 4.87673E-19 -46470 4.57318E-19 4.87872E-19 -46480 4.57482E-19 4.88071E-19 -46490 4.57646E-19 4.88270E-19 -46500 4.57810E-19 4.88469E-19 -46510 4.57973E-19 4.88668E-19 -46520 4.57741E-19 4.88363E-19 -46530 4.57433E-19 4.87960E-19 -46540 4.57124E-19 4.87557E-19 -46550 4.56816E-19 4.87155E-19 -46560 4.56508E-19 4.86752E-19 -46570 4.56200E-19 4.86350E-19 -46580 4.55892E-19 4.85948E-19 -46590 4.55584E-19 4.85546E-19 -46600 4.55276E-19 4.85145E-19 -46610 4.54969E-19 4.84743E-19 -46620 4.54661E-19 4.84342E-19 -46630 4.54354E-19 4.83941E-19 -46640 4.54047E-19 4.83540E-19 -46650 4.53740E-19 4.83139E-19 -46660 4.53433E-19 4.82738E-19 -46670 4.53126E-19 4.82338E-19 -46680 4.52820E-19 4.81938E-19 -46690 4.52513E-19 4.81538E-19 -46700 4.52207E-19 4.81138E-19 -46710 4.51901E-19 4.80738E-19 -46720 4.51594E-19 4.80338E-19 -46730 4.51288E-19 4.79939E-19 -46740 4.50983E-19 4.79540E-19 -46750 4.50677E-19 4.79141E-19 -46760 4.50371E-19 4.78742E-19 -46770 4.50066E-19 4.78343E-19 -46780 4.49761E-19 4.77945E-19 -46790 4.49455E-19 4.77546E-19 -46800 4.49150E-19 4.77148E-19 -46810 4.48845E-19 4.76750E-19 -46820 4.48541E-19 4.76352E-19 -46830 4.48236E-19 4.75954E-19 -46840 4.47932E-19 4.75557E-19 -46850 4.47627E-19 4.75159E-19 -46860 4.47323E-19 4.74762E-19 -46870 4.47019E-19 4.74365E-19 -46880 4.46715E-19 4.73968E-19 -46890 4.46411E-19 4.73572E-19 -46900 4.46107E-19 4.73175E-19 -46910 4.45803E-19 4.72779E-19 -46920 4.45500E-19 4.72383E-19 -46930 4.45197E-19 4.71987E-19 -46940 4.44893E-19 4.71591E-19 -46950 4.44590E-19 4.71195E-19 -46960 4.44287E-19 4.70800E-19 -46970 4.43984E-19 4.70404E-19 -46980 4.43682E-19 4.70009E-19 -46990 4.43379E-19 4.69614E-19 -47000 4.43077E-19 4.69219E-19 -47010 4.42774E-19 4.68825E-19 -47020 4.42472E-19 4.68430E-19 -47030 4.42170E-19 4.68036E-19 -47040 4.41868E-19 4.67641E-19 -47050 4.41566E-19 4.67247E-19 -47060 4.41264E-19 4.66854E-19 -47070 4.40963E-19 4.66460E-19 -47080 4.40661E-19 4.66067E-19 -47090 4.40360E-19 4.65673E-19 -47100 4.40059E-19 4.65280E-19 -47110 4.39758E-19 4.64887E-19 -47120 4.39457E-19 4.64494E-19 -47130 4.39156E-19 4.64102E-19 -47140 4.38856E-19 4.63709E-19 -47150 4.38555E-19 4.63317E-19 -47160 4.38255E-19 4.62925E-19 -47170 4.37954E-19 4.62533E-19 -47180 4.37654E-19 4.62141E-19 -47190 4.37354E-19 4.61749E-19 -47200 4.37054E-19 4.61358E-19 -47210 4.36754E-19 4.60966E-19 -47220 4.36455E-19 4.60575E-19 -47230 4.36155E-19 4.60184E-19 -47240 4.35856E-19 4.59793E-19 -47250 4.35557E-19 4.59403E-19 -47260 4.35257E-19 4.59012E-19 -47270 4.34958E-19 4.58622E-19 -47280 4.34660E-19 4.58232E-19 -47290 4.34361E-19 4.57842E-19 -47300 4.34062E-19 4.57452E-19 -47310 4.33764E-19 4.57062E-19 -47320 4.33465E-19 4.56673E-19 -47330 4.33167E-19 4.56283E-19 -47340 4.32869E-19 4.55894E-19 -47350 4.32571E-19 4.55505E-19 -47360 4.32273E-19 4.55116E-19 -47370 4.31975E-19 4.54728E-19 -47380 4.31678E-19 4.54339E-19 -47390 4.31380E-19 4.53951E-19 -47400 4.31083E-19 4.53562E-19 -47410 4.30786E-19 4.53175E-19 -47420 4.30488E-19 4.52787E-19 -47430 4.30191E-19 4.52399E-19 -47440 4.29894E-19 4.52011E-19 -47450 4.29598E-19 4.51624E-19 -47460 4.29301E-19 4.51237E-19 -47470 4.29005E-19 4.50850E-19 -47480 4.28708E-19 4.50463E-19 -47490 4.28412E-19 4.50076E-19 -47500 4.28116E-19 4.49690E-19 -47510 4.27820E-19 4.49303E-19 -47520 4.27524E-19 4.48917E-19 -47530 4.27228E-19 4.48531E-19 -47540 4.26932E-19 4.48145E-19 -47550 4.26637E-19 4.47759E-19 -47560 4.26342E-19 4.47373E-19 -47570 4.26046E-19 4.46988E-19 -47580 4.25751E-19 4.46603E-19 -47590 4.25456E-19 4.46218E-19 -47600 4.25161E-19 4.45833E-19 -47610 4.24867E-19 4.45448E-19 -47620 4.24531E-19 4.45010E-19 -47630 4.23811E-19 4.44067E-19 -47640 4.23091E-19 4.43124E-19 -47650 4.22371E-19 4.42181E-19 -47660 4.21652E-19 4.41239E-19 -47670 4.20932E-19 4.40297E-19 -47680 4.20213E-19 4.39355E-19 -47690 4.19495E-19 4.38414E-19 -47700 4.18776E-19 4.37473E-19 -47710 4.18058E-19 4.36533E-19 -47720 4.17341E-19 4.35593E-19 -47730 4.16623E-19 4.34653E-19 -47740 4.15906E-19 4.33714E-19 -47750 4.15189E-19 4.32775E-19 -47760 4.14473E-19 4.31837E-19 -47770 4.13757E-19 4.30899E-19 -47780 4.13041E-19 4.29962E-19 -47790 4.12325E-19 4.29024E-19 -47800 4.11610E-19 4.28088E-19 -47810 4.10895E-19 4.27151E-19 -47820 4.10180E-19 4.26215E-19 -47830 4.09466E-19 4.25279E-19 -47840 4.08752E-19 4.24344E-19 -47850 4.08038E-19 4.23410E-19 -47860 4.07325E-19 4.22475E-19 -47870 4.06611E-19 4.21541E-19 -47880 4.05898E-19 4.20607E-19 -47890 4.05186E-19 4.19674E-19 -47900 4.04473E-19 4.18741E-19 -47910 4.03761E-19 4.17808E-19 -47920 4.03050E-19 4.16876E-19 -47930 4.02338E-19 4.15945E-19 -47940 4.01627E-19 4.15013E-19 -47950 4.00916E-19 4.14082E-19 -47960 4.00206E-19 4.13152E-19 -47970 3.99496E-19 4.12222E-19 -47980 3.98786E-19 4.11292E-19 -47990 3.98076E-19 4.10362E-19 -48000 3.97367E-19 4.09433E-19 -48010 3.96658E-19 4.08505E-19 -48020 3.95949E-19 4.07576E-19 -48030 3.95240E-19 4.06648E-19 -48040 3.94532E-19 4.05721E-19 -48050 3.93824E-19 4.04794E-19 -48060 3.93117E-19 4.03867E-19 -48070 3.92409E-19 4.02941E-19 -48080 3.91703E-19 4.02015E-19 -48090 3.90996E-19 4.01089E-19 -48100 3.90290E-19 4.00165E-19 -48110 3.89583E-19 3.99239E-19 -48120 3.88877E-19 3.98315E-19 -48130 3.88172E-19 3.97391E-19 -48140 3.87467E-19 3.96468E-19 -48150 3.86762E-19 3.95545E-19 -48160 3.86057E-19 3.94621E-19 -48170 3.85353E-19 3.93699E-19 -48180 3.84649E-19 3.92777E-19 -48190 3.83945E-19 3.91855E-19 -48200 3.83241E-19 3.90934E-19 -48210 3.82538E-19 3.90013E-19 -48220 3.81836E-19 3.89093E-19 -48230 3.81133E-19 3.88172E-19 -48240 3.80431E-19 3.87253E-19 -48250 3.79728E-19 3.86333E-19 -48260 3.79027E-19 3.85414E-19 -48270 3.78325E-19 3.84496E-19 -48280 3.77624E-19 3.83577E-19 -48290 3.76923E-19 3.82659E-19 -48300 3.76223E-19 3.81742E-19 -48310 3.75523E-19 3.80825E-19 -48320 3.74822E-19 3.79908E-19 -48330 3.74123E-19 3.78991E-19 -48340 3.73423E-19 3.78076E-19 -48350 3.72724E-19 3.77160E-19 -48360 3.72026E-19 3.76245E-19 -48370 3.71327E-19 3.75330E-19 -48380 3.70629E-19 3.74415E-19 -48390 3.69931E-19 3.73501E-19 -48400 3.69233E-19 3.72588E-19 -48410 3.68536E-19 3.71674E-19 -48420 3.67838E-19 3.70761E-19 -48430 3.67142E-19 3.69849E-19 -48440 3.66445E-19 3.68937E-19 -48450 3.65749E-19 3.68024E-19 -48460 3.65053E-19 3.67113E-19 -48470 3.64357E-19 3.66202E-19 -48480 3.63662E-19 3.65291E-19 -48490 3.62967E-19 3.64381E-19 -48500 3.62272E-19 3.63471E-19 -48510 3.61578E-19 3.62562E-19 -48520 3.60884E-19 3.61653E-19 -48530 3.60189E-19 3.60743E-19 -48540 3.59496E-19 3.59835E-19 -48550 3.58802E-19 3.58927E-19 -48560 3.58109E-19 3.58019E-19 -48570 3.57416E-19 3.57112E-19 -48580 3.56724E-19 3.56205E-19 -48590 3.56032E-19 3.55298E-19 -48600 3.55340E-19 3.54392E-19 -48610 3.54648E-19 3.53486E-19 -48620 3.53957E-19 3.52581E-19 -48630 3.53266E-19 3.51676E-19 -48640 3.52575E-19 3.50771E-19 -48650 3.51885E-19 3.49867E-19 -48660 3.51194E-19 3.48962E-19 -48670 3.50504E-19 3.48059E-19 -48680 3.49815E-19 3.47156E-19 -48690 3.49125E-19 3.46253E-19 -48700 3.48436E-19 3.45351E-19 -48710 3.47747E-19 3.44448E-19 -48720 3.47059E-19 3.43547E-19 -48730 3.46371E-19 3.42645E-19 -48740 3.45683E-19 3.41744E-19 -48750 3.44995E-19 3.40843E-19 -48760 3.44307E-19 3.39943E-19 -48770 3.43620E-19 3.39044E-19 -48780 3.42933E-19 3.38144E-19 -48790 3.15491E-19 3.11075E-19 -48800 2.86693E-19 2.82680E-19 -48810 2.57895E-19 2.54285E-19 -48820 2.29113E-19 2.25906E-19 -48830 2.00349E-19 1.97544E-19 -48840 1.71592E-19 1.69190E-19 -48850 1.42844E-19 1.40845E-19 -48860 1.14113E-19 1.12516E-19 -48870 8.53901E-20 8.41948E-20 -48880 5.66840E-20 5.58905E-20 -48890 2.79862E-20 2.75944E-20 -48900 0.00000E+00 0.00000E+00 -48910 0.00000E+00 0.00000E+00 -48920 0.00000E+00 0.00000E+00 -48930 0.00000E+00 0.00000E+00 -48940 0.00000E+00 0.00000E+00 -48950 0.00000E+00 0.00000E+00 -48960 0.00000E+00 0.00000E+00 -48970 0.00000E+00 0.00000E+00 -48980 0.00000E+00 0.00000E+00 -48990 0.00000E+00 0.00000E+00 -49000 0.00000E+00 0.00000E+00 -49010 0.00000E+00 0.00000E+00 -49020 0.00000E+00 0.00000E+00 -49030 0.00000E+00 0.00000E+00 -49040 0.00000E+00 0.00000E+00 -49050 0.00000E+00 0.00000E+00 -49060 0.00000E+00 0.00000E+00 -49070 0.00000E+00 0.00000E+00 -49080 0.00000E+00 0.00000E+00 -49090 0.00000E+00 0.00000E+00 -49100 0.00000E+00 0.00000E+00 -49110 0.00000E+00 0.00000E+00 -49120 0.00000E+00 0.00000E+00 -49130 0.00000E+00 0.00000E+00 -49140 0.00000E+00 0.00000E+00 -49150 0.00000E+00 0.00000E+00 -49160 0.00000E+00 0.00000E+00 -49170 0.00000E+00 0.00000E+00 -49180 0.00000E+00 0.00000E+00 -49190 0.00000E+00 0.00000E+00 -49200 0.00000E+00 0.00000E+00 -49210 0.00000E+00 0.00000E+00 -49220 0.00000E+00 0.00000E+00 -49230 0.00000E+00 0.00000E+00 -49240 0.00000E+00 0.00000E+00 -49250 0.00000E+00 0.00000E+00 -49260 0.00000E+00 0.00000E+00 -49270 0.00000E+00 0.00000E+00 -49280 0.00000E+00 0.00000E+00 -49290 0.00000E+00 0.00000E+00 -49300 0.00000E+00 0.00000E+00 -49310 0.00000E+00 0.00000E+00 -49320 0.00000E+00 0.00000E+00 -49330 0.00000E+00 0.00000E+00 -49340 0.00000E+00 0.00000E+00 -49350 0.00000E+00 0.00000E+00 -49360 0.00000E+00 0.00000E+00 -49370 0.00000E+00 0.00000E+00 -49380 0.00000E+00 0.00000E+00 -49390 0.00000E+00 0.00000E+00 -49400 0.00000E+00 0.00000E+00 -49410 0.00000E+00 0.00000E+00 -49420 0.00000E+00 0.00000E+00 -49430 0.00000E+00 0.00000E+00 -49440 0.00000E+00 0.00000E+00 -49450 0.00000E+00 0.00000E+00 -49460 0.00000E+00 0.00000E+00 -49470 0.00000E+00 0.00000E+00 -49480 0.00000E+00 0.00000E+00 -49490 0.00000E+00 0.00000E+00 -49500 0.00000E+00 0.00000E+00 -49510 0.00000E+00 0.00000E+00 -49520 0.00000E+00 0.00000E+00 -49530 0.00000E+00 0.00000E+00 -49540 0.00000E+00 0.00000E+00 -49550 0.00000E+00 0.00000E+00 -49560 0.00000E+00 0.00000E+00 -49570 0.00000E+00 0.00000E+00 -49580 0.00000E+00 0.00000E+00 -49590 0.00000E+00 0.00000E+00 -49600 0.00000E+00 0.00000E+00 -49610 0.00000E+00 0.00000E+00 -49620 0.00000E+00 0.00000E+00 -49630 0.00000E+00 0.00000E+00 -49640 0.00000E+00 0.00000E+00 -49650 0.00000E+00 0.00000E+00 -49660 0.00000E+00 0.00000E+00 -49670 0.00000E+00 0.00000E+00 -49680 0.00000E+00 0.00000E+00 -49690 0.00000E+00 0.00000E+00 -49700 0.00000E+00 0.00000E+00 -49710 0.00000E+00 0.00000E+00 -49720 0.00000E+00 0.00000E+00 -49730 0.00000E+00 0.00000E+00 -49740 0.00000E+00 0.00000E+00 -49750 0.00000E+00 0.00000E+00 -49760 0.00000E+00 0.00000E+00 -49770 0.00000E+00 0.00000E+00 -49780 0.00000E+00 0.00000E+00 -49790 0.00000E+00 0.00000E+00 -49800 0.00000E+00 0.00000E+00 -49810 0.00000E+00 0.00000E+00 -49820 0.00000E+00 0.00000E+00 -49830 0.00000E+00 0.00000E+00 -49840 0.00000E+00 0.00000E+00 -49850 0.00000E+00 0.00000E+00 -49860 0.00000E+00 0.00000E+00 -49870 0.00000E+00 0.00000E+00 -49880 0.00000E+00 0.00000E+00 -49890 0.00000E+00 0.00000E+00 -49900 0.00000E+00 0.00000E+00 -49910 0.00000E+00 0.00000E+00 -49920 0.00000E+00 0.00000E+00 -49930 0.00000E+00 0.00000E+00 -49940 0.00000E+00 0.00000E+00 -49950 0.00000E+00 0.00000E+00 -49960 0.00000E+00 0.00000E+00 -49970 0.00000E+00 0.00000E+00 -49980 0.00000E+00 0.00000E+00 -49990 0.00000E+00 0.00000E+00 -50000 0.00000E+00 0.00000E+00 -50010 0.00000E+00 0.00000E+00 -50020 0.00000E+00 0.00000E+00 -50030 0.00000E+00 0.00000E+00 -50040 0.00000E+00 0.00000E+00 -50050 0.00000E+00 0.00000E+00 -50060 0.00000E+00 0.00000E+00 -50070 0.00000E+00 0.00000E+00 -50080 0.00000E+00 0.00000E+00 -50090 0.00000E+00 0.00000E+00 -50100 0.00000E+00 0.00000E+00 -50110 0.00000E+00 0.00000E+00 -50120 0.00000E+00 0.00000E+00 -50130 0.00000E+00 0.00000E+00 -50140 0.00000E+00 0.00000E+00 -50150 0.00000E+00 0.00000E+00 -50160 0.00000E+00 0.00000E+00 -50170 0.00000E+00 0.00000E+00 -50180 0.00000E+00 0.00000E+00 -50190 0.00000E+00 0.00000E+00 -50200 0.00000E+00 0.00000E+00 -50210 0.00000E+00 0.00000E+00 -50220 0.00000E+00 0.00000E+00 -50230 0.00000E+00 0.00000E+00 -50240 0.00000E+00 0.00000E+00 -50250 0.00000E+00 0.00000E+00 -50260 0.00000E+00 0.00000E+00 -50270 0.00000E+00 0.00000E+00 -50280 0.00000E+00 0.00000E+00 -50290 0.00000E+00 0.00000E+00 -50300 0.00000E+00 0.00000E+00 -50310 0.00000E+00 0.00000E+00 -50320 0.00000E+00 0.00000E+00 -50330 0.00000E+00 0.00000E+00 -50340 0.00000E+00 0.00000E+00 -50350 0.00000E+00 0.00000E+00 -50360 0.00000E+00 0.00000E+00 -50370 0.00000E+00 0.00000E+00 -50380 0.00000E+00 0.00000E+00 -50390 0.00000E+00 0.00000E+00 -50400 0.00000E+00 0.00000E+00 -50410 0.00000E+00 0.00000E+00 -50420 0.00000E+00 0.00000E+00 -50430 0.00000E+00 0.00000E+00 -50440 0.00000E+00 0.00000E+00 -50450 0.00000E+00 0.00000E+00 -50460 0.00000E+00 0.00000E+00 -50470 0.00000E+00 0.00000E+00 -50480 0.00000E+00 0.00000E+00 -50490 0.00000E+00 0.00000E+00 -50500 0.00000E+00 0.00000E+00 -50510 0.00000E+00 0.00000E+00 -50520 0.00000E+00 0.00000E+00 -50530 0.00000E+00 0.00000E+00 -50540 0.00000E+00 0.00000E+00 -50550 0.00000E+00 0.00000E+00 -50560 0.00000E+00 0.00000E+00 -50570 0.00000E+00 0.00000E+00 -50580 0.00000E+00 0.00000E+00 -50590 0.00000E+00 0.00000E+00 -50600 0.00000E+00 0.00000E+00 -50610 0.00000E+00 0.00000E+00 -50620 0.00000E+00 0.00000E+00 -50630 0.00000E+00 0.00000E+00 -50640 0.00000E+00 0.00000E+00 -50650 0.00000E+00 0.00000E+00 -50660 0.00000E+00 0.00000E+00 -50670 0.00000E+00 0.00000E+00 -50680 0.00000E+00 0.00000E+00 -50690 0.00000E+00 0.00000E+00 -50700 0.00000E+00 0.00000E+00 -50710 0.00000E+00 0.00000E+00 -50720 0.00000E+00 0.00000E+00 -50730 0.00000E+00 0.00000E+00 -50740 0.00000E+00 0.00000E+00 -50750 0.00000E+00 0.00000E+00 -50760 0.00000E+00 0.00000E+00 -50770 0.00000E+00 0.00000E+00 -50780 0.00000E+00 0.00000E+00 -50790 0.00000E+00 0.00000E+00 -50800 0.00000E+00 0.00000E+00 -50810 0.00000E+00 0.00000E+00 -50820 0.00000E+00 0.00000E+00 -50830 0.00000E+00 0.00000E+00 -50840 0.00000E+00 0.00000E+00 -50850 0.00000E+00 0.00000E+00 -50860 0.00000E+00 0.00000E+00 -50870 0.00000E+00 0.00000E+00 -50880 0.00000E+00 0.00000E+00 -50890 0.00000E+00 0.00000E+00 -50900 0.00000E+00 0.00000E+00 -50910 0.00000E+00 0.00000E+00 -50920 0.00000E+00 0.00000E+00 -50930 0.00000E+00 0.00000E+00 -50940 0.00000E+00 0.00000E+00 -50950 0.00000E+00 0.00000E+00 -50960 0.00000E+00 0.00000E+00 -50970 0.00000E+00 0.00000E+00 -50980 0.00000E+00 0.00000E+00 -50990 0.00000E+00 0.00000E+00 -51000 0.00000E+00 0.00000E+00 -51010 0.00000E+00 0.00000E+00 -51020 0.00000E+00 0.00000E+00 -51030 0.00000E+00 0.00000E+00 -51040 0.00000E+00 0.00000E+00 -51050 0.00000E+00 0.00000E+00 -51060 0.00000E+00 0.00000E+00 -51070 0.00000E+00 0.00000E+00 -51080 0.00000E+00 0.00000E+00 -51090 0.00000E+00 0.00000E+00 -51100 0.00000E+00 0.00000E+00 -51110 0.00000E+00 0.00000E+00 -51120 0.00000E+00 0.00000E+00 -51130 0.00000E+00 0.00000E+00 -51140 0.00000E+00 0.00000E+00 -51150 0.00000E+00 0.00000E+00 -51160 0.00000E+00 0.00000E+00 -51170 0.00000E+00 0.00000E+00 -51180 0.00000E+00 0.00000E+00 -51190 0.00000E+00 0.00000E+00 -51200 0.00000E+00 0.00000E+00 -51210 0.00000E+00 0.00000E+00 -51220 0.00000E+00 0.00000E+00 -51230 0.00000E+00 0.00000E+00 -51240 0.00000E+00 0.00000E+00 -51250 0.00000E+00 0.00000E+00 -51260 0.00000E+00 0.00000E+00 -51270 0.00000E+00 0.00000E+00 -51280 0.00000E+00 0.00000E+00 -51290 0.00000E+00 0.00000E+00 -51300 0.00000E+00 0.00000E+00 -51310 0.00000E+00 0.00000E+00 -51320 0.00000E+00 0.00000E+00 -51330 0.00000E+00 0.00000E+00 -51340 0.00000E+00 0.00000E+00 -51350 0.00000E+00 0.00000E+00 -51360 0.00000E+00 0.00000E+00 -51370 0.00000E+00 0.00000E+00 -51380 0.00000E+00 0.00000E+00 -51390 0.00000E+00 0.00000E+00 -51400 0.00000E+00 0.00000E+00 -51410 0.00000E+00 0.00000E+00 -51420 0.00000E+00 0.00000E+00 -51430 0.00000E+00 0.00000E+00 -51440 0.00000E+00 0.00000E+00 -51450 0.00000E+00 0.00000E+00 -51460 0.00000E+00 0.00000E+00 -51470 0.00000E+00 0.00000E+00 -51480 0.00000E+00 0.00000E+00 -51490 0.00000E+00 0.00000E+00 -51500 0.00000E+00 0.00000E+00 -51510 0.00000E+00 0.00000E+00 -51520 0.00000E+00 0.00000E+00 -51530 0.00000E+00 0.00000E+00 -51540 0.00000E+00 0.00000E+00 -51550 0.00000E+00 0.00000E+00 -51560 0.00000E+00 0.00000E+00 -51570 0.00000E+00 0.00000E+00 -51580 0.00000E+00 0.00000E+00 -51590 0.00000E+00 0.00000E+00 -51600 0.00000E+00 0.00000E+00 -51610 0.00000E+00 0.00000E+00 -51620 0.00000E+00 0.00000E+00 -51630 0.00000E+00 0.00000E+00 -51640 0.00000E+00 0.00000E+00 -51650 0.00000E+00 0.00000E+00 -51660 0.00000E+00 0.00000E+00 -51670 0.00000E+00 0.00000E+00 -51680 0.00000E+00 0.00000E+00 -51690 0.00000E+00 0.00000E+00 -51700 0.00000E+00 0.00000E+00 -51710 0.00000E+00 0.00000E+00 -51720 0.00000E+00 0.00000E+00 -51730 0.00000E+00 0.00000E+00 -51740 0.00000E+00 0.00000E+00 -51750 0.00000E+00 0.00000E+00 -51760 0.00000E+00 0.00000E+00 -51770 0.00000E+00 0.00000E+00 -51780 0.00000E+00 0.00000E+00 -51790 0.00000E+00 0.00000E+00 -51800 0.00000E+00 0.00000E+00 -51810 0.00000E+00 0.00000E+00 -51820 0.00000E+00 0.00000E+00 -51830 0.00000E+00 0.00000E+00 -51840 0.00000E+00 0.00000E+00 -51850 0.00000E+00 0.00000E+00 -51860 0.00000E+00 0.00000E+00 -51870 0.00000E+00 0.00000E+00 -51880 0.00000E+00 0.00000E+00 -51890 0.00000E+00 0.00000E+00 -51900 0.00000E+00 0.00000E+00 -51910 0.00000E+00 0.00000E+00 -51920 0.00000E+00 0.00000E+00 -51930 0.00000E+00 0.00000E+00 -51940 0.00000E+00 0.00000E+00 -51950 0.00000E+00 0.00000E+00 -51960 0.00000E+00 0.00000E+00 -51970 0.00000E+00 0.00000E+00 -51980 0.00000E+00 0.00000E+00 -51990 0.00000E+00 0.00000E+00 -52000 0.00000E+00 0.00000E+00 -52010 0.00000E+00 0.00000E+00 -52020 0.00000E+00 0.00000E+00 -52030 0.00000E+00 0.00000E+00 -52040 0.00000E+00 0.00000E+00 -52050 0.00000E+00 0.00000E+00 -52060 0.00000E+00 0.00000E+00 -52070 0.00000E+00 0.00000E+00 -52080 0.00000E+00 0.00000E+00 -52090 0.00000E+00 0.00000E+00 -52100 0.00000E+00 0.00000E+00 -52110 0.00000E+00 0.00000E+00 -52120 0.00000E+00 0.00000E+00 -52130 0.00000E+00 0.00000E+00 -52140 0.00000E+00 0.00000E+00 -52150 0.00000E+00 0.00000E+00 -52160 0.00000E+00 0.00000E+00 -52170 0.00000E+00 0.00000E+00 -52180 0.00000E+00 0.00000E+00 -52190 0.00000E+00 0.00000E+00 -52200 0.00000E+00 0.00000E+00 -52210 0.00000E+00 0.00000E+00 -52220 0.00000E+00 0.00000E+00 -52230 0.00000E+00 0.00000E+00 -52240 0.00000E+00 0.00000E+00 -52250 0.00000E+00 0.00000E+00 -52260 0.00000E+00 0.00000E+00 -52270 0.00000E+00 0.00000E+00 -52280 0.00000E+00 0.00000E+00 -52290 0.00000E+00 0.00000E+00 -52300 0.00000E+00 0.00000E+00 -52310 0.00000E+00 0.00000E+00 -52320 0.00000E+00 0.00000E+00 -52330 0.00000E+00 0.00000E+00 -52340 0.00000E+00 0.00000E+00 -52350 0.00000E+00 0.00000E+00 -52360 0.00000E+00 0.00000E+00 -52370 0.00000E+00 0.00000E+00 -52380 0.00000E+00 0.00000E+00 -52390 0.00000E+00 0.00000E+00 -52400 0.00000E+00 0.00000E+00 -52410 0.00000E+00 0.00000E+00 -52420 0.00000E+00 0.00000E+00 -52430 0.00000E+00 0.00000E+00 -52440 0.00000E+00 0.00000E+00 -52450 0.00000E+00 0.00000E+00 -52460 0.00000E+00 0.00000E+00 -52470 0.00000E+00 0.00000E+00 -52480 0.00000E+00 0.00000E+00 -52490 0.00000E+00 0.00000E+00 -52500 0.00000E+00 0.00000E+00 -52510 0.00000E+00 0.00000E+00 -52520 0.00000E+00 0.00000E+00 -52530 0.00000E+00 0.00000E+00 -52540 0.00000E+00 0.00000E+00 -52550 0.00000E+00 0.00000E+00 -52560 0.00000E+00 0.00000E+00 -52570 0.00000E+00 0.00000E+00 -52580 0.00000E+00 0.00000E+00 -52590 0.00000E+00 0.00000E+00 -52600 0.00000E+00 0.00000E+00 -52610 0.00000E+00 0.00000E+00 -52620 0.00000E+00 0.00000E+00 -52630 0.00000E+00 0.00000E+00 -52640 0.00000E+00 0.00000E+00 -52650 0.00000E+00 0.00000E+00 -52660 0.00000E+00 0.00000E+00 -52670 0.00000E+00 0.00000E+00 -52680 0.00000E+00 0.00000E+00 -52690 0.00000E+00 0.00000E+00 -52700 0.00000E+00 0.00000E+00 -52710 0.00000E+00 0.00000E+00 -52720 0.00000E+00 0.00000E+00 -52730 0.00000E+00 0.00000E+00 -52740 0.00000E+00 0.00000E+00 -52750 0.00000E+00 0.00000E+00 -52760 0.00000E+00 0.00000E+00 -52770 0.00000E+00 0.00000E+00 -52780 0.00000E+00 0.00000E+00 -52790 0.00000E+00 0.00000E+00 -52800 0.00000E+00 0.00000E+00 -52810 0.00000E+00 0.00000E+00 -52820 0.00000E+00 0.00000E+00 -52830 0.00000E+00 0.00000E+00 -52840 0.00000E+00 0.00000E+00 -52850 0.00000E+00 0.00000E+00 -52860 0.00000E+00 0.00000E+00 -52870 0.00000E+00 0.00000E+00 -52880 0.00000E+00 0.00000E+00 -52890 0.00000E+00 0.00000E+00 -52900 0.00000E+00 0.00000E+00 -52910 0.00000E+00 0.00000E+00 -52920 0.00000E+00 0.00000E+00 -52930 0.00000E+00 0.00000E+00 -52940 0.00000E+00 0.00000E+00 -52950 0.00000E+00 0.00000E+00 -52960 0.00000E+00 0.00000E+00 -52970 0.00000E+00 0.00000E+00 -52980 0.00000E+00 0.00000E+00 -52990 0.00000E+00 0.00000E+00 -53000 0.00000E+00 0.00000E+00 -53010 0.00000E+00 0.00000E+00 -53020 0.00000E+00 0.00000E+00 -53030 0.00000E+00 0.00000E+00 -53040 0.00000E+00 0.00000E+00 -53050 0.00000E+00 0.00000E+00 -53060 0.00000E+00 0.00000E+00 -53070 0.00000E+00 0.00000E+00 -53080 0.00000E+00 0.00000E+00 -53090 0.00000E+00 0.00000E+00 -53100 0.00000E+00 0.00000E+00 -53110 0.00000E+00 0.00000E+00 -53120 0.00000E+00 0.00000E+00 -53130 0.00000E+00 0.00000E+00 -53140 0.00000E+00 0.00000E+00 -53150 0.00000E+00 0.00000E+00 -53160 0.00000E+00 0.00000E+00 -53170 0.00000E+00 0.00000E+00 -53180 0.00000E+00 0.00000E+00 -53190 0.00000E+00 0.00000E+00 -53200 0.00000E+00 0.00000E+00 -53210 0.00000E+00 0.00000E+00 -53220 0.00000E+00 0.00000E+00 -53230 0.00000E+00 0.00000E+00 -53240 0.00000E+00 0.00000E+00 -53250 0.00000E+00 0.00000E+00 -53260 0.00000E+00 0.00000E+00 -53270 0.00000E+00 0.00000E+00 -53280 0.00000E+00 0.00000E+00 -53290 0.00000E+00 0.00000E+00 -53300 0.00000E+00 0.00000E+00 -53310 0.00000E+00 0.00000E+00 -53320 0.00000E+00 0.00000E+00 -53330 0.00000E+00 0.00000E+00 -53340 0.00000E+00 0.00000E+00 -53350 0.00000E+00 0.00000E+00 -53360 0.00000E+00 0.00000E+00 -53370 0.00000E+00 0.00000E+00 -53380 0.00000E+00 0.00000E+00 -53390 0.00000E+00 0.00000E+00 -53400 0.00000E+00 0.00000E+00 -53410 0.00000E+00 0.00000E+00 -53420 0.00000E+00 0.00000E+00 -53430 0.00000E+00 0.00000E+00 -53440 0.00000E+00 0.00000E+00 -53450 0.00000E+00 0.00000E+00 -53460 0.00000E+00 0.00000E+00 -53470 0.00000E+00 0.00000E+00 -53480 0.00000E+00 0.00000E+00 -53490 0.00000E+00 0.00000E+00 -53500 0.00000E+00 0.00000E+00 -53510 0.00000E+00 0.00000E+00 -53520 0.00000E+00 0.00000E+00 -53530 0.00000E+00 0.00000E+00 -53540 0.00000E+00 0.00000E+00 -53550 0.00000E+00 0.00000E+00 -53560 0.00000E+00 0.00000E+00 -53570 0.00000E+00 0.00000E+00 -53580 0.00000E+00 0.00000E+00 -53590 0.00000E+00 0.00000E+00 -53600 0.00000E+00 0.00000E+00 -53610 0.00000E+00 0.00000E+00 -53620 0.00000E+00 0.00000E+00 -53630 0.00000E+00 0.00000E+00 -53640 0.00000E+00 0.00000E+00 -53650 0.00000E+00 0.00000E+00 -53660 0.00000E+00 0.00000E+00 -53670 0.00000E+00 0.00000E+00 -53680 0.00000E+00 0.00000E+00 -53690 0.00000E+00 0.00000E+00 -53700 0.00000E+00 0.00000E+00 -53710 0.00000E+00 0.00000E+00 -53720 0.00000E+00 0.00000E+00 -53730 0.00000E+00 0.00000E+00 -53740 0.00000E+00 0.00000E+00 -53750 0.00000E+00 0.00000E+00 -53760 0.00000E+00 0.00000E+00 -53770 0.00000E+00 0.00000E+00 -53780 0.00000E+00 0.00000E+00 -53790 0.00000E+00 0.00000E+00 -53800 0.00000E+00 0.00000E+00 -53810 0.00000E+00 0.00000E+00 -53820 0.00000E+00 0.00000E+00 -53830 0.00000E+00 0.00000E+00 -53840 0.00000E+00 0.00000E+00 -53850 0.00000E+00 0.00000E+00 -53860 0.00000E+00 0.00000E+00 -53870 0.00000E+00 0.00000E+00 -53880 0.00000E+00 0.00000E+00 -53890 0.00000E+00 0.00000E+00 -53900 0.00000E+00 0.00000E+00 -53910 0.00000E+00 0.00000E+00 -53920 0.00000E+00 0.00000E+00 -53930 0.00000E+00 0.00000E+00 -53940 0.00000E+00 0.00000E+00 -53950 0.00000E+00 0.00000E+00 -53960 0.00000E+00 0.00000E+00 -53970 0.00000E+00 0.00000E+00 -53980 0.00000E+00 0.00000E+00 -53990 0.00000E+00 0.00000E+00 -54000 0.00000E+00 0.00000E+00 -54010 0.00000E+00 0.00000E+00 -54020 0.00000E+00 0.00000E+00 -54030 0.00000E+00 0.00000E+00 -54040 0.00000E+00 0.00000E+00 -54050 0.00000E+00 0.00000E+00 -54060 0.00000E+00 0.00000E+00 -54070 0.00000E+00 0.00000E+00 -54080 0.00000E+00 0.00000E+00 -54090 0.00000E+00 0.00000E+00 -54100 0.00000E+00 0.00000E+00 -54110 0.00000E+00 0.00000E+00 -54120 0.00000E+00 0.00000E+00 -54130 0.00000E+00 0.00000E+00 -54140 0.00000E+00 0.00000E+00 -54150 0.00000E+00 0.00000E+00 -54160 0.00000E+00 0.00000E+00 -54170 0.00000E+00 0.00000E+00 -54180 0.00000E+00 0.00000E+00 -54190 0.00000E+00 0.00000E+00 -54200 0.00000E+00 0.00000E+00 -54210 0.00000E+00 0.00000E+00 -54220 0.00000E+00 0.00000E+00 -54230 0.00000E+00 0.00000E+00 -54240 0.00000E+00 0.00000E+00 -54250 0.00000E+00 0.00000E+00 -54260 0.00000E+00 0.00000E+00 -54270 0.00000E+00 0.00000E+00 -54280 0.00000E+00 0.00000E+00 -54290 0.00000E+00 0.00000E+00 -54300 0.00000E+00 0.00000E+00 -54310 0.00000E+00 0.00000E+00 -54320 0.00000E+00 0.00000E+00 -54330 0.00000E+00 0.00000E+00 -54340 0.00000E+00 0.00000E+00 -54350 0.00000E+00 0.00000E+00 -54360 0.00000E+00 0.00000E+00 -54370 0.00000E+00 0.00000E+00 -54380 0.00000E+00 0.00000E+00 -54390 0.00000E+00 0.00000E+00 -54400 0.00000E+00 0.00000E+00 -54410 0.00000E+00 0.00000E+00 -54420 0.00000E+00 0.00000E+00 -54430 0.00000E+00 0.00000E+00 -54440 0.00000E+00 0.00000E+00 -54450 0.00000E+00 0.00000E+00 -54460 0.00000E+00 0.00000E+00 -54470 0.00000E+00 0.00000E+00 -54480 0.00000E+00 0.00000E+00 -54490 0.00000E+00 0.00000E+00 -54500 0.00000E+00 0.00000E+00 -54510 0.00000E+00 0.00000E+00 -54520 0.00000E+00 0.00000E+00 -54530 0.00000E+00 0.00000E+00 -54540 0.00000E+00 0.00000E+00 -54550 0.00000E+00 0.00000E+00 -54560 0.00000E+00 0.00000E+00 -54570 0.00000E+00 0.00000E+00 -54580 0.00000E+00 0.00000E+00 -54590 0.00000E+00 0.00000E+00 -54600 0.00000E+00 0.00000E+00 -54610 0.00000E+00 0.00000E+00 -54620 0.00000E+00 0.00000E+00 -54630 0.00000E+00 0.00000E+00 -54640 0.00000E+00 0.00000E+00 -54650 0.00000E+00 0.00000E+00 -54660 0.00000E+00 0.00000E+00 -54670 0.00000E+00 0.00000E+00 -54680 0.00000E+00 0.00000E+00 -54690 0.00000E+00 0.00000E+00 -54700 0.00000E+00 0.00000E+00 -54710 0.00000E+00 0.00000E+00 -54720 0.00000E+00 0.00000E+00 -54730 0.00000E+00 0.00000E+00 -54740 0.00000E+00 0.00000E+00 -54750 0.00000E+00 0.00000E+00 -54760 0.00000E+00 0.00000E+00 -54770 0.00000E+00 0.00000E+00 -54780 0.00000E+00 0.00000E+00 -54790 0.00000E+00 0.00000E+00 -54800 0.00000E+00 0.00000E+00 -54810 0.00000E+00 0.00000E+00 -54820 0.00000E+00 0.00000E+00 -54830 0.00000E+00 0.00000E+00 -54840 0.00000E+00 0.00000E+00 -54850 0.00000E+00 0.00000E+00 -54860 0.00000E+00 0.00000E+00 -54870 0.00000E+00 0.00000E+00 -54880 0.00000E+00 0.00000E+00 -54890 0.00000E+00 0.00000E+00 -54900 0.00000E+00 0.00000E+00 -54910 0.00000E+00 0.00000E+00 -54920 0.00000E+00 0.00000E+00 -54930 0.00000E+00 0.00000E+00 -54940 0.00000E+00 0.00000E+00 -54950 0.00000E+00 0.00000E+00 -54960 0.00000E+00 0.00000E+00 -54970 0.00000E+00 0.00000E+00 -54980 0.00000E+00 0.00000E+00 -54990 0.00000E+00 0.00000E+00 -55000 0.00000E+00 0.00000E+00 -55010 0.00000E+00 0.00000E+00 -55020 0.00000E+00 0.00000E+00 -55030 0.00000E+00 0.00000E+00 -55040 0.00000E+00 0.00000E+00 -55050 0.00000E+00 0.00000E+00 -55060 0.00000E+00 0.00000E+00 -55070 0.00000E+00 0.00000E+00 -55080 0.00000E+00 0.00000E+00 -55090 0.00000E+00 0.00000E+00 -55100 0.00000E+00 0.00000E+00 -55110 0.00000E+00 0.00000E+00 -55120 0.00000E+00 0.00000E+00 -55130 0.00000E+00 0.00000E+00 -55140 0.00000E+00 0.00000E+00 -55150 0.00000E+00 0.00000E+00 -55160 0.00000E+00 0.00000E+00 -55170 0.00000E+00 0.00000E+00 -55180 0.00000E+00 0.00000E+00 -55190 0.00000E+00 0.00000E+00 -55200 0.00000E+00 0.00000E+00 -55210 0.00000E+00 0.00000E+00 -55220 0.00000E+00 0.00000E+00 -55230 0.00000E+00 0.00000E+00 -55240 0.00000E+00 0.00000E+00 -55250 0.00000E+00 0.00000E+00 -55260 0.00000E+00 0.00000E+00 -55270 0.00000E+00 0.00000E+00 -55280 0.00000E+00 0.00000E+00 -55290 0.00000E+00 0.00000E+00 -55300 0.00000E+00 0.00000E+00 -55310 0.00000E+00 0.00000E+00 -55320 0.00000E+00 0.00000E+00 -55330 0.00000E+00 0.00000E+00 -55340 0.00000E+00 0.00000E+00 -55350 0.00000E+00 0.00000E+00 -55360 0.00000E+00 0.00000E+00 -55370 0.00000E+00 0.00000E+00 -55380 0.00000E+00 0.00000E+00 -55390 0.00000E+00 0.00000E+00 -55400 0.00000E+00 0.00000E+00 -55410 0.00000E+00 0.00000E+00 -55420 0.00000E+00 0.00000E+00 -55430 0.00000E+00 0.00000E+00 -55440 0.00000E+00 0.00000E+00 -55450 0.00000E+00 0.00000E+00 -55460 0.00000E+00 0.00000E+00 -55470 0.00000E+00 0.00000E+00 -55480 0.00000E+00 0.00000E+00 -55490 0.00000E+00 0.00000E+00 -55500 0.00000E+00 0.00000E+00 -55510 0.00000E+00 0.00000E+00 -55520 0.00000E+00 0.00000E+00 -55530 0.00000E+00 0.00000E+00 -55540 0.00000E+00 0.00000E+00 -55550 0.00000E+00 0.00000E+00 -55560 0.00000E+00 0.00000E+00 -55570 0.00000E+00 0.00000E+00 -55580 0.00000E+00 0.00000E+00 -55590 0.00000E+00 0.00000E+00 -55600 0.00000E+00 0.00000E+00 -55610 0.00000E+00 0.00000E+00 -55620 0.00000E+00 0.00000E+00 -55630 0.00000E+00 0.00000E+00 -55640 0.00000E+00 0.00000E+00 -55650 0.00000E+00 0.00000E+00 -55660 0.00000E+00 0.00000E+00 -55670 0.00000E+00 0.00000E+00 -55680 0.00000E+00 0.00000E+00 -55690 0.00000E+00 0.00000E+00 -55700 0.00000E+00 0.00000E+00 -55710 0.00000E+00 0.00000E+00 -55720 0.00000E+00 0.00000E+00 -55730 0.00000E+00 0.00000E+00 -55740 0.00000E+00 0.00000E+00 -55750 0.00000E+00 0.00000E+00 -55760 0.00000E+00 0.00000E+00 -55770 0.00000E+00 0.00000E+00 -55780 0.00000E+00 0.00000E+00 -55790 0.00000E+00 0.00000E+00 -55800 0.00000E+00 0.00000E+00 -55810 0.00000E+00 0.00000E+00 -55820 0.00000E+00 0.00000E+00 -55830 0.00000E+00 0.00000E+00 -55840 0.00000E+00 0.00000E+00 -55850 0.00000E+00 0.00000E+00 -55860 0.00000E+00 0.00000E+00 -55870 0.00000E+00 0.00000E+00 -55880 0.00000E+00 0.00000E+00 -55890 0.00000E+00 0.00000E+00 -55900 0.00000E+00 0.00000E+00 -55910 0.00000E+00 0.00000E+00 -55920 0.00000E+00 0.00000E+00 -55930 0.00000E+00 0.00000E+00 -55940 0.00000E+00 0.00000E+00 -55950 0.00000E+00 0.00000E+00 -55960 0.00000E+00 0.00000E+00 -55970 0.00000E+00 0.00000E+00 -55980 0.00000E+00 0.00000E+00 -55990 0.00000E+00 0.00000E+00 -56000 0.00000E+00 0.00000E+00 -56010 0.00000E+00 0.00000E+00 -56020 0.00000E+00 0.00000E+00 -56030 0.00000E+00 0.00000E+00 -56040 0.00000E+00 0.00000E+00 -56050 0.00000E+00 0.00000E+00 -56060 0.00000E+00 0.00000E+00 -56070 0.00000E+00 0.00000E+00 -56080 0.00000E+00 0.00000E+00 -56090 0.00000E+00 0.00000E+00 -56100 0.00000E+00 0.00000E+00 -56110 0.00000E+00 0.00000E+00 -56120 0.00000E+00 0.00000E+00 -56130 0.00000E+00 0.00000E+00 -56140 0.00000E+00 0.00000E+00 -56150 0.00000E+00 0.00000E+00 -56160 0.00000E+00 0.00000E+00 -56170 0.00000E+00 0.00000E+00 -56180 0.00000E+00 0.00000E+00 -56190 0.00000E+00 0.00000E+00 -56200 0.00000E+00 0.00000E+00 -56210 0.00000E+00 0.00000E+00 -56220 0.00000E+00 0.00000E+00 -56230 0.00000E+00 0.00000E+00 -56240 0.00000E+00 0.00000E+00 -56250 0.00000E+00 0.00000E+00 -56260 0.00000E+00 0.00000E+00 -56270 0.00000E+00 0.00000E+00 -56280 0.00000E+00 0.00000E+00 -56290 0.00000E+00 0.00000E+00 -56300 0.00000E+00 0.00000E+00 -56310 0.00000E+00 0.00000E+00 -56320 0.00000E+00 0.00000E+00 -56330 0.00000E+00 0.00000E+00 -56340 0.00000E+00 0.00000E+00 -56350 0.00000E+00 0.00000E+00 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.out b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.out deleted file mode 100644 index cf98a118..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2-IUPAC.out +++ /dev/null @@ -1,113 +0,0 @@ -NO2-IUPAC IUPAC at temp. T1/T2 220.0 298.0 - Bin Wavelength (nm) Solar Flux X-sect(T1) X-sect(T2) - 1 177.49 - 178.30 1.023E+11 0.000E+00 0.000E+00 - 2 178.30 - 179.26 1.443E+11 0.000E+00 0.000E+00 - 3 179.26 - 180.38 1.624E+11 0.000E+00 0.000E+00 - 4 180.38 - 181.65 2.136E+11 0.000E+00 0.000E+00 - 5 181.65 - 183.08 2.998E+11 0.000E+00 0.000E+00 - 6 183.08 - 184.65 2.927E+11 0.000E+00 0.000E+00 - 7 184.65 - 186.37 3.082E+11 0.000E+00 0.000E+00 - 8 186.37 - 188.24 4.765E+11 0.000E+00 0.000E+00 - 9 188.24 - 190.25 6.149E+11 0.000E+00 0.000E+00 - 10 190.25 - 192.42 7.709E+11 0.000E+00 0.000E+00 - 11 192.42 - 194.73 9.205E+11 0.000E+00 0.000E+00 - 12 194.73 - 197.20 1.345E+12 0.000E+00 0.000E+00 - 13 197.20 - 198.50 7.772E+11 0.000E+00 0.000E+00 - 14 198.50 - 200.00 9.630E+11 0.000E+00 0.000E+00 - 15 200.00 - 202.50 1.930E+12 0.000E+00 0.000E+00 - 16 202.50 - 204.00 1.291E+12 0.000E+00 0.000E+00 - 17 204.00 - 206.50 2.593E+12 2.523E-19 2.513E-19 - 18 206.50 - 209.50 4.391E+12 3.942E-19 4.053E-19 - 19 209.50 - 212.50 8.905E+12 4.317E-19 4.544E-19 - 20 212.50 - 215.50 1.081E+13 4.517E-19 4.805E-19 - 21 215.50 - 218.50 1.153E+13 4.506E-19 4.797E-19 - 22 218.50 - 221.50 1.451E+13 4.367E-19 4.634E-19 - 23 221.50 - 225.00 2.131E+13 3.923E-19 4.150E-19 - 24 225.00 - 229.00 2.063E+13 3.259E-19 3.445E-19 - 25 229.00 - 233.00 2.298E+13 2.368E-19 2.533E-19 - 26 233.00 - 237.50 2.396E+13 1.448E-19 1.623E-19 - 27 237.50 - 242.50 2.822E+13 7.707E-20 8.560E-20 - 28 242.50 - 248.00 3.842E+13 3.546E-20 4.026E-20 - 29 248.00 - 254.00 3.790E+13 1.184E-20 1.494E-20 - 30 254.00 - 260.00 7.566E+13 9.363E-21 1.304E-20 - 31 260.00 - 265.50 1.072E+14 1.655E-20 1.968E-20 - 32 265.50 - 270.50 1.715E+14 2.587E-20 2.628E-20 - 33 270.50 - 275.50 1.277E+14 3.630E-20 3.539E-20 - 34 275.50 - 280.00 1.204E+14 4.733E-20 4.652E-20 - 35 280.00 - 283.50 1.214E+14 5.925E-20 5.929E-20 - 36 283.50 - 286.50 1.035E+14 6.767E-20 6.823E-20 - 37 286.50 - 289.00 1.229E+14 7.860E-20 7.819E-20 - 38 289.00 - 291.00 1.601E+14 8.808E-20 8.676E-20 - 39 291.00 - 293.00 1.540E+14 9.510E-20 9.418E-20 - 40 293.00 - 295.00 1.526E+14 1.025E-19 1.022E-19 - 41 295.00 - 296.75 1.481E+14 1.101E-19 1.104E-19 - 42 296.75 - 298.25 1.190E+14 1.175E-19 1.184E-19 - 43 298.25 - 299.55 8.872E+13 1.236E-19 1.250E-19 - 44 299.55 - 300.50 6.089E+13 1.283E-19 1.300E-19 - 45 300.50 - 301.50 7.177E+13 1.344E-19 1.362E-19 - 46 301.50 - 302.50 6.438E+13 1.403E-19 1.421E-19 - 47 302.50 - 303.50 9.648E+13 1.466E-19 1.484E-19 - 48 303.50 - 304.50 8.564E+13 1.525E-19 1.543E-19 - 49 304.50 - 305.50 9.661E+13 1.586E-19 1.604E-19 - 50 305.50 - 306.50 8.102E+13 1.643E-19 1.661E-19 - 51 306.50 - 307.45 8.878E+13 1.699E-19 1.715E-19 - 52 307.45 - 308.50 1.037E+14 1.755E-19 1.770E-19 - 53 308.50 - 309.45 8.216E+13 1.808E-19 1.822E-19 - 54 309.45 - 310.50 8.354E+13 1.871E-19 1.882E-19 - 55 310.50 - 311.50 1.308E+14 1.935E-19 1.939E-19 - 56 311.50 - 312.45 1.019E+14 1.998E-19 1.993E-19 - 57 312.45 - 313.50 1.135E+14 2.064E-19 2.050E-19 - 58 313.50 - 314.50 1.144E+14 2.129E-19 2.106E-19 - 59 314.50 - 315.70 1.297E+14 2.203E-19 2.175E-19 - 60 315.70 - 317.20 1.504E+14 2.288E-19 2.281E-19 - 61 317.20 - 318.70 1.733E+14 2.368E-19 2.382E-19 - 62 318.70 - 320.30 1.893E+14 2.465E-19 2.505E-19 - 63 320.30 - 322.50 2.728E+14 2.566E-19 2.635E-19 - 64 322.50 - 326.95 6.081E+14 2.747E-19 2.872E-19 - 65 326.95 - 334.95 1.296E+15 3.071E-19 3.274E-19 - 66 334.95 - 345.00 1.609E+15 3.711E-19 3.953E-19 - 67 345.00 - 355.05 1.766E+15 4.366E-19 4.608E-19 - 68 355.05 - 365.03 1.744E+15 5.018E-19 5.170E-19 - 69 365.03 - 375.00 2.097E+15 5.614E-19 5.641E-19 - 70 375.00 - 389.95 3.038E+15 5.926E-19 5.967E-19 - 71 389.95 - 412.45 6.791E+15 3.193E-19 3.505E-19 - 72 412.45 - 437.55 9.281E+15 5.325E-21 1.006E-20 - 73 437.55 - 485.10 2.224E+16 0.000E+00 0.000E+00 - 74 485.10 - 560.10 3.676E+16 0.000E+00 0.000E+00 - 75 560.10 - 635.10 3.960E+16 0.000E+00 0.000E+00 - 76 635.10 - 760.20 6.302E+16 0.000E+00 0.000E+00 - 77 760.20 - 850.00 4.013E+16 0.000E+00 0.000E+00 - -SOLAR FLUX - 1.023E+11 1.443E+11 1.624E+11 2.136E+11 2.998E+11 2.927E+11 3.082E+11 4.765E+11 - 6.149E+11 7.709E+11 9.205E+11 1.345E+12 7.772E+11 9.630E+11 1.930E+12 1.291E+12 - 2.593E+12 4.391E+12 8.905E+12 1.081E+13 1.153E+13 1.451E+13 2.131E+13 2.063E+13 - 2.298E+13 2.396E+13 2.822E+13 3.842E+13 3.790E+13 7.566E+13 1.072E+14 1.715E+14 - 1.277E+14 1.204E+14 1.214E+14 1.035E+14 1.229E+14 1.601E+14 1.540E+14 1.526E+14 - 1.481E+14 1.190E+14 8.872E+13 6.089E+13 7.177E+13 6.438E+13 9.648E+13 8.564E+13 - 9.661E+13 8.102E+13 8.878E+13 1.037E+14 8.216E+13 8.354E+13 1.308E+14 1.019E+14 - 1.135E+14 1.144E+14 1.297E+14 1.504E+14 1.733E+14 1.893E+14 2.728E+14 6.081E+14 - 1.296E+15 1.609E+15 1.766E+15 1.744E+15 2.097E+15 3.038E+15 6.791E+15 9.281E+15 - 2.224E+16 3.676E+16 3.960E+16 6.302E+16 4.013E+16 -NO2-IUPAC IUPAC 220. - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.523E-19 3.942E-19 4.317E-19 4.517E-19 4.506E-19 4.367E-19 3.923E-19 3.259E-19 - 2.368E-19 1.448E-19 7.707E-20 3.546E-20 1.184E-20 9.363E-21 1.655E-20 2.587E-20 - 3.630E-20 4.733E-20 5.925E-20 6.767E-20 7.860E-20 8.808E-20 9.510E-20 1.025E-19 - 1.101E-19 1.175E-19 1.236E-19 1.283E-19 1.344E-19 1.403E-19 1.466E-19 1.525E-19 - 1.586E-19 1.643E-19 1.699E-19 1.755E-19 1.808E-19 1.871E-19 1.935E-19 1.998E-19 - 2.064E-19 2.129E-19 2.203E-19 2.288E-19 2.368E-19 2.465E-19 2.566E-19 2.747E-19 - 3.071E-19 3.711E-19 4.366E-19 5.018E-19 5.614E-19 5.926E-19 3.193E-19 5.325E-21 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 -NO2-IUPAC IUPAC 298. - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - 2.513E-19 4.053E-19 4.544E-19 4.805E-19 4.797E-19 4.634E-19 4.150E-19 3.445E-19 - 2.533E-19 1.623E-19 8.560E-20 4.026E-20 1.494E-20 1.304E-20 1.968E-20 2.628E-20 - 3.539E-20 4.652E-20 5.929E-20 6.823E-20 7.819E-20 8.676E-20 9.418E-20 1.022E-19 - 1.104E-19 1.184E-19 1.250E-19 1.300E-19 1.362E-19 1.421E-19 1.484E-19 1.543E-19 - 1.604E-19 1.661E-19 1.715E-19 1.770E-19 1.822E-19 1.882E-19 1.939E-19 1.993E-19 - 2.050E-19 2.106E-19 2.175E-19 2.281E-19 2.382E-19 2.505E-19 2.635E-19 2.872E-19 - 3.274E-19 3.953E-19 4.608E-19 5.170E-19 5.641E-19 5.967E-19 3.505E-19 1.006E-20 - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2_FJX.out b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2_FJX.out deleted file mode 100644 index 9bb7b343..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/NO2_FJX.out +++ /dev/null @@ -1,7 +0,0 @@ -NO2-IUPAC IUPAC at temp. T1/T2 220.0 298.0 -NO2-IUP220 0.000E+00 0.000E+00 0.000E+00 0.000E+00 9.064E-20 3.942E-19 - 4.317E-19 4.467E-19 3.114E-20 9.853E-20 1.142E-19 1.056E-19 - 1.476E-19 1.879E-19 2.280E-19 3.255E-19 4.400E-19 2.342E-22 -NO2-IUP298 0.000E+00 0.000E+00 0.000E+00 0.000E+00 9.028E-20 4.053E-19 - 4.544E-19 4.752E-19 3.364E-20 1.015E-19 1.157E-19 1.055E-19 - 1.493E-19 1.886E-19 2.281E-19 3.452E-19 4.594E-19 4.424E-22 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_FJX.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_FJX.f deleted file mode 100644 index 89d0ce07..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_FJX.f +++ /dev/null @@ -1,186 +0,0 @@ - program FJX1_bins -C -c -c********** this shortened version reads in the single pair of Xsects -c********** from the output of add_xsect.f - just use XXX.out as stdin -c********** and the fast-JX tables are printed to stdout. -c -C ****************************************************************** -C * * -C * GENERATING SOLAR FLUX AVERAGED CROSS SECTION IN GIVEN BINS * -C * >>>>>>>from ref code 77-bin to 18-bin fast-JX v5.3 <<<<<<< * -C * * -C ****************************************************************** -C -C----------------------------------------------------------------------- -C -C Combines the 77-bin std Xsects (including XX SR ODF bins) = 145 total -C into the fast-J(2) bins (7 at trop wavels, 18 for strat+trop) -C according to a supplied "FJX_bins.dat" file for the Fast-JX code -C -C history Standard model: Xin Zhu -C Fast-J & Distribution: Oliver Wild (9/98) -C Fast-J2: Huisheng Bian (8/02) -C new Fast-J(2) Prather (7/04) -C new Fast-JX v-5.3 Prather (6/05) -C -c open ( 2, file='FJX_bins.dat',status='OLD') - -C----------------------------------------------------------------------- - include 'cmn_bins.f' - -C---------77-bin spectral data----------UNIT=10---------------------------- - - do J=1,40 - do K=1,3 - TQQ(K,J) = 0.0 - enddo - enddo - - read( 5,'(A)') TITLE0 - write(6,'(a)') TITLE0 - read( 5,*) - - NWWW = 77 - NW1 = 1 - NW2 = NWWW - NQQQ = 1 - - do IW=1,NWWW - read(5,'(5x,f7.2,2x,f7.2,e12.3)') WBIN(IW),WBIN(IW+1),FL(IW) - enddo - - do IW=1,12 - read( 5,*) - enddo - - do IW=1,NWWW - WL(IW) = 0.5*(WBIN(IW)+WBIN(IW+1)) - enddo - -C-------rest of X-sections - do JQ=1,NQQQ - read( 5,'(a20,f5.0)') TITLEJ(1,JQ),TQQ(1,JQ) - read( 5,'(8e10.3)') (QQQ(IW,1,JQ),IW=1,NWWW) - read( 5,'(a20,f5.0)') TITLEJ(2,JQ),TQQ(2,JQ) - read( 5,'(8e10.3)') (QQQ(IW,2,JQ),IW=1,NWWW) - enddo - - NSPEC = NQQQ - NBIN = NWWW - -C****************now combine 77-bins+ODFs (145 bins) to get fast-J********* - - call COMB1(18) - - stop - end - - - subroutine COMB1(NN) -C----------------------------------------------------------------------- -C Combine x-sections from 'NBIN' to 'NN' bins (77 to 18 for Fast-J2) -C----------------------------------------------------------------------- - include 'cmn_bins.f' - integer NN,KT,IG,JG,NG(25,25) - real*8 RAYLAY -c -C-----Read in wavelength bins to combine: - open (2, file='FJX_bins.dat',status='OLD') - do IG = 1,NN - read(2,'(25I4)') (NG(JG,IG),JG=1,25) - enddo - - read(2,'(30x,4i5)') NWWW,NWSRB,NSR,NODF - read(2,'(a)') - read(2,'(8e10.3)') (WBIN(IW),IW=1,NWWW+1) - do IW=1,NWWW - WL(IW) = 0.5*(WBIN(IW)+WBIN(IW+1)) - enddo - read(2,'(a)') - read(2,'(8e10.3)') (FL(IW),IW=1,NWWW) - read(2,'(a)') - do L = 1,NSR - read(2,'(6F10.1,I3)') (ODF(I,L),I=1,NODF), ISR(L) - enddo - - close(2) -c -C----re-distribution of S-R sub-bins into one dimension - N=0 - do I=1,NSR - M=N - do J=1,ISR(I) - N=M+J - FFL(N)=FL(I)*ODF(J,I) - do JQ=1,NQQQ - QQQQ(N,1,JQ)=QQQ(I,1,JQ) - QQQQ(N,2,JQ)=QQQ(I,2,JQ) - enddo - enddo - enddo -c -C----distribute the rest of 77 bins into one dimension above - NT = N + NBIN - NSR -c WRITE(6,*) ' TOTAL BINS',NT,NSR - do I=N+1,NT - FFL(I)=FL(I-N+NSR) - do JQ=1,NQQQ - QQQQ(I,1,JQ)=QQQ((I-N+NSR),1,JQ) - QQQQ(I,2,JQ)=QQQ((I-N+NSR),2,JQ) - enddo - enddo -C - do I=1,NN - SFL(I)=0.D0 - do JQ=1,NQQQ - SQQQ(I,1,JQ)=0.D0 - SQQQ(I,2,JQ)=0.D0 - enddo - enddo -C -C----replace all X-sect_s by X-sect * Flux - do N=1,NT - do IG=1,NN - do JG=1,25 - if(N.EQ.NG(JG,IG)) then - call SUMM(IG,N) - endif - enddo - enddo - enddo -C - do I=1,NN - do JQ=1,NQQQ - QQQ(I,1,JQ)=SQQQ(I,1,JQ)/SFL(I) - QQQ(I,2,JQ)=SQQQ(I,2,JQ)/SFL(I) - enddo - enddo - -C-----output in Fast-JX 18-wavelength format - -c (JX_spec.dat) UCI fastJX-5.3: JPL02+irHNO4+IUPAC/NO2/VOC+Bltz (J-8.6, 6/05) - do JQ=1,NQQQ - do J=1,2 - write(6,1100) TITLEJ(J,JQ)(1:7), nint(TQQ(J,JQ)), - & (QQQ(K,J,JQ),K=NW1,NN) - 1100 format(a7,i3,6(1pE10.3)/(10x,6(1pE10.3))/(10x,6(1pE10.3))) - enddo - enddo -c - 99 continue - return - end - - - subroutine SUMM(I,N) - include 'cmn_bins.f' - SFL(I)=SFL(I)+FFL(N) - do J=1,NQQQ - SQQQ(I,1,J)=SQQQ(I,1,J)+QQQQ(N,1,J)*FFL(N) - SQQQ(I,2,J)=SQQQ(I,2,J)+QQQQ(N,2,J)*FFL(N) - enddo - return - end - - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_xsect.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_xsect.f deleted file mode 100644 index 0884953f..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/add_xsect.f +++ /dev/null @@ -1,183 +0,0 @@ - program ADD_XSECT -C -C ****************************************************************** -C * * -C * GENERATING SOLAR FLUX AVERAGED CROSS SECTION IN GIVEN BINS * -C * * -C ****************************************************************** -C - implicit none - integer, parameter :: NIB=100, NWN=4600 - real*8 WKSP(NWN),SF(NWN),ACS1(NWN),ACS2(NWN),WTBIN(NWN) - + ,BIN(NIB),FBAR(NIB),WTBINB(2,NIB),WTBINE(2,NIB) - + ,TEM(2) - integer NTRA(NIB),NMAX,NBIN,I,K,N,M,N1,N2,NE - character*20 XNAME - character*15 FNAME -c -C-------- input X-section ---------------------------------------------- -c program ADD_XSECT.f should be compiled and run using std i/o as below -c program needs the data files sflx_10cm.dat (solar flux at 10 wave numbers) -c wbins_77.dat (edges of the 77 wavelength bins) - - read (5,'(A20,I10,2F7.1)') XNAME,NE,TEM - write(6,'(A20,A,2F7.1)') XNAME,' at temp. T1/T2 ',TEM - - read (5,*) - do N = NE,1,-1 - read (5,'(5X,2F12.1)') ACS1(N),ACS2(N) - enddo -c - call INPUT(SF,BIN,WTBIN,WTBINB,WTBINE,NTRA,NMAX,NBIN) -c - do K = 1, NBIN - N1 = NTRA(K) + 1 - N2 = NTRA(K+1) - 2 - FBAR(K) = SF(N1-2)*WTBINB(1,K) + SF(N1-1)*WTBINB(2,K) - & +SF(N2+1)*WTBINE(1,K) + SF(N2+2)*WTBINE(2,K) - do N = N1, N2 - FBAR(K) = FBAR(K) + SF(N)*WTBIN(N) - enddo - enddo -c - call WEIGHT(ACS1,SF,FBAR,WKSP,WTBIN,WTBINB,WTBINE,NTRA,NBIN) - call WEIGHT(ACS2,SF,FBAR,WKSP,WTBIN,WTBINB,WTBINE,NTRA,NBIN) -c - write(6,*) - + 'Bin Wavelength (nm) Solar Flux X-sect(T1) X-sect(T2)' - do N = 1,NBIN - write(6,103) N,.1d0*BIN(N),.1d0*BIN(N+1),FBAR(N),ACS1(N),ACS2(N) - enddo -c - WRITE (6,'(/10HSOLAR FLUX)') - WRITE (6,102) (FBAR(N), N=1,NBIN) - WRITE (6,'(A20,F5.0)') XNAME,TEM(1) - WRITE (6,102) (ACS1(N), N=1, NBIN) - WRITE (6,'(A20,F5.0)') XNAME,TEM(2) - WRITE (6,102) (ACS2(N), N=1, NBIN) -C - stop - 102 format(1P,8E10.3) - 103 format(I3,2X,F7.2,2H -,F7.2,1P,E12.3,3X,2E11.3) - end -C -C ****************************************************************** -C - subroutine INPUT(SF,BIN,WTBIN,WTBINB,WTBINE,NTRA,NMAX,NBIN) -C -C ****************************************************************** -C * * -C * DATA INPUT * -C * * -C ****************************************************************** -C -C----------------------------------------------------------------------- - implicit none - integer, parameter :: NIB=100, NWN=4600 - real*8, intent(out) :: SF(NWN),WTBIN(NWN),BIN(NIB) - + ,WTBINB(2,NIB),WTBINE(2,NIB) - integer, intent(out) :: NTRA(NIB),NMAX,NBIN -C - real*8 WN(NWN),W_REF(NWN),CON,FNMAX,FNBIN,WNMID,DWEDG - integer I,K,N,M,N1,N2 -c -C-------- solar flux in 10 wave number intervals ----------------------- - 501 format(8F10.1) - CON = 6.6256d0 *2.9979d0 - open (1,file='sflx_10cm.dat') - read (1,501) FNMAX - NMAX = FNMAX - do N = NMAX, 1,-1 - read (1,'(F6.0,F10.1)') WN(N), SF(N) - SF(N) = SF(N) *1.d+20 /CON /WN(N) - enddo - close (1) -C---------------------------------------- bins ------------------------- - open (1,file='wbins_77.dat') - read (1,501) FNBIN - NBIN = FNBIN - read (1,501) (BIN(N), N=1,NBIN+1) - close (1) -C - do N = 1, NMAX - W_REF(N) = 1.E+8 /WN(N) - enddo - K = 0 - do 10 N = 1, NBIN+1 - 20 K = K +1 - if (W_REF(K) .ge. BIN(N)) THEN - NTRA(N) = K - GO TO 10 - else - GO TO 20 - endif - 10 continue - do N = 2,NMAX-1 - WTBIN(N) = 0.5d0*(W_REF(N+1)-W_REF(N-1)) - enddo - WTBIN(1) = 0.5d0*(W_REF(2)-W_REF(1)) - WTBIN(NMAX) = 0.5d0*(W_REF(NMAX)-W_REF(NMAX-1)) - do K = 1,NBIN - N2 = NTRA(K) - N1 = max(1,N2-1) - WNMID = 0.5d0*(W_REF(N1)+W_REF(N2)) - DWEDG = BIN(K) - WNMID - if (DWEDG .lt. 0.d0) then - WTBINB(1,K) = -DWEDG - WTBINB(2,K) = WTBIN(N2) - else - WTBINB(1,K) = 0.d0 - WTBINB(2,K) = WTBIN(N2) - DWEDG - endif - N2 = NTRA(K+1) - N1 = N2 - 1 - WNMID = 0.5d0*(W_REF(N1)+W_REF(N2)) - DWEDG = WNMID - BIN(K+1) - if (DWEDG .lt. 0.d0) then - WTBINE(1,K) = WTBIN(N1) - WTBINE(2,K) = -DWEDG - else - WTBINE(1,K) = WTBIN(N1) - DWEDG - WTBINE(2,K) = 0.d0 - endif - enddo -c - return - end -C -C ****************************************************************** -C - subroutine WEIGHT(ACS,SF,FBAR,WKSP,WTBIN,WTBINB,WTBINE,NTRA,NBIN) -C -C ****************************************************************** -C * * -C * CALCULATE SOLAR FLUX WEIGHTED AVERAGE VALUE * -C * * -C ****************************************************************** -c - implicit none - integer, parameter :: NIB=100, NWN=4600 - real*8, intent(in) :: WTBIN(NWN),WTBINB(2,NIB),WTBINE(2,NIB) - + ,SF(NWN),FBAR(NIB) - integer, intent(in) :: NTRA(NIB),NBIN - real*8, intent(inout) :: ACS(NWN),WKSP(NWN) -c - integer K,N,N1,N2 -C----------------------------------------------------------------------- - do K = 1, NBIN - N1 = NTRA(K) + 1 - N2 = NTRA(K+1) - 2 - WKSP(K) = ACS(N1-2)*SF(N1-2)*WTBINB(1,K) - & + ACS(N1-1)*SF(N1-1)*WTBINB(2,K) - & + ACS(N2+1)*SF(N2+1)*WTBINE(1,K) - & + ACS(N2+2)*SF(N2+2)*WTBINE(2,K) - do N = N1, N2 - WKSP(K) = WKSP(K) + ACS(N)*SF(N)*WTBIN(N) - enddo - enddo - do K = 1, NBIN - ACS(K) = WKSP(K)/FBAR(K) - enddo -c - return - end diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/cmn_bins.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/cmn_bins.f deleted file mode 100644 index ae46e286..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/cmn_bins.f +++ /dev/null @@ -1,26 +0,0 @@ - implicit none - integer NF,I,J,JQ,K,L,N,M,N1,N2,IW,NWWW, NT - integer NW1,NW2,NWSRB,NSR,NODF,ISR,NBIN,NSPEC,NQQQ,NJVAL - real*8 WBIN,WL,FL,QO2,O2X,ODF,FNO,QNO,QO3,Q1D,QQQ,TQQ,QRL - real*8 CNO - - character*20 TITLEJ(3,99) - character*78 TITLE0,TITLE - common / TITLES/ TITLE0,TITLE,TITLEJ - common /CCWVL/ WBIN(77+1),WL(77),FL(77),QO2(77,3),O2X(6,15,3), - & ODF(6,15),FNO(15),QNO(6,15), QO3(77,3),Q1D(77,3),QQQ(77,2,99), - & TQQ(3,99),QRL(77), - & NW1,NW2,NWSRB,NSR,NODF,ISR(15),NT,NBIN,NSPEC, NQQQ,NJVAL - -c Re-distribution common block (expand SR ODFs to get 145 W bins) - real FFL(145),QQNO(145),QQRL(145),WWL(145) - real QQO3(145,3),QQ1D(145,3),QQO2(145,3), - & QQQQ(145,2,99) - common /REDIS/ FFL,QQNO,QQRL,WWL,QQO3,QQ1D,QQO2,QQQQ -c -c Average into Fast-J2/X 18 bins - real SFL(18),SQNO(18),SQRL(18),SWL(18) - real SQO3(18,3),SQ1D(18,3),SQO2(18,3), - & SQQQ(18,2,95) - common /AVGJ2/ SFL,SQNO,SQRL,SWL,SQO3,SQ1D,SQO2,SQQQ - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/readme_addX.txt b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/readme_addX.txt deleted file mode 100644 index 60192beb..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/readme_addX.txt +++ /dev/null @@ -1,47 +0,0 @@ --------------------------------------------------------------------- -This directory contains programs and data files needed to add a -NEW X-section to UCI reference J-code(v8) AND then fast-JX (v5.3). --------------------------------------------------------------------- - -This is a three-step process: - (1) generate X-sections at 10 /cm (wavenumber) resolution, - see example. This is your responsibility! - (2) run 'add_xsect.f' on output of (1) to generate flux-weighted - X-sections in the 77-bins used in UCI std chemistry - (3) run 'add_FJX.f' on output of (2) to generate fast-JX tables. - --------------------------------------------------------------------- -add_xsect.f - reads in data sets: sflx_10cm.dat & wbins_77.dat - reads in user-supplied Xsections at 10/cm resolution - e.g. given as NO2-IUPAC.in - writes (stdout) the 77-bin X-sections - e.g. given as NO2-IUPAC.out - ->>> We are no longer supplying our 10 /cm fits to all the ->>> cross-sections, since this is redundant with the JX X-ections. - ->>> Further, the choices of interpolation and extrapolation ->>> needed to generate these are a scientific choice, one that ->>> the user needs to make. - - --------------------------------------------------------------------- -add_FJX.f - reads in data set: FJX_bins.dat - uses include file: cmn_bins.f - reads in (stdin) the output from add_xsect - e.g. given as NO2-IUPAC.out - writes (stdout) the pair of 18-bin fast-JX tables - e.g. given as NO2_FJX.out - --------------------------------------------------------------------- -Another program 'FJX_bin.f' is meant to read the full spectral data - file from the UCI ref J-code (fort10.x) and generate the full - fast-JX spectral data set (FJX_spec.dat) <<<>>> - --------------------------------------------------------------------- - - - - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/sflx_10cm.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/sflx_10cm.dat deleted file mode 100644 index 2947aa33..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/sflx_10cm.dat +++ /dev/null @@ -1,4464 +0,0 @@ - 4463.0 SOLAR FLUX: LOWTRAN7 (1FEB92) REV 4.2 cm-1; W/cm2/micrometer - 11730 9.838E-02 - 11740 1.003E-01 - 11750 1.136E-01 - 11760 1.126E-01 - 11770 1.118E-01 - 11780 1.115E-01 - 11790 1.129E-01 - 11800 9.661E-02 - 11810 9.801E-02 - 11820 9.900E-02 - 11830 9.900E-02 - 11840 9.869E-02 - 11850 9.849E-02 - 11860 9.849E-02 - 11870 8.835E-02 - 11880 8.893E-02 - 11890 8.922E-02 - 11900 8.941E-02 - 11910 8.939E-02 - 11920 8.928E-02 - 11930 8.947E-02 - 11940 8.986E-02 - 11950 1.048E-01 - 11960 1.050E-01 - 11970 1.048E-01 - 11980 1.044E-01 - 11990 1.037E-01 - 12000 1.032E-01 - 12010 1.037E-01 - 12020 1.046E-01 - 12030 1.057E-01 - 12040 1.066E-01 - 12050 1.069E-01 - 12060 1.069E-01 - 12070 1.070E-01 - 12080 1.071E-01 - 12090 1.110E-01 - 12100 1.111E-01 - 12110 1.111E-01 - 12120 1.110E-01 - 12130 1.109E-01 - 12140 1.108E-01 - 12150 1.109E-01 - 12160 9.830E-02 - 12170 9.839E-02 - 12180 9.839E-02 - 12190 9.778E-02 - 12200 9.727E-02 - 12210 9.746E-02 - 12220 9.805E-02 - 12230 9.935E-02 - 12240 1.157E-01 - 12250 1.162E-01 - 12260 1.164E-01 - 12270 1.165E-01 - 12280 1.165E-01 - 12290 1.168E-01 - 12300 1.171E-01 - 12310 1.035E-01 - 12320 1.035E-01 - 12330 1.030E-01 - 12340 1.024E-01 - 12350 1.019E-01 - 12360 1.016E-01 - 12370 1.021E-01 - 12380 1.028E-01 - 12390 1.076E-01 - 12400 1.080E-01 - 12410 1.078E-01 - 12420 1.076E-01 - 12430 1.078E-01 - 12440 1.081E-01 - 12450 1.087E-01 - 12460 1.093E-01 - 12470 1.256E-01 - 12480 1.259E-01 - 12490 1.258E-01 - 12500 1.255E-01 - 12510 1.255E-01 - 12520 1.256E-01 - 12530 1.262E-01 - 12540 1.136E-01 - 12550 1.136E-01 - 12560 1.134E-01 - 12570 1.128E-01 - 12580 1.123E-01 - 12590 1.123E-01 - 12600 1.126E-01 - 12610 1.130E-01 - 12620 1.137E-01 - 12630 1.141E-01 - 12640 1.146E-01 - 12650 1.151E-01 - 12660 1.157E-01 - 12670 1.161E-01 - 12680 1.164E-01 - 12690 1.165E-01 - 12700 1.198E-01 - 12710 1.199E-01 - 12720 1.200E-01 - 12730 1.200E-01 - 12740 1.200E-01 - 12750 1.199E-01 - 12760 1.198E-01 - 12770 1.198E-01 - 12780 1.076E-01 - 12790 1.079E-01 - 12800 1.082E-01 - 12810 1.083E-01 - 12820 1.084E-01 - 12830 1.083E-01 - 12840 1.084E-01 - 12850 1.087E-01 - 12860 1.090E-01 - 12870 1.225E-01 - 12880 1.224E-01 - 12890 1.222E-01 - 12900 1.220E-01 - 12910 1.224E-01 - 12920 1.229E-01 - 12930 1.234E-01 - 12940 1.238E-01 - 12950 1.264E-01 - 12960 1.263E-01 - 12970 1.262E-01 - 12980 1.261E-01 - 12990 1.261E-01 - 13000 1.259E-01 - 13010 1.253E-01 - 13020 1.247E-01 - 13030 1.121E-01 - 13040 1.123E-01 - 13050 1.135E-01 - 13060 1.150E-01 - 13070 1.163E-01 - 13080 1.173E-01 - 13090 1.176E-01 - 13100 1.175E-01 - 13110 1.174E-01 - 13120 1.195E-01 - 13130 1.194E-01 - 13140 1.193E-01 - 13150 1.193E-01 - 13160 1.194E-01 - 13170 1.195E-01 - 13180 1.197E-01 - 13190 1.199E-01 - 13200 1.201E-01 - 13210 1.377E-01 - 13220 1.379E-01 - 13230 1.382E-01 - 13240 1.384E-01 - 13250 1.386E-01 - 13260 1.387E-01 - 13270 1.388E-01 - 13280 1.389E-01 - 13290 1.253E-01 - 13300 1.254E-01 - 13310 1.255E-01 - 13320 1.256E-01 - 13330 1.257E-01 - 13340 1.260E-01 - 13350 1.263E-01 - 13360 1.267E-01 - 13370 1.271E-01 - 13380 1.278E-01 - 13390 1.279E-01 - 13400 1.278E-01 - 13410 1.277E-01 - 13420 1.277E-01 - 13430 1.279E-01 - 13440 1.281E-01 - 13450 1.282E-01 - 13460 1.281E-01 - 13470 1.304E-01 - 13480 1.296E-01 - 13490 1.290E-01 - 13500 1.286E-01 - 13510 1.289E-01 - 13520 1.295E-01 - 13530 1.303E-01 - 13540 1.313E-01 - 13550 1.321E-01 - 13560 1.212E-01 - 13570 1.216E-01 - 13580 1.219E-01 - 13590 1.219E-01 - 13600 1.219E-01 - 13610 1.220E-01 - 13620 1.221E-01 - 13630 1.224E-01 - 13640 1.226E-01 - 13650 1.229E-01 - 13660 1.389E-01 - 13670 1.391E-01 - 13680 1.392E-01 - 13690 1.391E-01 - 13700 1.389E-01 - 13710 1.388E-01 - 13720 1.386E-01 - 13730 1.387E-01 - 13740 1.389E-01 - 13750 1.276E-01 - 13760 1.282E-01 - 13770 1.288E-01 - 13780 1.293E-01 - 13790 1.298E-01 - 13800 1.301E-01 - 13810 1.302E-01 - 13820 1.300E-01 - 13830 1.297E-01 - 13840 1.293E-01 - 13850 1.454E-01 - 13860 1.449E-01 - 13870 1.446E-01 - 13880 1.443E-01 - 13890 1.441E-01 - 13900 1.442E-01 - 13910 1.445E-01 - 13920 1.450E-01 - 13930 1.457E-01 - 13940 1.332E-01 - 13950 1.338E-01 - 13960 1.343E-01 - 13970 1.346E-01 - 13980 1.349E-01 - 13990 1.351E-01 - 14000 1.352E-01 - 14010 1.354E-01 - 14020 1.356E-01 - 14030 1.359E-01 - 14040 1.386E-01 - 14050 1.389E-01 - 14060 1.392E-01 - 14070 1.393E-01 - 14080 1.393E-01 - 14090 1.392E-01 - 14100 1.392E-01 - 14110 1.394E-01 - 14120 1.396E-01 - 14130 1.401E-01 - 14140 1.421E-01 - 14150 1.427E-01 - 14160 1.432E-01 - 14170 1.436E-01 - 14180 1.437E-01 - 14190 1.435E-01 - 14200 1.430E-01 - 14210 1.422E-01 - 14220 1.415E-01 - 14230 1.409E-01 - 14240 1.472E-01 - 14250 1.471E-01 - 14260 1.474E-01 - 14270 1.482E-01 - 14280 1.491E-01 - 14290 1.501E-01 - 14300 1.510E-01 - 14310 1.514E-01 - 14320 1.514E-01 - 14330 1.511E-01 - 14340 1.383E-01 - 14350 1.383E-01 - 14360 1.385E-01 - 14370 1.389E-01 - 14380 1.395E-01 - 14390 1.401E-01 - 14400 1.406E-01 - 14410 1.410E-01 - 14420 1.412E-01 - 14430 1.413E-01 - 14440 1.413E-01 - 14450 1.516E-01 - 14460 1.515E-01 - 14470 1.516E-01 - 14480 1.518E-01 - 14490 1.521E-01 - 14500 1.524E-01 - 14510 1.527E-01 - 14520 1.531E-01 - 14530 1.534E-01 - 14540 1.535E-01 - 14550 1.445E-01 - 14560 1.443E-01 - 14570 1.440E-01 - 14580 1.436E-01 - 14590 1.434E-01 - 14600 1.434E-01 - 14610 1.438E-01 - 14620 1.443E-01 - 14630 1.449E-01 - 14640 1.456E-01 - 14650 1.461E-01 - 14660 1.496E-01 - 14670 1.498E-01 - 14680 1.500E-01 - 14690 1.502E-01 - 14700 1.503E-01 - 14710 1.504E-01 - 14720 1.506E-01 - 14730 1.508E-01 - 14740 1.510E-01 - 14750 1.513E-01 - 14760 1.515E-01 - 14770 1.685E-01 - 14780 1.686E-01 - 14790 1.686E-01 - 14800 1.687E-01 - 14810 1.689E-01 - 14820 1.691E-01 - 14830 1.694E-01 - 14840 1.697E-01 - 14850 1.698E-01 - 14860 1.699E-01 - 14870 1.425E-01 - 14880 1.423E-01 - 14890 1.422E-01 - 14900 1.422E-01 - 14910 1.427E-01 - 14920 1.434E-01 - 14930 1.440E-01 - 14940 1.447E-01 - 14950 1.449E-01 - 14960 1.449E-01 - 14970 1.446E-01 - 14980 1.443E-01 - 14990 1.587E-01 - 15000 1.588E-01 - 15010 1.593E-01 - 15020 1.600E-01 - 15030 1.605E-01 - 15040 1.611E-01 - 15050 1.611E-01 - 15060 1.611E-01 - 15070 1.609E-01 - 15080 1.607E-01 - 15090 1.607E-01 - 15100 1.619E-01 - 15110 1.623E-01 - 15120 1.628E-01 - 15130 1.635E-01 - 15140 1.640E-01 - 15150 1.641E-01 - 15160 1.636E-01 - 15170 1.617E-01 - 15180 1.588E-01 - 15190 1.546E-01 - 15200 1.505E-01 - 15210 1.372E-01 - 15220 1.354E-01 - 15230 1.362E-01 - 15240 1.386E-01 - 15250 1.423E-01 - 15260 1.463E-01 - 15270 1.497E-01 - 15280 1.524E-01 - 15290 1.541E-01 - 15300 1.551E-01 - 15310 1.558E-01 - 15320 1.562E-01 - 15330 1.556E-01 - 15340 1.558E-01 - 15350 1.558E-01 - 15360 1.554E-01 - 15370 1.545E-01 - 15380 1.534E-01 - 15390 1.522E-01 - 15400 1.513E-01 - 15410 1.510E-01 - 15420 1.512E-01 - 15430 1.521E-01 - 15440 1.532E-01 - 15450 1.580E-01 - 15460 1.591E-01 - 15470 1.599E-01 - 15480 1.605E-01 - 15490 1.609E-01 - 15500 1.611E-01 - 15510 1.612E-01 - 15520 1.612E-01 - 15530 1.611E-01 - 15540 1.609E-01 - 15550 1.606E-01 - 15560 1.603E-01 - 15570 1.642E-01 - 15580 1.640E-01 - 15590 1.640E-01 - 15600 1.642E-01 - 15610 1.647E-01 - 15620 1.655E-01 - 15630 1.663E-01 - 15640 1.671E-01 - 15650 1.677E-01 - 15660 1.681E-01 - 15670 1.683E-01 - 15680 1.683E-01 - 15690 1.564E-01 - 15700 1.563E-01 - 15710 1.563E-01 - 15720 1.563E-01 - 15730 1.563E-01 - 15740 1.563E-01 - 15750 1.564E-01 - 15760 1.564E-01 - 15770 1.564E-01 - 15780 1.563E-01 - 15790 1.561E-01 - 15800 1.558E-01 - 15810 1.553E-01 - 15820 1.710E-01 - 15830 1.708E-01 - 15840 1.707E-01 - 15850 1.711E-01 - 15860 1.718E-01 - 15870 1.728E-01 - 15880 1.739E-01 - 15890 1.750E-01 - 15900 1.759E-01 - 15910 1.763E-01 - 15920 1.766E-01 - 15930 1.768E-01 - 15940 1.660E-01 - 15950 1.660E-01 - 15960 1.655E-01 - 15970 1.633E-01 - 15980 1.610E-01 - 15990 1.602E-01 - 16000 1.600E-01 - 16010 1.607E-01 - 16020 1.618E-01 - 16030 1.624E-01 - 16040 1.632E-01 - 16050 1.649E-01 - 16060 1.664E-01 - 16070 1.713E-01 - 16080 1.709E-01 - 16090 1.711E-01 - 16100 1.717E-01 - 16110 1.729E-01 - 16120 1.738E-01 - 16130 1.732E-01 - 16140 1.722E-01 - 16150 1.722E-01 - 16160 1.726E-01 - 16170 1.734E-01 - 16180 1.736E-01 - 16190 1.716E-01 - 16200 1.695E-01 - 16210 1.661E-01 - 16220 1.640E-01 - 16230 1.662E-01 - 16240 1.695E-01 - 16250 1.722E-01 - 16260 1.739E-01 - 16270 1.733E-01 - 16280 1.720E-01 - 16290 1.709E-01 - 16300 1.701E-01 - 16310 1.703E-01 - 16320 1.710E-01 - 16330 1.642E-01 - 16340 1.659E-01 - 16350 1.665E-01 - 16360 1.664E-01 - 16370 1.651E-01 - 16380 1.640E-01 - 16390 1.648E-01 - 16400 1.661E-01 - 16410 1.670E-01 - 16420 1.676E-01 - 16430 1.676E-01 - 16440 1.676E-01 - 16450 1.681E-01 - 16460 1.686E-01 - 16470 1.839E-01 - 16480 1.840E-01 - 16490 1.841E-01 - 16500 1.841E-01 - 16510 1.843E-01 - 16520 1.845E-01 - 16530 1.850E-01 - 16540 1.856E-01 - 16550 1.866E-01 - 16560 1.870E-01 - 16570 1.859E-01 - 16580 1.842E-01 - 16590 1.821E-01 - 16600 1.697E-01 - 16610 1.703E-01 - 16620 1.714E-01 - 16630 1.718E-01 - 16640 1.721E-01 - 16650 1.723E-01 - 16660 1.726E-01 - 16670 1.735E-01 - 16680 1.743E-01 - 16690 1.741E-01 - 16700 1.736E-01 - 16710 1.734E-01 - 16720 1.736E-01 - 16730 1.746E-01 - 16740 1.805E-01 - 16750 1.816E-01 - 16760 1.823E-01 - 16770 1.821E-01 - 16780 1.815E-01 - 16790 1.807E-01 - 16800 1.799E-01 - 16810 1.795E-01 - 16820 1.795E-01 - 16830 1.800E-01 - 16840 1.808E-01 - 16850 1.818E-01 - 16860 1.826E-01 - 16870 1.827E-01 - 16880 1.732E-01 - 16890 1.724E-01 - 16900 1.718E-01 - 16910 1.732E-01 - 16920 1.743E-01 - 16930 1.730E-01 - 16940 1.698E-01 - 16950 1.631E-01 - 16960 1.572E-01 - 16970 1.570E-01 - 16980 1.598E-01 - 16990 1.654E-01 - 17000 1.713E-01 - 17010 1.749E-01 - 17020 1.771E-01 - 17030 1.924E-01 - 17040 1.918E-01 - 17050 1.902E-01 - 17060 1.883E-01 - 17070 1.870E-01 - 17080 1.866E-01 - 17090 1.886E-01 - 17100 1.910E-01 - 17110 1.927E-01 - 17120 1.938E-01 - 17130 1.938E-01 - 17140 1.935E-01 - 17150 1.939E-01 - 17160 1.944E-01 - 17170 1.845E-01 - 17180 1.843E-01 - 17190 1.836E-01 - 17200 1.827E-01 - 17210 1.821E-01 - 17220 1.816E-01 - 17230 1.815E-01 - 17240 1.813E-01 - 17250 1.806E-01 - 17260 1.794E-01 - 17270 1.777E-01 - 17280 1.765E-01 - 17290 1.773E-01 - 17300 1.790E-01 - 17310 1.812E-01 - 17320 1.857E-01 - 17330 1.859E-01 - 17340 1.854E-01 - 17350 1.844E-01 - 17360 1.835E-01 - 17370 1.833E-01 - 17380 1.836E-01 - 17390 1.847E-01 - 17400 1.859E-01 - 17410 1.867E-01 - 17420 1.873E-01 - 17430 1.877E-01 - 17440 1.880E-01 - 17450 1.887E-01 - 17460 1.891E-01 - 17470 1.781E-01 - 17480 1.767E-01 - 17490 1.741E-01 - 17500 1.712E-01 - 17510 1.686E-01 - 17520 1.670E-01 - 17530 1.680E-01 - 17540 1.701E-01 - 17550 1.727E-01 - 17560 1.746E-01 - 17570 1.737E-01 - 17580 1.723E-01 - 17590 1.721E-01 - 17600 1.728E-01 - 17610 1.752E-01 - 17620 1.773E-01 - 17630 1.918E-01 - 17640 1.904E-01 - 17650 1.881E-01 - 17660 1.858E-01 - 17670 1.846E-01 - 17680 1.843E-01 - 17690 1.853E-01 - 17700 1.869E-01 - 17710 1.886E-01 - 17720 1.900E-01 - 17730 1.904E-01 - 17740 1.905E-01 - 17750 1.904E-01 - 17760 1.901E-01 - 17770 1.896E-01 - 17780 1.790E-01 - 17790 1.781E-01 - 17800 1.773E-01 - 17810 1.771E-01 - 17820 1.773E-01 - 17830 1.779E-01 - 17840 1.782E-01 - 17850 1.778E-01 - 17860 1.769E-01 - 17870 1.755E-01 - 17880 1.741E-01 - 17890 1.731E-01 - 17900 1.730E-01 - 17910 1.742E-01 - 17920 1.759E-01 - 17930 1.773E-01 - 17940 1.815E-01 - 17950 1.809E-01 - 17960 1.801E-01 - 17970 1.805E-01 - 17980 1.817E-01 - 17990 1.840E-01 - 18000 1.863E-01 - 18010 1.874E-01 - 18020 1.878E-01 - 18030 1.876E-01 - 18040 1.870E-01 - 18050 1.866E-01 - 18060 1.860E-01 - 18070 1.849E-01 - 18080 1.838E-01 - 18090 1.828E-01 - 18100 1.758E-01 - 18110 1.763E-01 - 18120 1.770E-01 - 18130 1.775E-01 - 18140 1.778E-01 - 18150 1.775E-01 - 18160 1.773E-01 - 18170 1.778E-01 - 18180 1.786E-01 - 18190 1.795E-01 - 18200 1.801E-01 - 18210 1.796E-01 - 18220 1.787E-01 - 18230 1.773E-01 - 18240 1.759E-01 - 18250 1.749E-01 - 18260 1.744E-01 - 18270 1.806E-01 - 18280 1.816E-01 - 18290 1.831E-01 - 18300 1.846E-01 - 18310 1.858E-01 - 18320 1.865E-01 - 18330 1.865E-01 - 18340 1.861E-01 - 18350 1.855E-01 - 18360 1.848E-01 - 18370 1.848E-01 - 18380 1.849E-01 - 18390 1.847E-01 - 18400 1.840E-01 - 18410 1.822E-01 - 18420 1.806E-01 - 18430 1.801E-01 - 18440 1.838E-01 - 18450 1.856E-01 - 18460 1.871E-01 - 18470 1.862E-01 - 18480 1.841E-01 - 18490 1.808E-01 - 18500 1.779E-01 - 18510 1.775E-01 - 18520 1.787E-01 - 18530 1.812E-01 - 18540 1.843E-01 - 18550 1.868E-01 - 18560 1.888E-01 - 18570 1.899E-01 - 18580 1.903E-01 - 18590 1.897E-01 - 18600 1.887E-01 - 18610 1.888E-01 - 18620 1.877E-01 - 18630 1.880E-01 - 18640 1.896E-01 - 18650 1.933E-01 - 18660 1.970E-01 - 18670 1.985E-01 - 18680 1.982E-01 - 18690 1.945E-01 - 18700 1.906E-01 - 18710 1.893E-01 - 18720 1.893E-01 - 18730 1.914E-01 - 18740 1.928E-01 - 18750 1.902E-01 - 18760 1.864E-01 - 18770 1.824E-01 - 18780 1.771E-01 - 18790 1.802E-01 - 18800 1.854E-01 - 18810 1.908E-01 - 18820 1.952E-01 - 18830 1.961E-01 - 18840 1.954E-01 - 18850 1.939E-01 - 18860 1.922E-01 - 18870 1.912E-01 - 18880 1.904E-01 - 18890 1.898E-01 - 18900 1.892E-01 - 18910 1.887E-01 - 18920 1.881E-01 - 18930 1.874E-01 - 18940 1.860E-01 - 18950 1.831E-01 - 18960 1.797E-01 - 18970 1.741E-01 - 18980 1.695E-01 - 18990 1.683E-01 - 19000 1.702E-01 - 19010 1.767E-01 - 19020 1.844E-01 - 19030 1.905E-01 - 19040 1.949E-01 - 19050 1.960E-01 - 19060 1.954E-01 - 19070 1.942E-01 - 19080 1.925E-01 - 19090 1.907E-01 - 19100 1.886E-01 - 19110 1.860E-01 - 19120 1.836E-01 - 19130 1.822E-01 - 19140 1.804E-01 - 19150 1.823E-01 - 19160 1.847E-01 - 19170 1.864E-01 - 19180 1.870E-01 - 19190 1.853E-01 - 19200 1.831E-01 - 19210 1.816E-01 - 19220 1.807E-01 - 19230 1.810E-01 - 19240 1.809E-01 - 19250 1.785E-01 - 19260 1.748E-01 - 19270 1.697E-01 - 19280 1.653E-01 - 19290 1.641E-01 - 19300 1.645E-01 - 19310 1.667E-01 - 19320 1.687E-01 - 19330 1.665E-01 - 19340 1.651E-01 - 19350 1.637E-01 - 19360 1.638E-01 - 19370 1.680E-01 - 19380 1.738E-01 - 19390 1.801E-01 - 19400 1.852E-01 - 19410 1.867E-01 - 19420 1.864E-01 - 19430 1.849E-01 - 19440 1.831E-01 - 19450 1.824E-01 - 19460 1.821E-01 - 19470 1.818E-01 - 19480 1.817E-01 - 19490 1.813E-01 - 19500 1.814E-01 - 19510 1.829E-01 - 19520 1.922E-01 - 19530 1.959E-01 - 19540 1.994E-01 - 19550 2.015E-01 - 19560 2.023E-01 - 19570 2.012E-01 - 19580 1.994E-01 - 19590 1.976E-01 - 19600 1.959E-01 - 19610 1.950E-01 - 19620 1.946E-01 - 19630 1.945E-01 - 19640 1.946E-01 - 19650 1.947E-01 - 19660 1.947E-01 - 19670 1.944E-01 - 19680 1.940E-01 - 19690 1.936E-01 - 19700 1.935E-01 - 19710 1.876E-01 - 19720 1.885E-01 - 19730 1.901E-01 - 19740 1.919E-01 - 19750 1.939E-01 - 19760 1.954E-01 - 19770 1.960E-01 - 19780 1.955E-01 - 19790 1.930E-01 - 19800 1.898E-01 - 19810 1.866E-01 - 19820 1.842E-01 - 19830 1.842E-01 - 19840 1.854E-01 - 19850 1.874E-01 - 19860 1.892E-01 - 19870 1.898E-01 - 19880 1.894E-01 - 19890 1.879E-01 - 19900 1.858E-01 - 19910 1.889E-01 - 19920 1.866E-01 - 19930 1.846E-01 - 19940 1.833E-01 - 19950 1.829E-01 - 19960 1.834E-01 - 19970 1.852E-01 - 19980 1.878E-01 - 19990 1.914E-01 - 20000 1.948E-01 - 20010 1.971E-01 - 20020 1.979E-01 - 20030 1.960E-01 - 20040 1.933E-01 - 20050 1.907E-01 - 20060 1.894E-01 - 20070 1.912E-01 - 20080 1.944E-01 - 20090 1.988E-01 - 20100 2.029E-01 - 20110 2.092E-01 - 20120 2.102E-01 - 20130 2.094E-01 - 20140 2.073E-01 - 20150 2.043E-01 - 20160 2.013E-01 - 20170 1.994E-01 - 20180 1.990E-01 - 20190 2.015E-01 - 20200 2.049E-01 - 20210 2.083E-01 - 20220 2.103E-01 - 20230 2.088E-01 - 20240 2.055E-01 - 20250 2.009E-01 - 20260 1.965E-01 - 20270 1.943E-01 - 20280 1.933E-01 - 20290 1.939E-01 - 20300 1.948E-01 - 20310 1.881E-01 - 20320 1.882E-01 - 20330 1.880E-01 - 20340 1.883E-01 - 20350 1.899E-01 - 20360 1.922E-01 - 20370 1.952E-01 - 20380 1.978E-01 - 20390 1.991E-01 - 20400 1.994E-01 - 20410 1.983E-01 - 20420 1.966E-01 - 20430 1.949E-01 - 20440 1.933E-01 - 20450 1.921E-01 - 20460 1.911E-01 - 20470 1.904E-01 - 20480 1.896E-01 - 20490 1.883E-01 - 20500 1.862E-01 - 20510 1.824E-01 - 20520 1.827E-01 - 20530 1.767E-01 - 20540 1.715E-01 - 20550 1.685E-01 - 20560 1.680E-01 - 20570 1.712E-01 - 20580 1.762E-01 - 20590 1.821E-01 - 20600 1.880E-01 - 20610 1.925E-01 - 20620 1.961E-01 - 20630 1.988E-01 - 20640 2.008E-01 - 20650 2.026E-01 - 20660 2.040E-01 - 20670 2.050E-01 - 20680 2.057E-01 - 20690 2.057E-01 - 20700 2.057E-01 - 20710 2.057E-01 - 20720 2.061E-01 - 20730 2.029E-01 - 20740 2.045E-01 - 20750 2.063E-01 - 20760 2.077E-01 - 20770 2.079E-01 - 20780 2.074E-01 - 20790 2.059E-01 - 20800 2.044E-01 - 20810 2.038E-01 - 20820 2.038E-01 - 20830 2.049E-01 - 20840 2.061E-01 - 20850 2.066E-01 - 20860 2.063E-01 - 20870 2.048E-01 - 20880 2.029E-01 - 20890 2.016E-01 - 20900 2.011E-01 - 20910 2.023E-01 - 20920 2.041E-01 - 20930 2.057E-01 - 20940 2.065E-01 - 20950 2.097E-01 - 20960 2.074E-01 - 20970 2.043E-01 - 20980 2.015E-01 - 20990 2.001E-01 - 21000 1.999E-01 - 21010 2.013E-01 - 21020 2.033E-01 - 21030 2.054E-01 - 21040 2.073E-01 - 21050 2.087E-01 - 21060 2.093E-01 - 21070 2.092E-01 - 21080 2.084E-01 - 21090 2.070E-01 - 21100 2.054E-01 - 21110 2.042E-01 - 21120 2.035E-01 - 21130 2.038E-01 - 21140 2.047E-01 - 21150 2.061E-01 - 21160 2.075E-01 - 21170 2.049E-01 - 21180 2.055E-01 - 21190 2.052E-01 - 21200 2.039E-01 - 21210 2.013E-01 - 21220 1.981E-01 - 21230 1.943E-01 - 21240 1.910E-01 - 21250 1.893E-01 - 21260 1.891E-01 - 21270 1.909E-01 - 21280 1.937E-01 - 21290 1.966E-01 - 21300 1.991E-01 - 21310 2.001E-01 - 21320 2.004E-01 - 21330 2.002E-01 - 21340 2.000E-01 - 21350 2.004E-01 - 21360 2.010E-01 - 21370 2.018E-01 - 21380 2.022E-01 - 21390 2.013E-01 - 21400 2.030E-01 - 21410 2.005E-01 - 21420 1.981E-01 - 21430 1.969E-01 - 21440 1.969E-01 - 21450 1.991E-01 - 21460 2.020E-01 - 21470 2.049E-01 - 21480 2.071E-01 - 21490 2.074E-01 - 21500 2.066E-01 - 21510 2.048E-01 - 21520 2.029E-01 - 21530 2.019E-01 - 21540 2.017E-01 - 21550 2.028E-01 - 21560 2.045E-01 - 21570 2.066E-01 - 21580 2.089E-01 - 21590 2.108E-01 - 21600 2.125E-01 - 21610 2.135E-01 - 21620 2.139E-01 - 21630 2.184E-01 - 21640 2.176E-01 - 21650 2.164E-01 - 21660 2.151E-01 - 21670 2.141E-01 - 21680 2.134E-01 - 21690 2.130E-01 - 21700 2.128E-01 - 21710 2.126E-01 - 21720 2.125E-01 - 21730 2.122E-01 - 21740 2.116E-01 - 21750 2.108E-01 - 21760 2.098E-01 - 21770 2.083E-01 - 21780 2.069E-01 - 21790 2.058E-01 - 21800 2.054E-01 - 21810 2.063E-01 - 21820 2.080E-01 - 21830 2.109E-01 - 21840 2.139E-01 - 21850 2.166E-01 - 21860 2.105E-01 - 21870 2.112E-01 - 21880 2.110E-01 - 21890 2.102E-01 - 21900 2.090E-01 - 21910 2.080E-01 - 21920 2.069E-01 - 21930 2.061E-01 - 21940 2.053E-01 - 21950 2.043E-01 - 21960 2.032E-01 - 21970 2.019E-01 - 21980 2.007E-01 - 21990 1.996E-01 - 22000 1.988E-01 - 22010 1.984E-01 - 22020 1.982E-01 - 22030 1.982E-01 - 22040 1.980E-01 - 22050 1.974E-01 - 22060 1.965E-01 - 22070 1.953E-01 - 22080 1.945E-01 - 22090 1.944E-01 - 22100 1.953E-01 - 22110 1.976E-01 - 22120 2.008E-01 - 22130 2.046E-01 - 22140 2.084E-01 - 22150 2.116E-01 - 22160 2.140E-01 - 22170 2.154E-01 - 22180 2.159E-01 - 22190 2.155E-01 - 22200 2.144E-01 - 22210 2.127E-01 - 22220 2.104E-01 - 22230 2.079E-01 - 22240 2.052E-01 - 22250 2.026E-01 - 22260 2.003E-01 - 22270 1.985E-01 - 22280 1.975E-01 - 22290 1.977E-01 - 22300 1.989E-01 - 22310 2.012E-01 - 22320 2.039E-01 - 22330 2.062E-01 - 22340 2.076E-01 - 22350 2.103E-01 - 22360 2.084E-01 - 22370 2.048E-01 - 22380 2.004E-01 - 22390 1.960E-01 - 22400 1.917E-01 - 22410 1.885E-01 - 22420 1.861E-01 - 22430 1.851E-01 - 22440 1.854E-01 - 22450 1.872E-01 - 22460 1.899E-01 - 22470 1.934E-01 - 22480 1.968E-01 - 22490 1.994E-01 - 22500 2.008E-01 - 22510 2.005E-01 - 22520 1.993E-01 - 22530 1.975E-01 - 22540 1.959E-01 - 22550 1.953E-01 - 22560 1.954E-01 - 22570 1.966E-01 - 22580 1.984E-01 - 22590 2.002E-01 - 22600 2.001E-01 - 22610 2.011E-01 - 22620 2.012E-01 - 22630 2.003E-01 - 22640 1.982E-01 - 22650 1.946E-01 - 22660 1.901E-01 - 22670 1.848E-01 - 22680 1.798E-01 - 22690 1.762E-01 - 22700 1.743E-01 - 22710 1.752E-01 - 22720 1.775E-01 - 22730 1.808E-01 - 22740 1.833E-01 - 22750 1.835E-01 - 22760 1.816E-01 - 22770 1.768E-01 - 22780 1.709E-01 - 22790 1.652E-01 - 22800 1.609E-01 - 22810 1.599E-01 - 22820 1.615E-01 - 22830 1.658E-01 - 22840 1.716E-01 - 22850 1.779E-01 - 22860 1.828E-01 - 22870 1.877E-01 - 22880 1.914E-01 - 22890 1.935E-01 - 22900 1.942E-01 - 22910 1.931E-01 - 22920 1.906E-01 - 22930 1.870E-01 - 22940 1.826E-01 - 22950 1.783E-01 - 22960 1.742E-01 - 22970 1.710E-01 - 22980 1.687E-01 - 22990 1.675E-01 - 23000 1.671E-01 - 23010 1.676E-01 - 23020 1.687E-01 - 23030 1.703E-01 - 23040 1.719E-01 - 23050 1.732E-01 - 23060 1.738E-01 - 23070 1.731E-01 - 23080 1.716E-01 - 23090 1.694E-01 - 23100 1.672E-01 - 23110 1.660E-01 - 23120 1.659E-01 - 23130 1.717E-01 - 23140 1.741E-01 - 23150 1.764E-01 - 23160 1.770E-01 - 23170 1.741E-01 - 23180 1.680E-01 - 23190 1.577E-01 - 23200 1.459E-01 - 23210 1.342E-01 - 23220 1.247E-01 - 23230 1.202E-01 - 23240 1.199E-01 - 23250 1.246E-01 - 23260 1.321E-01 - 23270 1.408E-01 - 23280 1.493E-01 - 23290 1.557E-01 - 23300 1.603E-01 - 23310 1.628E-01 - 23320 1.638E-01 - 23330 1.638E-01 - 23340 1.631E-01 - 23350 1.622E-01 - 23360 1.614E-01 - 23370 1.609E-01 - 23380 1.609E-01 - 23390 1.618E-01 - 23400 1.627E-01 - 23410 1.651E-01 - 23420 1.677E-01 - 23430 1.703E-01 - 23440 1.725E-01 - 23450 1.739E-01 - 23460 1.746E-01 - 23470 1.745E-01 - 23480 1.742E-01 - 23490 1.739E-01 - 23500 1.739E-01 - 23510 1.746E-01 - 23520 1.756E-01 - 23530 1.771E-01 - 23540 1.787E-01 - 23550 1.800E-01 - 23560 1.810E-01 - 23570 1.814E-01 - 23580 1.810E-01 - 23590 1.800E-01 - 23600 1.783E-01 - 23610 1.758E-01 - 23620 1.728E-01 - 23630 1.694E-01 - 23640 1.663E-01 - 23650 1.639E-01 - 23660 1.627E-01 - 23670 1.684E-01 - 23680 1.706E-01 - 23690 1.745E-01 - 23700 1.789E-01 - 23710 1.833E-01 - 23720 1.871E-01 - 23730 1.894E-01 - 23740 1.905E-01 - 23750 1.902E-01 - 23760 1.890E-01 - 23770 1.873E-01 - 23780 1.854E-01 - 23790 1.838E-01 - 23800 1.823E-01 - 23810 1.812E-01 - 23820 1.804E-01 - 23830 1.798E-01 - 23840 1.794E-01 - 23850 1.792E-01 - 23860 1.791E-01 - 23870 1.789E-01 - 23880 1.786E-01 - 23890 1.779E-01 - 23900 1.771E-01 - 23910 1.760E-01 - 23920 1.750E-01 - 23930 1.745E-01 - 23940 1.746E-01 - 23950 1.759E-01 - 23960 1.722E-01 - 23970 1.755E-01 - 23980 1.792E-01 - 23990 1.827E-01 - 24000 1.855E-01 - 24010 1.869E-01 - 24020 1.871E-01 - 24030 1.857E-01 - 24040 1.835E-01 - 24050 1.809E-01 - 24060 1.785E-01 - 24070 1.767E-01 - 24080 1.755E-01 - 24090 1.751E-01 - 24100 1.753E-01 - 24110 1.759E-01 - 24120 1.766E-01 - 24130 1.772E-01 - 24140 1.778E-01 - 24150 1.782E-01 - 24160 1.785E-01 - 24170 1.787E-01 - 24180 1.788E-01 - 24190 1.790E-01 - 24200 1.791E-01 - 24210 1.794E-01 - 24220 1.799E-01 - 24230 1.808E-01 - 24240 1.821E-01 - 24250 1.920E-01 - 24260 1.938E-01 - 24270 1.953E-01 - 24280 1.961E-01 - 24290 1.954E-01 - 24300 1.932E-01 - 24310 1.888E-01 - 24320 1.833E-01 - 24330 1.769E-01 - 24340 1.707E-01 - 24350 1.658E-01 - 24360 1.626E-01 - 24370 1.620E-01 - 24380 1.634E-01 - 24390 1.668E-01 - 24400 1.714E-01 - 24410 1.766E-01 - 24420 1.818E-01 - 24430 1.866E-01 - 24440 1.905E-01 - 24450 1.934E-01 - 24460 1.950E-01 - 24470 1.949E-01 - 24480 1.932E-01 - 24490 1.898E-01 - 24500 1.851E-01 - 24510 1.797E-01 - 24520 1.744E-01 - 24530 1.699E-01 - 24540 1.552E-01 - 24550 1.538E-01 - 24560 1.538E-01 - 24570 1.552E-01 - 24580 1.573E-01 - 24590 1.598E-01 - 24600 1.623E-01 - 24610 1.643E-01 - 24620 1.660E-01 - 24630 1.670E-01 - 24640 1.676E-01 - 24650 1.676E-01 - 24660 1.672E-01 - 24670 1.663E-01 - 24680 1.652E-01 - 24690 1.639E-01 - 24700 1.625E-01 - 24710 1.614E-01 - 24720 1.606E-01 - 24730 1.602E-01 - 24740 1.603E-01 - 24750 1.609E-01 - 24760 1.620E-01 - 24770 1.635E-01 - 24780 1.653E-01 - 24790 1.676E-01 - 24800 1.700E-01 - 24810 1.726E-01 - 24820 1.751E-01 - 24830 1.775E-01 - 24840 1.795E-01 - 24850 1.861E-01 - 24860 1.872E-01 - 24870 1.877E-01 - 24880 1.876E-01 - 24890 1.870E-01 - 24900 1.857E-01 - 24910 1.840E-01 - 24920 1.817E-01 - 24930 1.791E-01 - 24940 1.764E-01 - 24950 1.739E-01 - 24960 1.717E-01 - 24970 1.703E-01 - 24980 1.694E-01 - 24990 1.692E-01 - 25000 1.694E-01 - 25010 1.698E-01 - 25020 1.702E-01 - 25030 1.705E-01 - 25040 1.705E-01 - 25050 1.700E-01 - 25060 1.689E-01 - 25070 1.670E-01 - 25080 1.642E-01 - 25090 1.604E-01 - 25100 1.556E-01 - 25110 1.497E-01 - 25120 1.427E-01 - 25130 1.348E-01 - 25140 1.259E-01 - 25150 1.162E-01 - 25160 1.023E-01 - 25170 9.188E-02 - 25180 8.210E-02 - 25190 7.381E-02 - 25200 6.802E-02 - 25210 6.596E-02 - 25220 6.780E-02 - 25230 7.467E-02 - 25240 8.487E-02 - 25250 9.771E-02 - 25260 1.113E-01 - 25270 1.239E-01 - 25280 1.344E-01 - 25290 1.408E-01 - 25300 1.436E-01 - 25310 1.424E-01 - 25320 1.378E-01 - 25330 1.304E-01 - 25340 1.208E-01 - 25350 1.096E-01 - 25360 9.753E-02 - 25370 8.532E-02 - 25380 7.385E-02 - 25390 6.398E-02 - 25400 5.648E-02 - 25410 5.246E-02 - 25420 5.176E-02 - 25430 5.496E-02 - 25440 6.099E-02 - 25450 6.926E-02 - 25460 7.887E-02 - 25470 8.893E-02 - 25480 9.338E-02 - 25490 1.025E-01 - 25500 1.108E-01 - 25510 1.181E-01 - 25520 1.245E-01 - 25530 1.299E-01 - 25540 1.344E-01 - 25550 1.379E-01 - 25560 1.405E-01 - 25570 1.423E-01 - 25580 1.432E-01 - 25590 1.433E-01 - 25600 1.426E-01 - 25610 1.413E-01 - 25620 1.393E-01 - 25630 1.367E-01 - 25640 1.335E-01 - 25650 1.297E-01 - 25660 1.254E-01 - 25670 1.206E-01 - 25680 1.153E-01 - 25690 1.098E-01 - 25700 1.043E-01 - 25710 9.908E-02 - 25720 9.432E-02 - 25730 9.043E-02 - 25740 8.750E-02 - 25750 8.583E-02 - 25760 8.523E-02 - 25770 8.565E-02 - 25780 8.686E-02 - 25790 8.868E-02 - 25800 9.092E-02 - 25810 9.662E-02 - 25820 9.918E-02 - 25830 1.016E-01 - 25840 1.036E-01 - 25850 1.052E-01 - 25860 1.061E-01 - 25870 1.060E-01 - 25880 1.051E-01 - 25890 1.033E-01 - 25900 1.011E-01 - 25910 9.876E-02 - 25920 9.670E-02 - 25930 9.537E-02 - 25940 9.488E-02 - 25950 9.568E-02 - 25960 9.718E-02 - 25970 9.917E-02 - 25980 1.010E-01 - 25990 1.022E-01 - 26000 1.023E-01 - 26010 1.005E-01 - 26020 9.731E-02 - 26030 9.256E-02 - 26040 8.695E-02 - 26050 8.099E-02 - 26060 7.524E-02 - 26070 7.033E-02 - 26080 6.650E-02 - 26090 6.423E-02 - 26100 6.330E-02 - 26110 6.370E-02 - 26120 6.524E-02 - 26130 6.775E-02 - 26140 7.112E-02 - 26150 7.785E-02 - 26160 8.248E-02 - 26170 8.756E-02 - 26180 9.298E-02 - 26190 9.862E-02 - 26200 1.044E-01 - 26210 1.102E-01 - 26220 1.157E-01 - 26230 1.209E-01 - 26240 1.253E-01 - 26250 1.288E-01 - 26260 1.310E-01 - 26270 1.316E-01 - 26280 1.304E-01 - 26290 1.272E-01 - 26300 1.227E-01 - 26310 1.173E-01 - 26320 1.119E-01 - 26330 1.072E-01 - 26340 1.039E-01 - 26350 1.029E-01 - 26360 1.040E-01 - 26370 1.075E-01 - 26380 1.126E-01 - 26390 1.187E-01 - 26400 1.250E-01 - 26410 1.307E-01 - 26420 1.354E-01 - 26430 1.384E-01 - 26440 1.400E-01 - 26450 1.401E-01 - 26460 1.390E-01 - 26470 1.369E-01 - 26480 1.342E-01 - 26490 1.309E-01 - 26500 1.291E-01 - 26510 1.256E-01 - 26520 1.222E-01 - 26530 1.192E-01 - 26540 1.166E-01 - 26550 1.149E-01 - 26560 1.139E-01 - 26570 1.140E-01 - 26580 1.147E-01 - 26590 1.158E-01 - 26600 1.170E-01 - 26610 1.178E-01 - 26620 1.181E-01 - 26630 1.173E-01 - 26640 1.154E-01 - 26650 1.124E-01 - 26660 1.087E-01 - 26670 1.045E-01 - 26680 1.002E-01 - 26690 9.600E-02 - 26700 9.227E-02 - 26710 8.934E-02 - 26720 8.714E-02 - 26730 8.577E-02 - 26740 8.512E-02 - 26750 8.513E-02 - 26760 8.573E-02 - 26770 8.685E-02 - 26780 8.846E-02 - 26790 9.051E-02 - 26800 9.301E-02 - 26810 9.595E-02 - 26820 9.935E-02 - 26830 1.032E-01 - 26840 1.075E-01 - 26850 1.064E-01 - 26860 1.113E-01 - 26870 1.161E-01 - 26880 1.206E-01 - 26890 1.243E-01 - 26900 1.269E-01 - 26910 1.280E-01 - 26920 1.275E-01 - 26930 1.251E-01 - 26940 1.216E-01 - 26950 1.173E-01 - 26960 1.130E-01 - 26970 1.093E-01 - 26980 1.067E-01 - 26990 1.061E-01 - 27000 1.072E-01 - 27010 1.103E-01 - 27020 1.145E-01 - 27030 1.193E-01 - 27040 1.239E-01 - 27050 1.275E-01 - 27060 1.297E-01 - 27070 1.298E-01 - 27080 1.282E-01 - 27090 1.250E-01 - 27100 1.209E-01 - 27110 1.164E-01 - 27120 1.121E-01 - 27130 1.088E-01 - 27140 1.066E-01 - 27150 1.061E-01 - 27160 1.067E-01 - 27170 1.084E-01 - 27180 1.109E-01 - 27190 1.136E-01 - 27200 1.163E-01 - 27210 1.185E-01 - 27220 1.236E-01 - 27230 1.247E-01 - 27240 1.252E-01 - 27250 1.255E-01 - 27260 1.255E-01 - 27270 1.256E-01 - 27280 1.257E-01 - 27290 1.262E-01 - 27300 1.267E-01 - 27310 1.275E-01 - 27320 1.282E-01 - 27330 1.286E-01 - 27340 1.286E-01 - 27350 1.281E-01 - 27360 1.269E-01 - 27370 1.248E-01 - 27380 1.221E-01 - 27390 1.189E-01 - 27400 1.152E-01 - 27410 1.114E-01 - 27420 1.077E-01 - 27430 1.041E-01 - 27440 1.008E-01 - 27450 9.815E-02 - 27460 9.599E-02 - 27470 9.451E-02 - 27480 9.380E-02 - 27490 9.392E-02 - 27500 9.492E-02 - 27510 9.696E-02 - 27520 9.978E-02 - 27530 1.033E-01 - 27540 1.071E-01 - 27550 1.109E-01 - 27560 1.142E-01 - 27570 1.166E-01 - 27580 1.178E-01 - 27590 1.147E-01 - 27600 1.129E-01 - 27610 1.097E-01 - 27620 1.056E-01 - 27630 1.011E-01 - 27640 9.640E-02 - 27650 9.216E-02 - 27660 8.859E-02 - 27670 8.617E-02 - 27680 8.479E-02 - 27690 8.457E-02 - 27700 8.535E-02 - 27710 8.703E-02 - 27720 8.950E-02 - 27730 9.270E-02 - 27740 9.641E-02 - 27750 1.006E-01 - 27760 1.047E-01 - 27770 1.086E-01 - 27780 1.117E-01 - 27790 1.137E-01 - 27800 1.143E-01 - 27810 1.129E-01 - 27820 1.095E-01 - 27830 1.040E-01 - 27840 9.701E-02 - 27850 8.912E-02 - 27860 8.105E-02 - 27870 7.353E-02 - 27880 6.719E-02 - 27890 6.290E-02 - 27900 6.069E-02 - 27910 6.109E-02 - 27920 6.336E-02 - 27930 6.716E-02 - 27940 7.187E-02 - 27950 7.693E-02 - 27960 8.184E-02 - 27970 8.591E-02 - 27980 9.204E-02 - 27990 9.399E-02 - 28000 9.506E-02 - 28010 9.541E-02 - 28020 9.531E-02 - 28030 9.504E-02 - 28040 9.483E-02 - 28050 9.497E-02 - 28060 9.548E-02 - 28070 9.651E-02 - 28080 9.789E-02 - 28090 9.956E-02 - 28100 1.014E-01 - 28110 1.033E-01 - 28120 1.051E-01 - 28130 1.068E-01 - 28140 1.083E-01 - 28150 1.095E-01 - 28160 1.106E-01 - 28170 1.115E-01 - 28180 1.123E-01 - 28190 1.131E-01 - 28200 1.138E-01 - 28210 1.145E-01 - 28220 1.152E-01 - 28230 1.158E-01 - 28240 1.162E-01 - 28250 1.164E-01 - 28260 1.161E-01 - 28270 1.154E-01 - 28280 1.141E-01 - 28290 1.120E-01 - 28300 1.093E-01 - 28310 1.061E-01 - 28320 1.026E-01 - 28330 9.894E-02 - 28340 9.548E-02 - 28350 9.241E-02 - 28360 8.992E-02 - 28370 8.439E-02 - 28380 8.360E-02 - 28390 8.373E-02 - 28400 8.463E-02 - 28410 8.620E-02 - 28420 8.829E-02 - 28430 9.080E-02 - 28440 9.359E-02 - 28450 9.654E-02 - 28460 9.947E-02 - 28470 1.024E-01 - 28480 1.050E-01 - 28490 1.072E-01 - 28500 1.089E-01 - 28510 1.102E-01 - 28520 1.073E-01 - 28530 1.129E-01 - 28540 1.213E-01 - 28550 1.208E-01 - 28560 1.180E-01 - 28570 1.166E-01 - 28580 1.049E-01 - 28590 8.652E-02 - 28600 8.218E-02 - 28610 9.052E-02 - 28620 9.264E-02 - 28630 8.667E-02 - 28640 8.119E-02 - 28650 7.907E-02 - 28660 8.669E-02 - 28670 1.013E-01 - 28680 1.052E-01 - 28690 9.583E-02 - 28700 8.837E-02 - 28710 8.989E-02 - 28720 9.626E-02 - 28730 1.011E-01 - 28740 1.019E-01 - 28750 9.537E-02 - 28760 8.144E-02 - 28770 7.402E-02 - 28780 7.835E-02 - 28790 8.840E-02 - 28800 9.703E-02 - 28810 1.065E-01 - 28820 1.107E-01 - 28830 1.087E-01 - 28840 1.022E-01 - 28850 9.712E-02 - 28860 1.022E-01 - 28870 1.038E-01 - 28880 9.139E-02 - 28890 7.978E-02 - 28900 7.940E-02 - 28910 8.532E-02 - 28920 9.398E-02 - 28930 1.039E-01 - 28940 1.091E-01 - 28950 1.030E-01 - 28960 9.540E-02 - 28970 1.009E-01 - 28980 1.073E-01 - 28990 1.025E-01 - 29000 9.318E-02 - 29010 8.421E-02 - 29020 7.791E-02 - 29030 7.154E-02 - 29040 6.309E-02 - 29050 5.583E-02 - 29060 5.499E-02 - 29070 6.809E-02 - 29080 8.518E-02 - 29090 9.413E-02 - 29100 1.025E-01 - 29110 1.070E-01 - 29120 1.001E-01 - 29130 9.716E-02 - 29140 1.086E-01 - 29150 1.197E-01 - 29160 1.169E-01 - 29170 1.047E-01 - 29180 9.826E-02 - 29190 9.865E-02 - 29200 9.610E-02 - 29210 9.235E-02 - 29220 9.930E-02 - 29230 1.109E-01 - 29240 1.159E-01 - 29250 1.110E-01 - 29260 1.026E-01 - 29270 9.537E-02 - 29280 8.474E-02 - 29290 7.764E-02 - 29300 8.649E-02 - 29310 9.999E-02 - 29320 1.014E-01 - 29330 9.588E-02 - 29340 9.298E-02 - 29350 9.435E-02 - 29360 9.848E-02 - 29370 1.013E-01 - 29380 1.036E-01 - 29390 1.085E-01 - 29400 1.163E-01 - 29410 1.204E-01 - 29420 1.159E-01 - 29430 1.103E-01 - 29440 1.055E-01 - 29450 9.877E-02 - 29460 8.844E-02 - 29470 7.943E-02 - 29480 8.217E-02 - 29490 9.511E-02 - 29500 1.033E-01 - 29510 9.906E-02 - 29520 9.666E-02 - 29530 1.024E-01 - 29540 1.025E-01 - 29550 9.625E-02 - 29560 9.290E-02 - 29570 8.807E-02 - 29580 7.732E-02 - 29590 7.572E-02 - 29600 9.036E-02 - 29610 1.057E-01 - 29620 1.083E-01 - 29630 9.999E-02 - 29640 8.630E-02 - 29650 7.522E-02 - 29660 7.027E-02 - 29670 6.944E-02 - 29680 6.948E-02 - 29690 7.334E-02 - 29700 8.318E-02 - 29710 9.601E-02 - 29720 1.039E-01 - 29730 9.958E-02 - 29740 8.266E-02 - 29750 6.149E-02 - 29760 5.310E-02 - 29770 6.478E-02 - 29780 8.742E-02 - 29790 1.062E-01 - 29800 1.123E-01 - 29810 1.092E-01 - 29820 1.066E-01 - 29830 1.078E-01 - 29840 1.044E-01 - 29850 9.119E-02 - 29860 8.169E-02 - 29870 8.962E-02 - 29880 1.030E-01 - 29890 1.087E-01 - 29900 1.087E-01 - 29910 1.043E-01 - 29920 9.736E-02 - 29930 9.476E-02 - 29940 9.667E-02 - 29950 9.696E-02 - 29960 9.074E-02 - 29970 8.057E-02 - 29980 7.837E-02 - 29990 8.762E-02 - 30000 9.825E-02 - 30010 1.026E-01 - 30020 1.012E-01 - 30030 9.550E-02 - 30040 9.138E-02 - 30050 9.489E-02 - 30060 1.023E-01 - 30070 1.061E-01 - 30080 9.671E-02 - 30090 8.555E-02 - 30100 8.480E-02 - 30110 9.308E-02 - 30120 9.890E-02 - 30130 1.015E-01 - 30140 1.032E-01 - 30150 1.015E-01 - 30160 9.529E-02 - 30170 8.885E-02 - 30180 8.862E-02 - 30190 9.399E-02 - 30200 9.898E-02 - 30210 1.012E-01 - 30220 1.007E-01 - 30230 9.518E-02 - 30240 8.466E-02 - 30250 8.050E-02 - 30260 8.896E-02 - 30270 9.757E-02 - 30280 1.018E-01 - 30290 1.123E-01 - 30300 1.230E-01 - 30310 1.208E-01 - 30320 1.138E-01 - 30330 1.128E-01 - 30340 1.127E-01 - 30350 1.126E-01 - 30360 1.137E-01 - 30370 1.109E-01 - 30380 1.071E-01 - 30390 1.070E-01 - 30400 1.034E-01 - 30410 9.095E-02 - 30420 7.855E-02 - 30430 7.750E-02 - 30440 8.612E-02 - 30450 9.293E-02 - 30460 9.258E-02 - 30470 9.075E-02 - 30480 9.198E-02 - 30490 9.197E-02 - 30500 9.101E-02 - 30510 9.235E-02 - 30520 9.412E-02 - 30530 9.752E-02 - 30540 1.019E-01 - 30550 1.014E-01 - 30560 9.745E-02 - 30570 9.323E-02 - 30580 9.505E-02 - 30590 1.017E-01 - 30600 1.064E-01 - 30610 1.063E-01 - 30620 9.964E-02 - 30630 9.127E-02 - 30640 9.197E-02 - 30650 9.934E-02 - 30660 1.044E-01 - 30670 1.074E-01 - 30680 1.080E-01 - 30690 1.047E-01 - 30700 1.026E-01 - 30710 1.030E-01 - 30720 9.742E-02 - 30730 8.747E-02 - 30740 8.263E-02 - 30750 8.060E-02 - 30760 7.782E-02 - 30770 7.550E-02 - 30780 7.367E-02 - 30790 7.608E-02 - 30800 8.406E-02 - 30810 8.847E-02 - 30820 8.487E-02 - 30830 8.116E-02 - 30840 8.203E-02 - 30850 8.380E-02 - 30860 8.095E-02 - 30870 7.573E-02 - 30880 7.344E-02 - 30890 6.998E-02 - 30900 6.622E-02 - 30910 6.550E-02 - 30920 6.758E-02 - 30930 7.337E-02 - 30940 7.546E-02 - 30950 6.831E-02 - 30960 5.919E-02 - 30970 5.637E-02 - 30980 5.960E-02 - 30990 6.386E-02 - 31000 6.960E-02 - 31010 7.630E-02 - 31020 7.635E-02 - 31030 7.341E-02 - 31040 7.971E-02 - 31050 8.833E-02 - 31060 8.991E-02 - 31070 8.521E-02 - 31080 7.669E-02 - 31090 7.099E-02 - 31100 6.647E-02 - 31110 5.960E-02 - 31120 5.673E-02 - 31130 5.763E-02 - 31140 5.977E-02 - 31150 6.505E-02 - 31160 7.274E-02 - 31170 8.233E-02 - 31180 9.037E-02 - 31190 9.281E-02 - 31200 9.287E-02 - 31210 9.089E-02 - 31220 8.639E-02 - 31230 8.313E-02 - 31240 7.982E-02 - 31250 7.941E-02 - 31260 8.291E-02 - 31270 7.933E-02 - 31280 7.093E-02 - 31290 6.812E-02 - 31300 6.668E-02 - 31310 5.999E-02 - 31320 5.300E-02 - 31330 5.591E-02 - 31340 7.028E-02 - 31350 8.454E-02 - 31360 8.595E-02 - 31370 7.806E-02 - 31380 7.269E-02 - 31390 7.015E-02 - 31400 6.617E-02 - 31410 6.136E-02 - 31420 5.667E-02 - 31430 5.306E-02 - 31440 5.167E-02 - 31450 5.387E-02 - 31460 6.400E-02 - 31470 8.084E-02 - 31480 9.167E-02 - 31490 9.023E-02 - 31500 8.604E-02 - 31510 8.930E-02 - 31520 9.372E-02 - 31530 9.322E-02 - 31540 8.565E-02 - 31550 7.468E-02 - 31560 6.933E-02 - 31570 7.030E-02 - 31580 6.928E-02 - 31590 6.595E-02 - 31600 6.551E-02 - 31610 6.572E-02 - 31620 6.027E-02 - 31630 5.114E-02 - 31640 4.510E-02 - 31650 4.187E-02 - 31660 4.085E-02 - 31670 4.720E-02 - 31680 5.936E-02 - 31690 6.794E-02 - 31700 7.157E-02 - 31710 7.408E-02 - 31720 7.480E-02 - 31730 7.436E-02 - 31740 7.542E-02 - 31750 7.663E-02 - 31760 7.294E-02 - 31770 6.577E-02 - 31780 5.901E-02 - 31790 4.889E-02 - 31800 4.029E-02 - 31810 4.798E-02 - 31820 6.816E-02 - 31830 8.153E-02 - 31840 8.363E-02 - 31850 8.417E-02 - 31860 8.588E-02 - 31870 8.292E-02 - 31880 7.596E-02 - 31890 7.040E-02 - 31900 6.658E-02 - 31910 6.535E-02 - 31920 6.695E-02 - 31930 6.834E-02 - 31940 6.943E-02 - 31950 7.101E-02 - 31960 7.182E-02 - 31970 7.141E-02 - 31980 6.880E-02 - 31990 6.551E-02 - 32000 6.905E-02 - 32010 7.429E-02 - 32020 7.164E-02 - 32030 6.421E-02 - 32040 6.039E-02 - 32050 6.026E-02 - 32060 6.180E-02 - 32070 6.447E-02 - 32080 6.962E-02 - 32090 7.746E-02 - 32100 8.185E-02 - 32110 8.197E-02 - 32120 8.464E-02 - 32130 8.678E-02 - 32140 8.327E-02 - 32150 8.124E-02 - 32160 8.570E-02 - 32170 8.919E-02 - 32180 8.607E-02 - 32190 8.050E-02 - 32200 7.748E-02 - 32210 7.636E-02 - 32220 6.908E-02 - 32230 5.243E-02 - 32240 3.658E-02 - 32250 3.122E-02 - 32260 3.754E-02 - 32270 4.725E-02 - 32280 4.949E-02 - 32290 5.013E-02 - 32300 5.674E-02 - 32310 5.694E-02 - 32320 4.569E-02 - 32330 3.764E-02 - 32340 3.984E-02 - 32350 4.685E-02 - 32360 5.465E-02 - 32370 5.960E-02 - 32380 6.001E-02 - 32390 6.242E-02 - 32400 7.131E-02 - 32410 7.810E-02 - 32420 7.354E-02 - 32430 6.232E-02 - 32440 5.492E-02 - 32450 5.666E-02 - 32460 6.492E-02 - 32470 6.927E-02 - 32480 6.666E-02 - 32490 6.606E-02 - 32500 6.642E-02 - 32510 6.054E-02 - 32520 5.915E-02 - 32530 6.361E-02 - 32540 6.487E-02 - 32550 6.497E-02 - 32560 6.858E-02 - 32570 7.096E-02 - 32580 6.683E-02 - 32590 5.598E-02 - 32600 4.720E-02 - 32610 4.890E-02 - 32620 5.364E-02 - 32630 5.486E-02 - 32640 5.908E-02 - 32650 6.689E-02 - 32660 6.898E-02 - 32670 5.964E-02 - 32680 4.385E-02 - 32690 3.272E-02 - 32700 3.311E-02 - 32710 4.409E-02 - 32720 5.651E-02 - 32730 6.030E-02 - 32740 6.047E-02 - 32750 6.844E-02 - 32760 7.732E-02 - 32770 7.450E-02 - 32780 6.768E-02 - 32790 6.356E-02 - 32800 5.403E-02 - 32810 4.501E-02 - 32820 5.083E-02 - 32830 6.402E-02 - 32840 6.924E-02 - 32850 6.640E-02 - 32860 5.889E-02 - 32870 5.055E-02 - 32880 4.976E-02 - 32890 5.589E-02 - 32900 5.736E-02 - 32910 4.861E-02 - 32920 4.225E-02 - 32930 5.164E-02 - 32940 6.625E-02 - 32950 7.189E-02 - 32960 7.272E-02 - 32970 7.239E-02 - 32980 6.604E-02 - 32990 5.830E-02 - 33000 5.841E-02 - 33010 6.851E-02 - 33020 7.285E-02 - 33030 6.640E-02 - 33040 5.119E-02 - 33050 4.413E-02 - 33060 4.938E-02 - 33070 5.644E-02 - 33080 5.515E-02 - 33090 4.141E-02 - 33100 2.581E-02 - 33110 2.281E-02 - 33120 2.970E-02 - 33130 3.687E-02 - 33140 4.330E-02 - 33150 4.980E-02 - 33160 5.390E-02 - 33170 5.516E-02 - 33180 5.519E-02 - 33190 5.362E-02 - 33200 5.250E-02 - 33210 5.261E-02 - 33220 4.786E-02 - 33230 3.930E-02 - 33240 3.447E-02 - 33250 3.649E-02 - 33260 4.401E-02 - 33270 5.088E-02 - 33280 4.984E-02 - 33290 4.041E-02 - 33300 3.084E-02 - 33310 2.724E-02 - 33320 2.664E-02 - 33330 2.946E-02 - 33340 4.065E-02 - 33350 5.530E-02 - 33360 6.268E-02 - 33370 5.917E-02 - 33380 4.768E-02 - 33390 3.853E-02 - 33400 4.139E-02 - 33410 5.014E-02 - 33420 5.723E-02 - 33430 6.335E-02 - 33440 6.537E-02 - 33450 6.032E-02 - 33460 5.160E-02 - 33470 4.393E-02 - 33480 3.859E-02 - 33490 3.365E-02 - 33500 2.944E-02 - 33510 3.011E-02 - 33520 3.346E-02 - 33530 3.798E-02 - 33540 4.316E-02 - 33550 5.089E-02 - 33560 5.888E-02 - 33570 6.767E-02 - 33580 7.549E-02 - 33590 7.413E-02 - 33600 6.712E-02 - 33610 6.288E-02 - 33620 5.612E-02 - 33630 4.585E-02 - 33640 4.344E-02 - 33650 4.692E-02 - 33660 4.445E-02 - 33670 4.021E-02 - 33680 4.248E-02 - 33690 4.271E-02 - 33700 3.565E-02 - 33710 3.226E-02 - 33720 3.780E-02 - 33730 4.915E-02 - 33740 6.269E-02 - 33750 7.056E-02 - 33760 6.836E-02 - 33770 6.196E-02 - 33780 5.996E-02 - 33790 6.352E-02 - 33800 6.465E-02 - 33810 5.918E-02 - 33820 5.606E-02 - 33830 5.877E-02 - 33840 5.714E-02 - 33850 5.227E-02 - 33860 5.642E-02 - 33870 6.534E-02 - 33880 6.536E-02 - 33890 5.628E-02 - 33900 4.461E-02 - 33910 3.576E-02 - 33920 3.574E-02 - 33930 4.677E-02 - 33940 5.883E-02 - 33950 5.979E-02 - 33960 5.639E-02 - 33970 5.821E-02 - 33980 5.962E-02 - 33990 5.558E-02 - 34000 4.769E-02 - 34010 4.774E-02 - 34020 4.576E-02 - 34030 4.078E-02 - 34040 3.585E-02 - 34050 3.733E-02 - 34060 4.919E-02 - 34070 5.995E-02 - 34080 6.051E-02 - 34090 5.925E-02 - 34100 6.198E-02 - 34110 6.408E-02 - 34120 6.182E-02 - 34130 5.359E-02 - 34140 4.450E-02 - 34150 4.326E-02 - 34160 4.461E-02 - 34170 4.311E-02 - 34180 4.353E-02 - 34190 4.537E-02 - 34200 4.648E-02 - 34210 4.979E-02 - 34220 5.441E-02 - 34230 5.614E-02 - 34240 5.570E-02 - 34250 5.505E-02 - 34260 5.352E-02 - 34270 5.261E-02 - 34280 5.329E-02 - 34290 5.279E-02 - 34300 5.256E-02 - 34310 5.663E-02 - 34320 6.312E-02 - 34330 6.532E-02 - 34340 6.108E-02 - 34350 5.663E-02 - 34360 5.542E-02 - 34370 5.551E-02 - 34380 5.587E-02 - 34390 5.712E-02 - 34400 5.926E-02 - 34410 6.233E-02 - 34420 6.593E-02 - 34430 6.771E-02 - 34440 6.568E-02 - 34450 6.104E-02 - 34460 6.004E-02 - 34470 6.391E-02 - 34480 6.381E-02 - 34490 5.794E-02 - 34500 5.327E-02 - 34510 5.468E-02 - 34520 5.499E-02 - 34530 5.349E-02 - 34540 4.870E-02 - 34550 4.369E-02 - 34560 4.165E-02 - 34570 4.158E-02 - 34580 4.138E-02 - 34590 4.075E-02 - 34600 4.044E-02 - 34610 4.043E-02 - 34620 4.033E-02 - 34630 4.049E-02 - 34640 4.148E-02 - 34650 4.269E-02 - 34660 4.132E-02 - 34670 3.521E-02 - 34680 2.600E-02 - 34690 1.702E-02 - 34700 1.259E-02 - 34710 1.528E-02 - 34720 2.128E-02 - 34730 2.641E-02 - 34740 3.118E-02 - 34750 3.438E-02 - 34760 3.457E-02 - 34770 3.503E-02 - 34780 3.649E-02 - 34790 3.740E-02 - 34800 3.940E-02 - 34810 4.285E-02 - 34820 4.508E-02 - 34830 4.314E-02 - 34840 3.685E-02 - 34850 3.118E-02 - 34860 2.993E-02 - 34870 3.139E-02 - 34880 3.384E-02 - 34890 3.604E-02 - 34900 3.683E-02 - 34910 3.655E-02 - 34920 3.517E-02 - 34930 3.374E-02 - 34940 3.337E-02 - 34950 3.320E-02 - 34960 3.187E-02 - 34970 2.813E-02 - 34980 2.320E-02 - 34990 1.963E-02 - 35000 1.708E-02 - 35010 1.667E-02 - 35020 1.381E-02 - 35030 1.096E-02 - 35040 7.820E-03 - 35050 5.073E-03 - 35060 4.397E-03 - 35070 5.905E-03 - 35080 8.241E-03 - 35090 1.095E-02 - 35100 1.418E-02 - 35110 1.759E-02 - 35120 2.071E-02 - 35130 2.365E-02 - 35140 2.676E-02 - 35150 2.820E-02 - 35160 2.763E-02 - 35170 2.908E-02 - 35180 3.227E-02 - 35190 3.282E-02 - 35200 3.181E-02 - 35210 3.293E-02 - 35220 3.556E-02 - 35230 3.706E-02 - 35240 3.545E-02 - 35250 3.071E-02 - 35260 2.762E-02 - 35270 2.994E-02 - 35280 3.421E-02 - 35290 3.599E-02 - 35300 3.560E-02 - 35310 3.558E-02 - 35320 3.651E-02 - 35330 3.697E-02 - 35340 3.593E-02 - 35350 3.388E-02 - 35360 3.225E-02 - 35370 3.105E-02 - 35380 2.958E-02 - 35390 2.986E-02 - 35400 3.262E-02 - 35410 3.372E-02 - 35420 3.174E-02 - 35430 3.004E-02 - 35440 3.003E-02 - 35450 3.041E-02 - 35460 3.003E-02 - 35470 2.866E-02 - 35480 2.665E-02 - 35490 2.498E-02 - 35500 2.475E-02 - 35510 2.865E-02 - 35520 2.872E-02 - 35530 2.654E-02 - 35540 2.280E-02 - 35550 2.016E-02 - 35560 1.943E-02 - 35570 1.943E-02 - 35580 1.938E-02 - 35590 1.882E-02 - 35600 1.751E-02 - 35610 1.581E-02 - 35620 1.418E-02 - 35630 1.268E-02 - 35640 1.111E-02 - 35650 9.611E-03 - 35660 8.926E-03 - 35670 9.140E-03 - 35680 9.148E-03 - 35690 8.729E-03 - 35700 8.889E-03 - 35710 9.338E-03 - 35720 9.092E-03 - 35730 8.336E-03 - 35740 7.772E-03 - 35750 8.012E-03 - 35760 9.089E-03 - 35770 9.625E-03 - 35780 8.837E-03 - 35790 8.429E-03 - 35800 9.364E-03 - 35810 1.051E-02 - 35820 1.133E-02 - 35830 1.217E-02 - 35840 1.325E-02 - 35850 1.439E-02 - 35860 1.554E-02 - 35870 1.720E-02 - 35880 1.902E-02 - 35890 1.995E-02 - 35900 1.997E-02 - 35910 1.946E-02 - 35920 1.884E-02 - 35930 1.886E-02 - 35940 1.921E-02 - 35950 1.901E-02 - 35960 1.857E-02 - 35970 1.859E-02 - 35980 1.922E-02 - 35990 2.070E-02 - 36000 1.955E-02 - 36010 2.140E-02 - 36020 2.324E-02 - 36030 2.581E-02 - 36040 2.793E-02 - 36050 2.788E-02 - 36060 2.612E-02 - 36070 2.546E-02 - 36080 2.669E-02 - 36090 2.659E-02 - 36100 2.401E-02 - 36110 2.218E-02 - 36120 2.274E-02 - 36130 2.403E-02 - 36140 2.547E-02 - 36150 2.789E-02 - 36160 2.972E-02 - 36170 2.836E-02 - 36180 2.440E-02 - 36190 2.096E-02 - 36200 2.082E-02 - 36210 2.364E-02 - 36220 2.619E-02 - 36230 2.805E-02 - 36240 2.909E-02 - 36250 2.598E-02 - 36260 1.922E-02 - 36270 1.325E-02 - 36280 1.102E-02 - 36290 1.278E-02 - 36300 1.619E-02 - 36310 1.957E-02 - 36320 2.198E-02 - 36330 2.134E-02 - 36340 1.718E-02 - 36350 1.197E-02 - 36360 9.075E-03 - 36370 9.915E-03 - 36380 1.150E-02 - 36390 1.092E-02 - 36400 1.046E-02 - 36410 1.237E-02 - 36420 1.385E-02 - 36430 1.220E-02 - 36440 9.651E-03 - 36450 9.180E-03 - 36460 1.091E-02 - 36470 1.294E-02 - 36480 1.336E-02 - 36490 1.258E-02 - 36500 1.286E-02 - 36510 1.393E-02 - 36520 1.359E-02 - 36530 1.343E-02 - 36540 1.574E-02 - 36550 1.835E-02 - 36560 1.874E-02 - 36570 1.854E-02 - 36580 2.029E-02 - 36590 2.333E-02 - 36600 2.514E-02 - 36610 2.594E-02 - 36620 2.822E-02 - 36630 3.015E-02 - 36640 2.688E-02 - 36650 2.101E-02 - 36660 1.864E-02 - 36670 1.932E-02 - 36680 1.965E-02 - 36690 1.875E-02 - 36700 1.762E-02 - 36710 1.752E-02 - 36720 1.820E-02 - 36730 1.743E-02 - 36740 1.449E-02 - 36750 1.166E-02 - 36760 1.039E-02 - 36770 1.081E-02 - 36780 1.419E-02 - 36790 1.970E-02 - 36800 2.336E-02 - 36810 2.292E-02 - 36820 2.028E-02 - 36830 1.930E-02 - 36840 2.235E-02 - 36850 2.730E-02 - 36860 2.893E-02 - 36870 2.663E-02 - 36880 2.495E-02 - 36890 2.521E-02 - 36900 2.516E-02 - 36910 2.457E-02 - 36920 2.455E-02 - 36930 2.447E-02 - 36940 2.459E-02 - 36950 2.694E-02 - 36960 3.056E-02 - 36970 3.172E-02 - 36980 3.011E-02 - 36990 2.801E-02 - 37000 2.624E-02 - 37010 2.744E-02 - 37020 3.094E-02 - 37030 3.231E-02 - 37040 2.845E-02 - 37050 2.414E-02 - 37060 2.308E-02 - 37070 2.268E-02 - 37080 2.066E-02 - 37090 1.992E-02 - 37100 2.266E-02 - 37110 2.587E-02 - 37120 2.667E-02 - 37130 2.596E-02 - 37140 2.521E-02 - 37150 2.377E-02 - 37160 2.171E-02 - 37170 2.093E-02 - 37180 2.225E-02 - 37190 2.440E-02 - 37200 2.625E-02 - 37210 2.741E-02 - 37220 2.721E-02 - 37230 2.567E-02 - 37240 2.422E-02 - 37250 2.407E-02 - 37260 2.504E-02 - 37270 2.620E-02 - 37280 2.664E-02 - 37290 2.574E-02 - 37300 2.366E-02 - 37310 2.162E-02 - 37320 2.088E-02 - 37330 2.186E-02 - 37340 2.399E-02 - 37350 2.678E-02 - 37360 2.973E-02 - 37370 3.155E-02 - 37380 3.122E-02 - 37390 2.775E-02 - 37400 2.262E-02 - 37410 2.106E-02 - 37420 2.444E-02 - 37430 2.698E-02 - 37440 2.514E-02 - 37450 2.304E-02 - 37460 2.403E-02 - 37470 2.600E-02 - 37480 2.584E-02 - 37490 2.432E-02 - 37500 2.370E-02 - 37510 2.481E-02 - 37520 2.339E-02 - 37530 2.134E-02 - 37540 2.155E-02 - 37550 2.257E-02 - 37560 2.327E-02 - 37570 2.488E-02 - 37580 2.686E-02 - 37590 2.742E-02 - 37600 2.649E-02 - 37610 2.600E-02 - 37620 2.696E-02 - 37630 2.784E-02 - 37640 2.858E-02 - 37650 2.987E-02 - 37660 2.971E-02 - 37670 2.721E-02 - 37680 2.463E-02 - 37690 2.311E-02 - 37700 2.176E-02 - 37710 2.049E-02 - 37720 1.979E-02 - 37730 1.904E-02 - 37740 1.779E-02 - 37750 1.739E-02 - 37760 1.890E-02 - 37770 2.100E-02 - 37780 2.242E-02 - 37790 2.383E-02 - 37800 2.628E-02 - 37810 2.991E-02 - 37820 3.261E-02 - 37830 3.149E-02 - 37840 2.737E-02 - 37850 2.381E-02 - 37860 2.289E-02 - 37870 2.412E-02 - 37880 2.635E-02 - 37890 2.755E-02 - 37900 2.571E-02 - 37910 2.210E-02 - 37920 1.901E-02 - 37930 1.696E-02 - 37940 1.586E-02 - 37950 1.450E-02 - 37960 1.196E-02 - 37970 9.063E-03 - 37980 6.613E-03 - 37990 5.010E-03 - 38000 6.982E-03 - 38010 8.374E-03 - 38020 9.209E-03 - 38030 9.064E-03 - 38040 9.243E-03 - 38050 9.812E-03 - 38060 9.802E-03 - 38070 9.892E-03 - 38080 1.136E-02 - 38090 1.332E-02 - 38100 1.419E-02 - 38110 1.401E-02 - 38120 1.337E-02 - 38130 1.239E-02 - 38140 1.186E-02 - 38150 1.240E-02 - 38160 1.265E-02 - 38170 1.131E-02 - 38180 9.472E-03 - 38190 8.921E-03 - 38200 1.014E-02 - 38210 1.185E-02 - 38220 1.222E-02 - 38230 1.088E-02 - 38240 8.812E-03 - 38250 7.214E-03 - 38260 6.483E-03 - 38270 6.212E-03 - 38280 6.708E-03 - 38290 8.323E-03 - 38300 1.017E-02 - 38310 1.098E-02 - 38320 1.037E-02 - 38330 8.766E-03 - 38340 7.100E-03 - 38350 6.491E-03 - 38360 7.172E-03 - 38370 8.672E-03 - 38380 1.055E-02 - 38390 1.215E-02 - 38400 1.316E-02 - 38410 1.369E-02 - 38420 1.339E-02 - 38430 1.171E-02 - 38440 8.759E-03 - 38450 5.928E-03 - 38460 4.789E-03 - 38470 5.534E-03 - 38480 7.679E-03 - 38490 1.025E-02 - 38500 1.148E-02 - 38510 1.094E-02 - 38520 1.038E-02 - 38530 9.389E-03 - 38540 8.205E-03 - 38550 8.342E-03 - 38560 9.738E-03 - 38570 1.079E-02 - 38580 1.178E-02 - 38590 1.419E-02 - 38600 1.647E-02 - 38610 1.602E-02 - 38620 1.352E-02 - 38630 1.114E-02 - 38640 9.162E-03 - 38650 7.188E-03 - 38660 6.110E-03 - 38670 7.025E-03 - 38680 9.386E-03 - 38690 1.131E-02 - 38700 1.185E-02 - 38710 1.248E-02 - 38720 1.487E-02 - 38730 1.737E-02 - 38740 1.748E-02 - 38750 1.597E-02 - 38760 1.430E-02 - 38770 1.261E-02 - 38780 1.090E-02 - 38790 9.067E-03 - 38800 7.457E-03 - 38810 6.963E-03 - 38820 8.055E-03 - 38830 1.031E-02 - 38840 1.278E-02 - 38850 1.420E-02 - 38860 1.405E-02 - 38870 1.328E-02 - 38880 1.281E-02 - 38890 1.280E-02 - 38900 1.309E-02 - 38910 1.296E-02 - 38920 1.217E-02 - 38930 1.151E-02 - 38940 1.134E-02 - 38950 1.149E-02 - 38960 1.160E-02 - 38970 1.092E-02 - 38980 9.431E-03 - 38990 7.921E-03 - 39000 6.762E-03 - 39010 7.029E-03 - 39020 7.282E-03 - 39030 8.212E-03 - 39040 9.198E-03 - 39050 9.823E-03 - 39060 1.022E-02 - 39070 1.023E-02 - 39080 9.517E-03 - 39090 8.623E-03 - 39100 8.302E-03 - 39110 8.438E-03 - 39120 8.605E-03 - 39130 8.907E-03 - 39140 9.327E-03 - 39150 9.277E-03 - 39160 8.851E-03 - 39170 8.889E-03 - 39180 9.165E-03 - 39190 8.642E-03 - 39200 7.277E-03 - 39210 5.937E-03 - 39220 5.336E-03 - 39230 5.538E-03 - 39240 5.941E-03 - 39250 6.001E-03 - 39260 5.852E-03 - 39270 5.893E-03 - 39280 6.217E-03 - 39290 6.617E-03 - 39300 6.886E-03 - 39310 6.901E-03 - 39320 6.573E-03 - 39330 6.053E-03 - 39340 5.720E-03 - 39350 5.814E-03 - 39360 6.090E-03 - 39370 6.057E-03 - 39380 5.802E-03 - 39390 5.733E-03 - 39400 5.736E-03 - 39410 5.555E-03 - 39420 5.349E-03 - 39430 5.385E-03 - 39440 5.618E-03 - 39450 5.796E-03 - 39460 5.826E-03 - 39470 5.828E-03 - 39480 5.951E-03 - 39490 6.154E-03 - 39500 5.871E-03 - 39510 5.224E-03 - 39520 4.204E-03 - 39530 3.470E-03 - 39540 3.256E-03 - 39550 3.428E-03 - 39560 3.849E-03 - 39570 4.348E-03 - 39580 4.685E-03 - 39590 4.604E-03 - 39600 4.155E-03 - 39610 3.699E-03 - 39620 3.470E-03 - 39630 3.557E-03 - 39640 4.016E-03 - 39650 4.641E-03 - 39660 5.021E-03 - 39670 4.913E-03 - 39680 4.444E-03 - 39690 4.039E-03 - 39700 3.919E-03 - 39710 3.911E-03 - 39720 3.821E-03 - 39730 3.644E-03 - 39740 3.574E-03 - 39750 3.690E-03 - 39760 3.830E-03 - 39770 4.016E-03 - 39780 4.431E-03 - 39790 4.984E-03 - 39800 5.338E-03 - 39810 5.411E-03 - 39820 5.524E-03 - 39830 6.003E-03 - 39840 6.648E-03 - 39850 6.863E-03 - 39860 6.426E-03 - 39870 5.547E-03 - 39880 4.643E-03 - 39890 4.342E-03 - 39900 4.904E-03 - 39910 5.880E-03 - 39920 6.703E-03 - 39930 7.043E-03 - 39940 6.900E-03 - 39950 6.472E-03 - 39960 5.840E-03 - 39970 5.312E-03 - 39980 5.498E-03 - 39990 6.425E-03 - 40000 7.146E-03 - 40010 7.361E-03 - 40020 7.090E-03 - 40030 6.880E-03 - 40040 6.824E-03 - 40050 6.714E-03 - 40060 6.666E-03 - 40070 6.877E-03 - 40080 7.011E-03 - 40090 6.631E-03 - 40100 5.905E-03 - 40110 5.228E-03 - 40120 4.480E-03 - 40130 3.570E-03 - 40140 2.960E-03 - 40150 2.862E-03 - 40160 3.069E-03 - 40170 3.274E-03 - 40180 3.300E-03 - 40190 3.422E-03 - 40200 3.893E-03 - 40210 4.488E-03 - 40220 4.856E-03 - 40230 4.772E-03 - 40240 4.273E-03 - 40250 3.571E-03 - 40260 3.050E-03 - 40270 3.117E-03 - 40280 3.751E-03 - 40290 4.649E-03 - 40300 5.275E-03 - 40310 5.254E-03 - 40320 4.782E-03 - 40330 4.388E-03 - 40340 4.486E-03 - 40350 4.925E-03 - 40360 5.372E-03 - 40370 5.697E-03 - 40380 5.895E-03 - 40390 6.058E-03 - 40400 6.196E-03 - 40410 6.146E-03 - 40420 5.639E-03 - 40430 4.832E-03 - 40440 4.499E-03 - 40450 4.990E-03 - 40460 5.624E-03 - 40470 5.719E-03 - 40480 5.498E-03 - 40490 5.409E-03 - 40500 5.512E-03 - 40510 5.565E-03 - 40520 5.493E-03 - 40530 5.288E-03 - 40540 5.069E-03 - 40550 4.976E-03 - 40560 4.993E-03 - 40570 4.978E-03 - 40580 4.801E-03 - 40590 4.433E-03 - 40600 4.025E-03 - 40610 3.850E-03 - 40620 3.963E-03 - 40630 4.186E-03 - 40640 4.428E-03 - 40650 4.660E-03 - 40660 4.823E-03 - 40670 4.966E-03 - 40680 5.182E-03 - 40690 5.245E-03 - 40700 4.967E-03 - 40710 4.719E-03 - 40720 4.759E-03 - 40730 4.866E-03 - 40740 4.823E-03 - 40750 4.635E-03 - 40760 4.445E-03 - 40770 4.380E-03 - 40780 4.399E-03 - 40790 4.446E-03 - 40800 4.574E-03 - 40810 4.792E-03 - 40820 5.015E-03 - 40830 5.127E-03 - 40840 5.024E-03 - 40850 4.911E-03 - 40860 5.094E-03 - 40870 5.471E-03 - 40880 5.834E-03 - 40890 6.087E-03 - 40900 6.172E-03 - 40910 6.159E-03 - 40920 6.282E-03 - 40930 6.710E-03 - 40940 7.246E-03 - 40950 7.590E-03 - 40960 7.582E-03 - 40970 7.183E-03 - 40980 6.509E-03 - 40990 5.857E-03 - 41000 5.664E-03 - 41010 6.238E-03 - 41020 6.773E-03 - 41030 6.882E-03 - 41040 6.430E-03 - 41050 5.881E-03 - 41060 5.570E-03 - 41070 5.654E-03 - 41080 6.148E-03 - 41090 6.557E-03 - 41100 6.478E-03 - 41110 6.274E-03 - 41120 6.451E-03 - 41130 6.961E-03 - 41140 7.454E-03 - 41150 7.614E-03 - 41160 7.329E-03 - 41170 6.855E-03 - 41180 6.720E-03 - 41190 7.238E-03 - 41200 8.030E-03 - 41210 8.312E-03 - 41220 7.866E-03 - 41230 7.193E-03 - 41240 6.644E-03 - 41250 6.254E-03 - 41260 6.123E-03 - 41270 6.327E-03 - 41280 6.895E-03 - 41290 7.628E-03 - 41300 7.962E-03 - 41310 7.745E-03 - 41320 7.364E-03 - 41330 7.022E-03 - 41340 6.770E-03 - 41350 6.604E-03 - 41360 6.368E-03 - 41370 6.080E-03 - 41380 5.912E-03 - 41390 5.780E-03 - 41400 5.544E-03 - 41410 5.225E-03 - 41420 4.778E-03 - 41430 4.228E-03 - 41440 3.807E-03 - 41450 3.700E-03 - 41460 3.715E-03 - 41470 3.456E-03 - 41480 3.018E-03 - 41490 2.933E-03 - 41500 3.556E-03 - 41510 4.330E-03 - 41520 4.791E-03 - 41530 4.669E-03 - 41540 4.100E-03 - 41550 3.513E-03 - 41560 3.242E-03 - 41570 3.149E-03 - 41580 2.989E-03 - 41590 2.863E-03 - 41600 3.127E-03 - 41610 3.841E-03 - 41620 4.504E-03 - 41630 4.772E-03 - 41640 4.869E-03 - 41650 5.001E-03 - 41660 5.002E-03 - 41670 4.584E-03 - 41680 3.897E-03 - 41690 3.590E-03 - 41700 3.894E-03 - 41710 4.259E-03 - 41720 4.174E-03 - 41730 3.656E-03 - 41740 2.972E-03 - 41750 2.567E-03 - 41760 2.951E-03 - 41770 4.049E-03 - 41780 5.115E-03 - 41790 5.656E-03 - 41800 5.824E-03 - 41810 5.895E-03 - 41820 6.025E-03 - 41830 6.020E-03 - 41840 5.426E-03 - 41850 4.384E-03 - 41860 3.563E-03 - 41870 3.454E-03 - 41880 4.052E-03 - 41890 4.839E-03 - 41900 5.344E-03 - 41910 5.447E-03 - 41920 5.184E-03 - 41930 4.611E-03 - 41940 3.868E-03 - 41950 3.187E-03 - 41960 2.678E-03 - 41970 2.364E-03 - 41980 2.272E-03 - 41990 2.432E-03 - 42000 2.870E-03 - 42010 3.344E-03 - 42020 3.731E-03 - 42030 3.918E-03 - 42040 4.282E-03 - 42050 5.039E-03 - 42060 5.874E-03 - 42070 6.329E-03 - 42080 6.108E-03 - 42090 5.352E-03 - 42100 4.604E-03 - 42110 4.111E-03 - 42120 3.764E-03 - 42130 3.629E-03 - 42140 4.042E-03 - 42150 5.088E-03 - 42160 6.154E-03 - 42170 6.538E-03 - 42180 6.267E-03 - 42190 5.808E-03 - 42200 5.461E-03 - 42210 5.132E-03 - 42220 4.686E-03 - 42230 4.286E-03 - 42240 4.054E-03 - 42250 3.975E-03 - 42260 4.021E-03 - 42270 4.035E-03 - 42280 3.955E-03 - 42290 4.066E-03 - 42300 4.625E-03 - 42310 5.340E-03 - 42320 5.603E-03 - 42330 5.256E-03 - 42340 4.666E-03 - 42350 4.106E-03 - 42360 3.550E-03 - 42370 3.122E-03 - 42380 3.107E-03 - 42390 3.595E-03 - 42400 4.519E-03 - 42410 5.545E-03 - 42420 6.179E-03 - 42430 6.350E-03 - 42440 6.184E-03 - 42450 5.640E-03 - 42460 4.938E-03 - 42470 4.636E-03 - 42480 5.005E-03 - 42490 5.668E-03 - 42500 6.087E-03 - 42510 6.248E-03 - 42520 5.956E-03 - 42530 5.575E-03 - 42540 5.339E-03 - 42550 5.196E-03 - 42560 4.820E-03 - 42570 4.060E-03 - 42580 3.298E-03 - 42590 3.041E-03 - 42600 3.242E-03 - 42610 3.412E-03 - 42620 3.302E-03 - 42630 3.079E-03 - 42640 2.872E-03 - 42650 2.663E-03 - 42660 2.571E-03 - 42670 2.852E-03 - 42680 3.575E-03 - 42690 4.392E-03 - 42700 4.868E-03 - 42710 4.887E-03 - 42720 4.589E-03 - 42730 4.199E-03 - 42740 3.832E-03 - 42750 3.447E-03 - 42760 3.085E-03 - 42770 3.020E-03 - 42780 3.553E-03 - 42790 4.570E-03 - 42800 5.524E-03 - 42810 5.943E-03 - 42820 5.784E-03 - 42830 5.266E-03 - 42840 4.677E-03 - 42850 4.173E-03 - 42860 3.736E-03 - 42870 3.480E-03 - 42880 3.547E-03 - 42890 3.832E-03 - 42900 4.274E-03 - 42910 4.883E-03 - 42920 5.455E-03 - 42930 5.766E-03 - 42940 5.709E-03 - 42950 5.230E-03 - 42960 4.546E-03 - 42970 4.023E-03 - 42980 3.771E-03 - 42990 3.784E-03 - 43000 4.222E-03 - 43010 5.123E-03 - 43020 6.390E-03 - 43030 7.396E-03 - 43040 7.695E-03 - 43050 7.090E-03 - 43060 5.927E-03 - 43070 4.756E-03 - 43080 3.913E-03 - 43090 3.519E-03 - 43100 3.632E-03 - 43110 4.261E-03 - 43120 5.050E-03 - 43130 5.487E-03 - 43140 5.449E-03 - 43150 5.282E-03 - 43160 5.331E-03 - 43170 5.610E-03 - 43180 5.956E-03 - 43190 6.080E-03 - 43200 5.678E-03 - 43210 4.789E-03 - 43220 3.859E-03 - 43230 3.342E-03 - 43240 3.227E-03 - 43250 3.226E-03 - 43260 3.301E-03 - 43270 3.559E-03 - 43280 3.962E-03 - 43290 4.394E-03 - 43300 4.867E-03 - 43310 5.411E-03 - 43320 5.929E-03 - 43330 6.414E-03 - 43340 6.951E-03 - 43350 7.396E-03 - 43360 7.440E-03 - 43370 6.954E-03 - 43380 6.110E-03 - 43390 5.241E-03 - 43400 4.542E-03 - 43410 4.260E-03 - 43420 4.534E-03 - 43430 4.849E-03 - 43440 4.742E-03 - 43450 4.351E-03 - 43460 3.983E-03 - 43470 3.825E-03 - 43480 3.768E-03 - 43490 3.576E-03 - 43500 3.278E-03 - 43510 3.210E-03 - 43520 3.421E-03 - 43530 4.204E-03 - 43540 5.271E-03 - 43550 5.932E-03 - 43560 5.876E-03 - 43570 5.460E-03 - 43580 5.188E-03 - 43590 5.160E-03 - 43600 5.139E-03 - 43610 4.998E-03 - 43620 4.803E-03 - 43630 4.621E-03 - 43640 4.434E-03 - 43650 4.285E-03 - 43660 4.317E-03 - 43670 4.541E-03 - 43680 4.862E-03 - 43690 5.060E-03 - 43700 4.804E-03 - 43710 4.222E-03 - 43720 3.946E-03 - 43730 4.397E-03 - 43740 5.387E-03 - 43750 6.215E-03 - 43760 6.319E-03 - 43770 5.842E-03 - 43780 5.366E-03 - 43790 5.388E-03 - 43800 5.870E-03 - 43810 6.264E-03 - 43820 6.233E-03 - 43830 5.867E-03 - 43840 5.310E-03 - 43850 4.797E-03 - 43860 4.599E-03 - 43870 4.657E-03 - 43880 4.710E-03 - 43890 4.656E-03 - 43900 4.544E-03 - 43910 4.373E-03 - 43920 4.109E-03 - 43930 3.845E-03 - 43940 3.753E-03 - 43950 3.798E-03 - 43960 3.728E-03 - 43970 3.557E-03 - 43980 3.532E-03 - 43990 3.606E-03 - 44000 3.510E-03 - 44010 3.375E-03 - 44020 3.251E-03 - 44030 3.138E-03 - 44040 3.051E-03 - 44050 3.023E-03 - 44060 3.043E-03 - 44070 3.097E-03 - 44080 3.170E-03 - 44090 3.241E-03 - 44100 3.320E-03 - 44110 3.388E-03 - 44120 3.386E-03 - 44130 3.320E-03 - 44140 3.308E-03 - 44150 3.458E-03 - 44160 3.715E-03 - 44170 4.027E-03 - 44180 4.447E-03 - 44190 4.834E-03 - 44200 4.931E-03 - 44210 4.689E-03 - 44220 4.269E-03 - 44230 3.988E-03 - 44240 4.185E-03 - 44250 4.785E-03 - 44260 5.278E-03 - 44270 5.370E-03 - 44280 5.255E-03 - 44290 5.178E-03 - 44300 5.055E-03 - 44310 4.785E-03 - 44320 4.647E-03 - 44330 4.879E-03 - 44340 5.135E-03 - 44350 5.007E-03 - 44360 4.780E-03 - 44370 4.971E-03 - 44380 5.480E-03 - 44390 5.757E-03 - 44400 5.545E-03 - 44410 5.183E-03 - 44420 5.099E-03 - 44430 5.236E-03 - 44440 5.320E-03 - 44450 5.387E-03 - 44460 5.736E-03 - 44470 6.444E-03 - 44480 7.085E-03 - 44490 7.218E-03 - 44500 6.946E-03 - 44510 6.511E-03 - 44520 6.254E-03 - 44530 5.918E-03 - 44540 5.370E-03 - 44550 4.815E-03 - 44560 4.623E-03 - 44570 4.770E-03 - 44580 4.965E-03 - 44590 5.079E-03 - 44600 5.183E-03 - 44610 5.453E-03 - 44620 5.964E-03 - 44630 6.470E-03 - 44640 6.583E-03 - 44650 6.162E-03 - 44660 5.556E-03 - 44670 5.407E-03 - 44680 5.877E-03 - 44690 6.488E-03 - 44700 6.977E-03 - 44710 7.400E-03 - 44720 7.648E-03 - 44730 7.622E-03 - 44740 7.474E-03 - 44750 7.493E-03 - 44760 7.779E-03 - 44770 7.961E-03 - 44780 7.618E-03 - 44790 6.718E-03 - 44800 5.522E-03 - 44810 4.580E-03 - 44820 4.313E-03 - 44830 4.564E-03 - 44840 4.946E-03 - 44850 5.222E-03 - 44860 5.221E-03 - 44870 4.888E-03 - 44880 4.471E-03 - 44890 4.260E-03 - 44900 4.337E-03 - 44910 4.596E-03 - 44920 4.811E-03 - 44930 4.899E-03 - 44940 4.987E-03 - 44950 5.070E-03 - 44960 4.988E-03 - 44970 4.831E-03 - 44980 4.819E-03 - 44990 5.027E-03 - 45000 5.382E-03 - 45010 5.526E-03 - 45020 5.417E-03 - 45030 5.229E-03 - 45040 5.129E-03 - 45050 4.879E-03 - 45060 4.231E-03 - 45070 3.396E-03 - 45080 2.745E-03 - 45090 2.385E-03 - 45100 2.355E-03 - 45110 2.718E-03 - 45120 3.394E-03 - 45130 4.095E-03 - 45140 4.466E-03 - 45150 4.478E-03 - 45160 4.487E-03 - 45170 4.652E-03 - 45180 4.510E-03 - 45190 3.620E-03 - 45200 2.538E-03 - 45210 1.991E-03 - 45220 1.967E-03 - 45230 2.360E-03 - 45240 3.020E-03 - 45250 3.528E-03 - 45260 3.605E-03 - 45270 3.503E-03 - 45280 3.660E-03 - 45290 4.020E-03 - 45300 4.376E-03 - 45310 4.814E-03 - 45320 5.352E-03 - 45330 5.699E-03 - 45340 5.777E-03 - 45350 5.930E-03 - 45360 6.328E-03 - 45370 6.616E-03 - 45380 6.480E-03 - 45390 5.882E-03 - 45400 4.874E-03 - 45410 3.876E-03 - 45420 3.352E-03 - 45430 3.473E-03 - 45440 4.221E-03 - 45450 5.137E-03 - 45460 5.693E-03 - 45470 5.843E-03 - 45480 5.661E-03 - 45490 5.151E-03 - 45500 4.483E-03 - 45510 3.809E-03 - 45520 3.425E-03 - 45530 3.457E-03 - 45540 3.902E-03 - 45550 4.540E-03 - 45560 5.198E-03 - 45570 5.745E-03 - 45580 6.045E-03 - 45590 5.792E-03 - 45600 4.870E-03 - 45610 4.024E-03 - 45620 3.919E-03 - 45630 4.225E-03 - 45640 4.355E-03 - 45650 4.141E-03 - 45660 3.874E-03 - 45670 3.860E-03 - 45680 3.964E-03 - 45690 3.823E-03 - 45700 3.362E-03 - 45710 2.908E-03 - 45720 2.970E-03 - 45730 3.735E-03 - 45740 4.614E-03 - 45750 4.849E-03 - 45760 4.545E-03 - 45770 4.349E-03 - 45780 4.521E-03 - 45790 4.908E-03 - 45800 5.326E-03 - 45810 5.632E-03 - 45820 5.712E-03 - 45830 5.594E-03 - 45840 5.428E-03 - 45850 5.317E-03 - 45860 5.200E-03 - 45870 4.869E-03 - 45880 4.148E-03 - 45890 3.230E-03 - 45900 2.579E-03 - 45910 2.418E-03 - 45920 2.656E-03 - 45930 3.005E-03 - 45940 3.078E-03 - 45950 2.812E-03 - 45960 2.524E-03 - 45970 2.462E-03 - 45980 2.640E-03 - 45990 2.982E-03 - 46000 3.361E-03 - 46010 3.753E-03 - 46020 3.850E-03 - 46030 3.782E-03 - 46040 3.659E-03 - 46050 3.554E-03 - 46060 3.374E-03 - 46070 3.071E-03 - 46080 2.792E-03 - 46090 2.747E-03 - 46100 2.918E-03 - 46110 2.923E-03 - 46120 2.525E-03 - 46130 2.052E-03 - 46140 1.934E-03 - 46150 2.216E-03 - 46160 2.714E-03 - 46170 3.233E-03 - 46180 3.577E-03 - 46190 3.700E-03 - 46200 3.775E-03 - 46210 3.899E-03 - 46220 3.964E-03 - 46230 3.973E-03 - 46240 4.064E-03 - 46250 4.218E-03 - 46260 4.279E-03 - 46270 4.029E-03 - 46280 3.409E-03 - 46290 2.756E-03 - 46300 2.374E-03 - 46310 2.203E-03 - 46320 2.150E-03 - 46330 2.245E-03 - 46340 2.504E-03 - 46350 2.888E-03 - 46360 3.284E-03 - 46370 3.597E-03 - 46380 3.844E-03 - 46390 4.110E-03 - 46400 4.429E-03 - 46410 4.680E-03 - 46420 4.687E-03 - 46430 4.402E-03 - 46440 3.952E-03 - 46450 3.542E-03 - 46460 3.270E-03 - 46470 3.141E-03 - 46480 3.254E-03 - 46490 3.682E-03 - 46500 3.985E-03 - 46510 4.244E-03 - 46520 4.121E-03 - 46530 3.845E-03 - 46540 3.548E-03 - 46550 3.271E-03 - 46560 3.108E-03 - 46570 3.085E-03 - 46580 3.170E-03 - 46590 3.386E-03 - 46600 3.747E-03 - 46610 4.147E-03 - 46620 4.467E-03 - 46630 4.650E-03 - 46640 4.649E-03 - 46650 4.546E-03 - 46660 4.551E-03 - 46670 4.740E-03 - 46680 4.857E-03 - 46690 4.534E-03 - 46700 3.799E-03 - 46710 3.017E-03 - 46720 2.430E-03 - 46730 2.196E-03 - 46740 2.415E-03 - 46750 2.943E-03 - 46760 3.513E-03 - 46770 3.884E-03 - 46780 3.846E-03 - 46790 3.433E-03 - 46800 2.961E-03 - 46810 2.611E-03 - 46820 2.398E-03 - 46830 2.410E-03 - 46840 2.633E-03 - 46850 2.838E-03 - 46860 2.848E-03 - 46870 2.756E-03 - 46880 2.739E-03 - 46890 2.779E-03 - 46900 2.746E-03 - 46910 2.575E-03 - 46920 2.401E-03 - 46930 2.456E-03 - 46940 2.789E-03 - 46950 3.203E-03 - 46960 3.459E-03 - 46970 3.509E-03 - 46980 3.474E-03 - 46990 3.455E-03 - 47000 3.337E-03 - 47010 3.104E-03 - 47020 2.668E-03 - 47030 2.106E-03 - 47040 1.538E-03 - 47050 1.196E-03 - 47060 1.191E-03 - 47070 1.403E-03 - 47080 1.768E-03 - 47090 2.255E-03 - 47100 2.722E-03 - 47110 3.106E-03 - 47120 3.476E-03 - 47130 3.939E-03 - 47140 4.469E-03 - 47150 4.737E-03 - 47160 4.488E-03 - 47170 3.948E-03 - 47180 3.518E-03 - 47190 3.423E-03 - 47200 3.703E-03 - 47210 4.126E-03 - 47220 4.299E-03 - 47230 4.077E-03 - 47240 3.526E-03 - 47250 2.824E-03 - 47260 2.312E-03 - 47270 2.193E-03 - 47280 2.350E-03 - 47290 2.581E-03 - 47300 2.802E-03 - 47310 3.102E-03 - 47320 3.490E-03 - 47330 3.708E-03 - 47340 3.520E-03 - 47350 2.959E-03 - 47360 2.305E-03 - 47370 1.871E-03 - 47380 1.710E-03 - 47390 1.703E-03 - 47400 1.858E-03 - 47410 2.241E-03 - 47420 2.716E-03 - 47430 3.027E-03 - 47440 3.129E-03 - 47450 3.180E-03 - 47460 3.321E-03 - 47470 3.471E-03 - 47480 3.349E-03 - 47490 2.881E-03 - 47500 2.276E-03 - 47510 1.992E-03 - 47520 1.932E-03 - 47530 2.332E-03 - 47540 2.892E-03 - 47550 3.268E-03 - 47560 3.300E-03 - 47570 3.002E-03 - 47580 2.559E-03 - 47590 2.177E-03 - 47600 1.953E-03 - 47610 1.934E-03 - 47620 2.108E-03 - 47630 2.354E-03 - 47640 2.544E-03 - 47650 2.598E-03 - 47660 2.519E-03 - 47670 2.386E-03 - 47680 2.266E-03 - 47690 2.159E-03 - 47700 2.045E-03 - 47710 1.910E-03 - 47720 1.794E-03 - 47730 1.818E-03 - 47740 2.039E-03 - 47750 2.277E-03 - 47760 2.264E-03 - 47770 2.021E-03 - 47780 1.820E-03 - 47790 1.757E-03 - 47800 1.699E-03 - 47810 1.598E-03 - 47820 1.520E-03 - 47830 1.513E-03 - 47840 1.586E-03 - 47850 1.709E-03 - 47860 1.794E-03 - 47870 1.763E-03 - 47880 1.656E-03 - 47890 1.581E-03 - 47900 1.575E-03 - 47910 1.591E-03 - 47920 1.557E-03 - 47930 1.449E-03 - 47940 1.313E-03 - 47950 1.233E-03 - 47960 1.230E-03 - 47970 1.256E-03 - 47980 1.266E-03 - 47990 1.242E-03 - 48000 1.210E-03 - 48010 1.278E-03 - 48020 1.293E-03 - 48030 1.314E-03 - 48040 1.344E-03 - 48050 1.381E-03 - 48060 1.402E-03 - 48070 1.382E-03 - 48080 1.337E-03 - 48090 1.313E-03 - 48100 1.331E-03 - 48110 1.377E-03 - 48120 1.414E-03 - 48130 1.420E-03 - 48140 1.406E-03 - 48150 1.383E-03 - 48160 1.357E-03 - 48170 1.332E-03 - 48180 1.313E-03 - 48190 1.304E-03 - 48200 1.292E-03 - 48210 1.269E-03 - 48220 1.243E-03 - 48230 1.222E-03 - 48240 1.208E-03 - 48250 1.212E-03 - 48260 1.219E-03 - 48270 1.204E-03 - 48280 1.173E-03 - 48290 1.148E-03 - 48300 1.138E-03 - 48310 1.139E-03 - 48320 1.145E-03 - 48330 1.160E-03 - 48340 1.182E-03 - 48350 1.185E-03 - 48360 1.154E-03 - 48370 1.111E-03 - 48380 1.090E-03 - 48390 1.100E-03 - 48400 1.125E-03 - 48410 1.141E-03 - 48420 1.133E-03 - 48430 1.110E-03 - 48440 1.078E-03 - 48450 1.031E-03 - 48460 9.849E-04 - 48470 9.579E-04 - 48480 9.598E-04 - 48490 1.007E-03 - 48500 1.045E-03 - 48510 1.099E-03 - 48520 1.106E-03 - 48530 1.088E-03 - 48540 1.048E-03 - 48550 9.870E-04 - 48560 9.550E-04 - 48570 9.830E-04 - 48580 1.033E-03 - 48590 1.059E-03 - 48600 1.039E-03 - 48610 9.859E-04 - 48620 9.359E-04 - 48630 9.289E-04 - 48640 9.668E-04 - 48650 1.022E-03 - 48660 1.062E-03 - 48670 1.081E-03 - 48680 1.090E-03 - 48690 1.084E-03 - 48700 1.065E-03 - 48710 1.049E-03 - 48720 1.039E-03 - 48730 1.028E-03 - 48740 1.020E-03 - 48750 1.012E-03 - 48760 1.002E-03 - 48770 9.956E-04 - 48780 9.975E-04 - 48790 9.875E-04 - 48800 9.625E-04 - 48810 9.535E-04 - 48820 9.755E-04 - 48830 1.016E-03 - 48840 1.057E-03 - 48850 1.078E-03 - 48860 1.055E-03 - 48870 1.003E-03 - 48880 9.543E-04 - 48890 9.303E-04 - 48900 9.383E-04 - 48910 9.703E-04 - 48920 1.014E-03 - 48930 1.051E-03 - 48940 1.062E-03 - 48950 1.034E-03 - 48960 9.902E-04 - 48970 9.491E-04 - 48980 8.968E-04 - 48990 8.349E-04 - 49000 8.169E-04 - 49010 8.197E-04 - 49020 8.594E-04 - 49030 9.099E-04 - 49040 9.461E-04 - 49050 9.651E-04 - 49060 9.730E-04 - 49070 9.750E-04 - 49080 9.700E-04 - 49090 9.400E-04 - 49100 8.862E-04 - 49110 8.329E-04 - 49120 7.885E-04 - 49130 7.568E-04 - 49140 7.523E-04 - 49150 7.803E-04 - 49160 8.316E-04 - 49170 8.896E-04 - 49180 9.368E-04 - 49190 9.618E-04 - 49200 9.638E-04 - 49210 9.468E-04 - 49220 9.155E-04 - 49230 8.760E-04 - 49240 8.487E-04 - 49250 8.496E-04 - 49260 8.646E-04 - 49270 8.695E-04 - 49280 8.610E-04 - 49290 8.424E-04 - 49300 7.996E-04 - 49310 7.157E-04 - 49320 6.176E-04 - 49330 5.662E-04 - 49340 5.922E-04 - 49350 6.716E-04 - 49360 7.456E-04 - 49370 7.901E-04 - 49380 8.243E-04 - 49390 8.341E-04 - 49400 8.039E-04 - 49410 7.638E-04 - 49420 7.413E-04 - 49430 7.340E-04 - 49440 7.362E-04 - 49450 7.532E-04 - 49460 7.823E-04 - 49470 8.071E-04 - 49480 8.185E-04 - 49490 8.239E-04 - 49500 8.369E-04 - 49510 8.779E-04 - 49520 8.911E-04 - 49530 8.782E-04 - 49540 8.487E-04 - 49550 8.202E-04 - 49560 7.972E-04 - 49570 7.781E-04 - 49580 7.655E-04 - 49590 7.617E-04 - 49600 7.643E-04 - 49610 7.704E-04 - 49620 7.810E-04 - 49630 7.985E-04 - 49640 8.188E-04 - 49650 8.243E-04 - 49660 8.031E-04 - 49670 7.687E-04 - 49680 7.365E-04 - 49690 7.086E-04 - 49700 6.980E-04 - 49710 7.225E-04 - 49720 7.628E-04 - 49730 7.764E-04 - 49740 7.606E-04 - 49750 7.446E-04 - 49760 7.355E-04 - 49770 7.292E-04 - 49780 7.282E-04 - 49790 7.313E-04 - 49800 7.403E-04 - 49810 7.592E-04 - 49820 7.780E-04 - 49830 7.835E-04 - 49840 7.685E-04 - 49850 7.380E-04 - 49860 7.117E-04 - 49870 7.053E-04 - 49880 7.165E-04 - 49890 7.292E-04 - 49900 7.371E-04 - 49910 7.435E-04 - 49920 7.396E-04 - 49930 7.245E-04 - 49940 7.049E-04 - 49950 6.850E-04 - 49960 6.753E-04 - 49970 6.781E-04 - 49980 6.801E-04 - 49990 6.758E-04 - 50000 6.839E-04 - 50010 6.945E-04 - 50020 6.943E-04 - 50030 6.742E-04 - 50040 6.544E-04 - 50050 6.560E-04 - 50060 6.752E-04 - 50070 6.923E-04 - 50080 6.966E-04 - 50090 6.950E-04 - 50100 6.933E-04 - 50110 6.916E-04 - 50120 6.990E-04 - 50130 7.227E-04 - 50140 7.476E-04 - 50150 7.512E-04 - 50160 7.331E-04 - 50170 7.115E-04 - 50180 6.929E-04 - 50190 6.630E-04 - 50200 6.222E-04 - 50210 5.959E-04 - 50220 5.939E-04 - 50230 6.003E-04 - 50240 5.977E-04 - 50250 5.814E-04 - 50260 5.605E-04 - 50270 5.475E-04 - 50280 5.483E-04 - 50290 5.614E-04 - 50300 5.729E-04 - 50310 5.668E-04 - 50320 5.508E-04 - 50330 5.443E-04 - 50340 5.509E-04 - 50350 5.718E-04 - 50360 6.073E-04 - 50370 6.354E-04 - 50380 6.371E-04 - 50390 6.245E-04 - 50400 6.151E-04 - 50410 6.095E-04 - 50420 6.070E-04 - 50430 6.248E-04 - 50440 6.616E-04 - 50450 6.814E-04 - 50460 6.708E-04 - 50470 6.462E-04 - 50480 6.210E-04 - 50490 6.042E-04 - 50500 5.725E-04 - 50510 5.735E-04 - 50520 5.738E-04 - 50530 5.787E-04 - 50540 5.900E-04 - 50550 5.922E-04 - 50560 5.769E-04 - 50570 5.622E-04 - 50580 5.656E-04 - 50590 5.785E-04 - 50600 5.863E-04 - 50610 5.859E-04 - 50620 5.806E-04 - 50630 5.754E-04 - 50640 5.733E-04 - 50650 5.754E-04 - 50660 5.846E-04 - 50670 5.969E-04 - 50680 6.010E-04 - 50690 5.959E-04 - 50700 5.922E-04 - 50710 5.961E-04 - 50720 5.990E-04 - 50730 5.941E-04 - 50740 5.972E-04 - 50750 6.180E-04 - 50760 6.411E-04 - 50770 6.547E-04 - 50780 6.604E-04 - 50790 6.595E-04 - 50800 6.540E-04 - 50810 6.491E-04 - 50820 6.469E-04 - 50830 6.454E-04 - 50840 6.426E-04 - 50850 6.385E-04 - 50860 6.337E-04 - 50870 6.265E-04 - 50880 6.161E-04 - 50890 5.984E-04 - 50900 5.684E-04 - 50910 5.354E-04 - 50920 5.144E-04 - 50930 5.068E-04 - 50940 5.034E-04 - 50950 4.987E-04 - 50960 4.921E-04 - 50970 4.863E-04 - 50980 4.903E-04 - 50990 5.090E-04 - 51000 5.315E-04 - 51010 5.490E-04 - 51020 5.621E-04 - 51030 5.665E-04 - 51040 5.585E-04 - 51050 5.392E-04 - 51060 5.166E-04 - 51070 5.077E-04 - 51080 5.205E-04 - 51090 5.374E-04 - 51100 5.365E-04 - 51110 5.200E-04 - 51120 5.030E-04 - 51130 4.965E-04 - 51140 5.041E-04 - 51150 5.225E-04 - 51160 5.409E-04 - 51170 5.446E-04 - 51180 5.229E-04 - 51190 4.861E-04 - 51200 4.563E-04 - 51210 4.416E-04 - 51220 4.444E-04 - 51230 4.611E-04 - 51240 4.800E-04 - 51250 4.942E-04 - 51260 5.010E-04 - 51270 5.080E-04 - 51280 5.287E-04 - 51290 5.569E-04 - 51300 5.749E-04 - 51310 5.812E-04 - 51320 5.834E-04 - 51330 5.740E-04 - 51340 5.427E-04 - 51350 5.040E-04 - 51360 4.815E-04 - 51370 4.780E-04 - 51380 4.858E-04 - 51390 4.994E-04 - 51400 5.086E-04 - 51410 5.077E-04 - 51420 5.082E-04 - 51430 5.189E-04 - 51440 5.368E-04 - 51450 5.544E-04 - 51460 5.611E-04 - 51470 5.570E-04 - 51480 5.522E-04 - 51490 5.415E-04 - 51500 5.491E-04 - 51510 5.120E-04 - 51520 4.873E-04 - 51530 4.776E-04 - 51540 4.740E-04 - 51550 4.700E-04 - 51560 4.605E-04 - 51570 4.408E-04 - 51580 4.112E-04 - 51590 3.794E-04 - 51600 3.492E-04 - 51610 3.138E-04 - 51620 2.767E-04 - 51630 2.579E-04 - 51640 2.611E-04 - 51650 2.675E-04 - 51660 2.736E-04 - 51670 2.890E-04 - 51680 3.071E-04 - 51690 3.129E-04 - 51700 3.106E-04 - 51710 3.103E-04 - 51720 3.063E-04 - 51730 2.904E-04 - 51740 2.741E-04 - 51750 2.703E-04 - 51760 2.733E-04 - 51770 2.775E-04 - 51780 2.928E-04 - 51790 3.212E-04 - 51800 3.532E-04 - 51810 3.830E-04 - 51820 4.074E-04 - 51830 4.252E-04 - 51840 4.359E-04 - 51850 4.374E-04 - 51860 4.313E-04 - 51870 4.236E-04 - 51880 4.180E-04 - 51890 4.172E-04 - 51900 4.241E-04 - 51910 4.318E-04 - 51920 4.297E-04 - 51930 4.202E-04 - 51940 4.159E-04 - 51950 4.186E-04 - 51960 4.245E-04 - 51970 4.344E-04 - 51980 4.433E-04 - 51990 4.426E-04 - 52000 3.995E-04 - 52010 4.024E-04 - 52020 4.173E-04 - 52030 4.322E-04 - 52040 4.348E-04 - 52050 4.252E-04 - 52060 4.114E-04 - 52070 3.986E-04 - 52080 3.867E-04 - 52090 3.753E-04 - 52100 3.650E-04 - 52110 3.580E-04 - 52120 3.563E-04 - 52130 3.601E-04 - 52140 3.687E-04 - 52150 3.799E-04 - 52160 3.882E-04 - 52170 3.929E-04 - 52180 4.024E-04 - 52190 4.134E-04 - 52200 4.102E-04 - 52210 3.942E-04 - 52220 3.778E-04 - 52230 3.654E-04 - 52240 3.576E-04 - 52250 3.526E-04 - 52260 3.485E-04 - 52270 3.477E-04 - 52280 3.501E-04 - 52290 3.484E-04 - 52300 3.391E-04 - 52310 3.292E-04 - 52320 3.240E-04 - 52330 3.201E-04 - 52340 3.242E-04 - 52350 3.483E-04 - 52360 3.779E-04 - 52370 3.914E-04 - 52380 3.886E-04 - 52390 3.770E-04 - 52400 3.614E-04 - 52410 3.488E-04 - 52420 3.428E-04 - 52430 3.387E-04 - 52440 3.317E-04 - 52450 3.236E-04 - 52460 3.197E-04 - 52470 3.237E-04 - 52480 3.306E-04 - 52490 3.346E-04 - 52500 3.396E-04 - 52510 3.640E-04 - 52520 3.640E-04 - 52530 3.538E-04 - 52540 3.404E-04 - 52550 3.306E-04 - 52560 3.211E-04 - 52570 3.078E-04 - 52580 2.975E-04 - 52590 2.999E-04 - 52600 3.124E-04 - 52610 3.224E-04 - 52620 3.217E-04 - 52630 3.102E-04 - 52640 2.935E-04 - 52650 2.800E-04 - 52660 2.757E-04 - 52670 2.801E-04 - 52680 2.901E-04 - 52690 3.052E-04 - 52700 3.230E-04 - 52710 3.363E-04 - 52720 3.405E-04 - 52730 3.393E-04 - 52740 3.386E-04 - 52750 3.424E-04 - 52760 3.513E-04 - 52770 3.557E-04 - 52780 3.485E-04 - 52790 3.361E-04 - 52800 3.230E-04 - 52810 3.209E-04 - 52820 3.457E-04 - 52830 3.774E-04 - 52840 3.871E-04 - 52850 3.774E-04 - 52860 3.608E-04 - 52870 3.436E-04 - 52880 3.308E-04 - 52890 3.256E-04 - 52900 3.268E-04 - 52910 3.297E-04 - 52920 3.285E-04 - 52930 3.198E-04 - 52940 3.079E-04 - 52950 3.013E-04 - 52960 3.026E-04 - 52970 3.085E-04 - 52980 3.124E-04 - 52990 3.111E-04 - 53000 3.074E-04 - 53010 3.108E-04 - 53020 3.115E-04 - 53030 3.098E-04 - 53040 3.071E-04 - 53050 3.098E-04 - 53060 3.173E-04 - 53070 3.202E-04 - 53080 3.190E-04 - 53090 3.196E-04 - 53100 3.161E-04 - 53110 2.998E-04 - 53120 2.773E-04 - 53130 2.625E-04 - 53140 2.585E-04 - 53150 2.592E-04 - 53160 2.607E-04 - 53170 2.625E-04 - 53180 2.634E-04 - 53190 2.636E-04 - 53200 2.650E-04 - 53210 2.683E-04 - 53220 2.721E-04 - 53230 2.762E-04 - 53240 2.799E-04 - 53250 2.817E-04 - 53260 2.817E-04 - 53270 2.819E-04 - 53280 2.827E-04 - 53290 2.842E-04 - 53300 2.849E-04 - 53310 2.835E-04 - 53320 2.835E-04 - 53330 2.883E-04 - 53340 2.941E-04 - 53350 2.946E-04 - 53360 2.887E-04 - 53370 2.811E-04 - 53380 2.780E-04 - 53390 2.826E-04 - 53400 2.924E-04 - 53410 3.029E-04 - 53420 3.102E-04 - 53430 3.101E-04 - 53440 3.026E-04 - 53450 2.957E-04 - 53460 2.943E-04 - 53470 2.941E-04 - 53480 2.936E-04 - 53490 2.939E-04 - 53500 2.853E-04 - 53510 2.861E-04 - 53520 2.872E-04 - 53530 2.836E-04 - 53540 2.732E-04 - 53550 2.613E-04 - 53560 2.495E-04 - 53570 2.334E-04 - 53580 2.159E-04 - 53590 2.061E-04 - 53600 2.053E-04 - 53610 2.074E-04 - 53620 2.107E-04 - 53630 2.161E-04 - 53640 2.212E-04 - 53650 2.265E-04 - 53660 2.320E-04 - 53670 2.327E-04 - 53680 2.269E-04 - 53690 2.194E-04 - 53700 2.141E-04 - 53710 2.099E-04 - 53720 2.068E-04 - 53730 2.058E-04 - 53740 2.053E-04 - 53750 2.020E-04 - 53760 1.971E-04 - 53770 1.950E-04 - 53780 1.975E-04 - 53790 2.009E-04 - 53800 2.023E-04 - 53810 2.018E-04 - 53820 2.020E-04 - 53830 2.064E-04 - 53840 2.173E-04 - 53850 2.313E-04 - 53860 2.405E-04 - 53870 2.419E-04 - 53880 2.415E-04 - 53890 2.445E-04 - 53900 2.472E-04 - 53910 2.442E-04 - 53920 2.323E-04 - 53930 2.114E-04 - 53940 1.900E-04 - 53950 1.737E-04 - 53960 1.601E-04 - 53970 1.500E-04 - 53980 1.456E-04 - 53990 1.429E-04 - 54000 1.385E-04 - 54010 1.433E-04 - 54020 1.451E-04 - 54030 1.628E-04 - 54040 1.888E-04 - 54050 2.025E-04 - 54060 1.951E-04 - 54070 1.753E-04 - 54080 1.546E-04 - 54090 1.387E-04 - 54100 1.291E-04 - 54110 1.285E-04 - 54120 1.383E-04 - 54130 1.524E-04 - 54140 1.626E-04 - 54150 1.656E-04 - 54160 1.649E-04 - 54170 1.662E-04 - 54180 1.731E-04 - 54190 1.836E-04 - 54200 1.913E-04 - 54210 1.922E-04 - 54220 1.907E-04 - 54230 1.920E-04 - 54240 1.946E-04 - 54250 1.943E-04 - 54260 1.882E-04 - 54270 1.767E-04 - 54280 1.631E-04 - 54290 1.539E-04 - 54300 1.563E-04 - 54310 1.696E-04 - 54320 1.851E-04 - 54330 1.988E-04 - 54340 2.149E-04 - 54350 2.308E-04 - 54360 2.366E-04 - 54370 2.304E-04 - 54380 2.209E-04 - 54390 2.159E-04 - 54400 2.150E-04 - 54410 2.135E-04 - 54420 2.086E-04 - 54430 2.026E-04 - 54440 2.011E-04 - 54450 2.070E-04 - 54460 2.168E-04 - 54470 2.251E-04 - 54480 2.292E-04 - 54490 2.288E-04 - 54500 2.236E-04 - 54510 2.252E-04 - 54520 2.170E-04 - 54530 2.127E-04 - 54540 2.133E-04 - 54550 2.161E-04 - 54560 2.166E-04 - 54570 2.133E-04 - 54580 2.079E-04 - 54590 2.018E-04 - 54600 1.962E-04 - 54610 1.930E-04 - 54620 1.931E-04 - 54630 1.963E-04 - 54640 2.007E-04 - 54650 2.025E-04 - 54660 1.997E-04 - 54670 1.938E-04 - 54680 1.879E-04 - 54690 1.850E-04 - 54700 1.863E-04 - 54710 1.905E-04 - 54720 1.939E-04 - 54730 1.947E-04 - 54740 1.950E-04 - 54750 1.983E-04 - 54760 2.056E-04 - 54770 2.149E-04 - 54780 2.241E-04 - 54790 2.323E-04 - 54800 2.390E-04 - 54810 2.410E-04 - 54820 2.370E-04 - 54830 2.292E-04 - 54840 2.193E-04 - 54850 2.086E-04 - 54860 2.010E-04 - 54870 1.986E-04 - 54880 1.974E-04 - 54890 1.921E-04 - 54900 1.820E-04 - 54910 1.728E-04 - 54920 1.708E-04 - 54930 1.777E-04 - 54940 1.879E-04 - 54950 1.937E-04 - 54960 1.969E-04 - 54970 2.073E-04 - 54980 2.364E-04 - 54990 2.967E-04 - 55000 3.792E-04 - 55010 4.540E-04 - 55020 4.565E-04 - 55030 4.050E-04 - 55040 3.243E-04 - 55050 2.442E-04 - 55060 1.895E-04 - 55070 1.677E-04 - 55080 1.647E-04 - 55090 1.622E-04 - 55100 1.565E-04 - 55110 1.539E-04 - 55120 1.571E-04 - 55130 1.631E-04 - 55140 1.687E-04 - 55150 1.723E-04 - 55160 1.730E-04 - 55170 1.721E-04 - 55180 1.724E-04 - 55190 1.751E-04 - 55200 1.791E-04 - 55210 1.823E-04 - 55220 1.812E-04 - 55230 1.749E-04 - 55240 1.698E-04 - 55250 1.768E-04 - 55260 2.007E-04 - 55270 2.346E-04 - 55280 2.663E-04 - 55290 2.831E-04 - 55300 2.754E-04 - 55310 2.419E-04 - 55320 1.980E-04 - 55330 1.677E-04 - 55340 1.606E-04 - 55350 1.672E-04 - 55360 1.750E-04 - 55370 1.791E-04 - 55380 1.798E-04 - 55390 1.781E-04 - 55400 1.743E-04 - 55410 1.698E-04 - 55420 1.668E-04 - 55430 1.664E-04 - 55440 1.676E-04 - 55450 1.678E-04 - 55460 1.672E-04 - 55470 1.678E-04 - 55480 1.691E-04 - 55490 1.690E-04 - 55500 1.680E-04 - 55510 1.832E-04 - 55520 1.808E-04 - 55530 1.773E-04 - 55540 1.738E-04 - 55550 1.710E-04 - 55560 1.691E-04 - 55570 1.678E-04 - 55580 1.668E-04 - 55590 1.659E-04 - 55600 1.652E-04 - 55610 1.643E-04 - 55620 1.628E-04 - 55630 1.603E-04 - 55640 1.570E-04 - 55650 1.544E-04 - 55660 1.543E-04 - 55670 1.566E-04 - 55680 1.581E-04 - 55690 1.560E-04 - 55700 1.511E-04 - 55710 1.459E-04 - 55720 1.416E-04 - 55730 1.382E-04 - 55740 1.363E-04 - 55750 1.368E-04 - 55760 1.401E-04 - 55770 1.449E-04 - 55780 1.509E-04 - 55790 1.598E-04 - 55800 1.708E-04 - 55810 1.794E-04 - 55820 1.834E-04 - 55830 1.844E-04 - 55840 1.831E-04 - 55850 1.805E-04 - 55860 1.791E-04 - 55870 1.802E-04 - 55880 1.805E-04 - 55890 1.765E-04 - 55900 1.696E-04 - 55910 1.642E-04 - 55920 1.615E-04 - 55930 1.605E-04 - 55940 1.598E-04 - 55950 1.594E-04 - 55960 1.601E-04 - 55970 1.626E-04 - 55980 1.655E-04 - 55990 1.658E-04 - 56000 1.631E-04 - 56010 1.589E-04 - 56020 1.576E-04 - 56030 1.581E-04 - 56040 1.588E-04 - 56050 1.590E-04 - 56060 1.584E-04 - 56070 1.561E-04 - 56080 1.515E-04 - 56090 1.458E-04 - 56100 1.416E-04 - 56110 1.419E-04 - 56120 1.476E-04 - 56130 1.564E-04 - 56140 1.641E-04 - 56150 1.677E-04 - 56160 1.667E-04 - 56170 1.629E-04 - 56180 1.603E-04 - 56190 1.608E-04 - 56200 1.606E-04 - 56210 1.558E-04 - 56220 1.468E-04 - 56230 1.381E-04 - 56240 1.324E-04 - 56250 1.293E-04 - 56260 1.277E-04 - 56270 1.267E-04 - 56280 1.243E-04 - 56290 1.199E-04 - 56300 1.147E-04 - 56310 1.109E-04 - 56320 1.110E-04 - 56330 1.168E-04 - 56340 1.282E-04 - 56350 1.426E-04 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/wbins_77.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/wbins_77.dat deleted file mode 100644 index 4aeab358..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/add_X/wbins_77.dat +++ /dev/null @@ -1,12 +0,0 @@ - 77.0 - 1774.9 1783.0 1792.6 1803.8 1816.5 1830.8 1846.5 1863.7 - 1882.4 1902.5 1924.2 1947.3 1972.0 1985.0 2000.0 2025.0 - 2040.00 2065.00 2095.00 2125.00 2155.00 2185.00 2215.00 2250.00 - 2290.00 2330.00 2375.00 2425.00 2480.00 2540.00 2600.00 2655.00 - 2705.00 2755.00 2800.00 2835.00 2865.00 2890.00 2910.00 2930.00 - 2950.00 2967.50 2982.50 2995.50 3005.00 3015.00 3025.00 3035.00 - 3045.00 3055.00 3065.00 3074.50 3085.00 3094.50 3105.00 3115.00 - 3124.50 3135.00 3145.00 3157.00 3172.00 3187.00 3203.00 3225.00 - 3269.50 3349.50 3450.00 3550.50 3650.30 3750.00 3899.50 4124.50 - 4375.50 4851.00 5601.00 6351.00 7602.00 8500.00 -THE BOUNDARIES OF EACH BIN diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/atmos_std.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/atmos_std.dat deleted file mode 100644 index 9ca040fb..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/atmos_std.dat +++ /dev/null @@ -1,1775 +0,0 @@ -atmos_std.dat: new mergd O3(Labow,2/11/02) & T(Nagatani,12/13/91) == Fast-JX 5.3 - 18 12 latitudes x months -A-85LAT 1M -T1 256.4 251.1 241.9 233.2 228.0 227.8 230.3 232.3 233.4 234.0 234.4 -T2 235.0 236.3 238.7 242.0 245.4 248.9 252.4 256.7 263.2 271.5 279.5 -T3 285.5 289.2 290.2 288.4 283.8 276.0 269.5 263.3 257.1 249.8 242.5 -T4 235.0 227.0 218.2 209.1 199.9 190.7 170.7 170.4 -Z1 0.027 0.027 0.019 0.027 0.060 0.241 0.304 0.485 0.987 1.753 2.494 -Z2 3.082 3.159 3.262 3.592 4.121 4.641 5.082 5.350 5.380 5.079 4.229 -Z3 3.367 2.600 2.043 1.706 1.413 1.158 0.948 0.757 0.601 -A-75LAT 1M -T1 262.1 256.4 245.8 235.6 228.6 226.8 228.6 230.6 231.9 232.6 233.2 -T2 234.0 235.4 237.7 240.8 244.1 247.5 251.2 255.8 262.0 269.5 276.8 -T3 282.3 285.7 286.5 284.6 280.0 272.7 266.5 260.6 254.6 247.8 240.6 -T4 232.9 224.9 216.4 207.5 198.6 189.8 180.7 169.0 -Z1 0.017 0.019 0.026 0.036 0.072 0.230 0.302 0.476 0.921 1.729 2.486 -Z2 3.163 3.668 3.838 3.993 4.401 4.911 5.304 5.506 5.465 5.103 4.280 -Z3 3.456 2.713 2.139 1.775 1.466 1.203 0.987 0.791 0.632 -A-65LAT 1M -T1 268.5 262.1 250.2 238.5 230.1 227.0 227.6 229.0 229.8 230.2 230.7 -T2 231.6 233.2 235.5 238.4 241.6 245.2 249.4 254.5 260.3 266.7 272.6 -T3 277.1 279.8 280.5 278.7 274.9 268.7 262.5 256.4 250.3 241.7 235.9 -T4 228.1 220.4 212.2 204.0 195.8 187.5 179.8 166.2 -Z1 0.013 0.015 0.022 0.031 0.061 0.203 0.282 0.428 0.855 1.569 2.392 -Z2 3.134 3.819 4.308 4.801 5.268 5.591 5.779 5.747 5.420 4.690 3.852 -Z3 3.149 2.643 2.287 2.013 1.767 1.522 1.278 1.042 0.852 -A-55LAT 1M -T1 273.6 267.0 254.6 242.0 231.9 226.2 224.8 224.9 225.2 225.6 226.5 -T2 227.9 229.8 232.4 235.3 238.5 242.2 247.0 252.4 257.9 263.3 268.2 -T3 271.9 274.0 274.4 272.8 269.5 264.2 258.0 251.7 245.4 236.3 230.4 -T4 222.5 214.8 207.6 200.5 193.4 186.3 179.1 174.7 -Z1 0.012 0.020 0.030 0.037 0.052 0.124 0.224 0.315 0.586 1.199 2.099 -Z2 3.113 3.764 4.773 5.833 6.470 6.739 6.782 6.622 6.124 5.256 4.282 -Z3 3.465 2.868 2.448 2.122 1.833 1.560 1.323 1.108 0.924 -A-45LAT 1M -T1 280.2 273.5 260.8 247.3 234.7 225.3 220.4 218.3 217.7 218.3 220.1 -T2 222.5 225.3 228.4 231.6 235.1 239.1 244.1 249.7 255.2 260.4 265.0 -T3 268.3 270.2 270.4 268.7 265.4 260.1 253.9 247.7 241.5 232.3 226.6 -T4 219.0 211.6 205.6 199.9 194.2 188.7 183.2 179.2 -Z1 0.018 0.023 0.033 0.039 0.052 0.090 0.161 0.224 0.417 0.908 1.741 -Z2 2.815 3.766 5.286 6.691 7.531 7.847 7.745 7.414 6.767 5.760 4.699 -Z3 3.815 3.163 2.684 2.325 1.993 1.693 1.428 1.180 0.945 -A-35LAT 1M -T1 287.2 280.3 267.2 252.9 238.8 226.7 217.8 212.1 209.5 210.1 212.9 -T2 216.6 220.4 224.1 227.7 231.5 235.7 240.8 246.4 252.0 257.6 262.5 -T3 266.2 268.1 268.3 266.5 263.0 257.7 252.1 246.5 240.9 233.2 227.8 -T4 220.3 213.2 208.2 203.7 199.2 194.7 190.5 187.2 -Z1 0.024 0.035 0.040 0.048 0.063 0.085 0.126 0.174 0.299 0.704 1.464 -Z2 2.602 3.848 5.583 7.279 8.428 8.859 8.640 8.111 7.296 6.171 5.008 -Z3 4.067 3.381 2.885 2.481 2.128 1.814 1.514 1.236 0.986 -A-25LAT 1M -T1 291.7 284.7 271.4 257.0 242.6 228.9 217.0 207.6 202.7 203.3 207.3 -T2 212.0 216.5 220.6 224.3 228.1 232.3 237.4 243.1 249.1 255.3 260.9 -T3 265.0 267.3 267.6 265.8 262.3 257.6 252.7 247.7 242.7 234.7 230.9 -T4 223.1 216.4 211.9 208.0 204.1 200.2 196.5 193.8 -Z1 0.040 0.040 0.048 0.056 0.065 0.074 0.082 0.103 0.148 0.398 1.135 -Z2 2.446 4.023 5.818 7.616 8.931 9.535 9.375 8.739 7.834 6.630 5.352 -Z3 4.305 3.541 2.977 2.541 2.174 1.840 1.519 1.208 0.950 -A-15LAT 1M -T1 293.4 286.4 273.2 259.0 244.4 230.1 216.5 204.9 198.5 199.2 203.9 -T2 209.2 214.0 218.1 221.8 225.5 229.8 234.8 240.7 247.1 253.8 259.9 -T3 264.5 267.1 267.6 265.9 262.8 259.6 254.6 249.3 244.1 235.4 231.2 -T4 223.3 216.6 212.3 208.8 205.3 201.8 198.5 196.3 -Z1 0.010 0.020 0.031 0.035 0.035 0.034 0.038 0.057 0.096 0.294 0.951 -Z2 2.222 3.895 5.819 7.830 9.442 10.232 10.159 9.509 8.515 7.184 5.806 -Z3 4.648 3.751 3.087 2.524 2.147 1.809 1.457 1.141 0.899 -A -5LAT 1M -T1 293.2 286.4 273.5 259.4 244.7 230.2 216.3 204.0 197.1 197.9 203.0 -T2 208.6 213.4 217.3 220.8 224.3 228.5 233.7 239.8 246.4 253.3 259.6 -T3 264.2 266.8 267.4 265.8 263.3 261.4 255.8 249.7 243.6 233.3 228.7 -T4 220.4 213.4 209.6 207.0 204.6 202.1 199.5 197.9 -Z1 0.016 0.030 0.041 0.047 0.044 0.044 0.048 0.056 0.079 0.217 0.883 -Z2 2.088 3.734 5.719 7.779 9.571 10.370 10.321 9.655 8.731 7.497 6.079 -Z3 4.834 3.854 3.061 2.414 2.015 1.700 1.380 1.101 0.884 -A 5LAT 1M -T1 292.8 286.1 273.3 259.3 244.6 230.1 216.2 204.0 197.1 198.1 203.5 -T2 209.3 214.1 217.8 221.0 224.2 228.2 233.4 239.5 246.2 253.1 259.4 -T3 264.1 266.7 267.3 265.7 263.1 261.0 255.1 248.6 242.0 232.5 226.3 -T4 217.5 210.7 207.3 205.4 203.7 201.9 200.2 198.7 -Z1 0.024 0.026 0.042 0.049 0.050 0.054 0.065 0.080 0.108 0.251 0.906 -Z2 2.064 3.615 5.552 7.570 9.300 9.884 9.748 9.173 8.447 7.456 6.119 -Z3 4.855 3.804 3.020 2.403 1.979 1.673 1.368 1.089 0.871 -A 15LAT 1M -T1 291.2 284.5 271.8 257.7 243.3 229.2 216.1 204.9 198.4 199.1 204.2 -T2 209.9 214.5 218.1 221.2 224.3 228.2 233.1 239.0 245.6 252.4 258.8 -T3 263.5 266.4 267.0 265.4 262.2 258.7 253.0 246.9 240.9 232.0 226.3 -T4 218.1 211.5 208.0 205.9 203.9 201.8 199.9 198.1 -Z1 0.022 0.041 0.049 0.048 0.048 0.050 0.059 0.070 0.119 0.301 1.119 -Z2 2.176 3.627 5.407 7.268 8.486 9.033 8.967 8.626 8.114 7.230 5.986 -Z3 4.767 3.827 3.093 2.514 2.107 1.759 1.409 1.108 0.878 -A 25LAT 1M -T1 286.2 279.5 266.7 252.8 239.2 227.0 216.6 208.4 203.5 203.4 206.9 -T2 211.1 214.9 218.2 221.2 224.3 227.9 232.6 238.1 244.2 250.6 256.5 -T3 261.2 264.1 264.9 263.4 259.8 254.9 250.0 245.2 240.3 232.8 228.4 -T4 221.5 215.3 211.4 208.6 205.8 203.1 200.2 198.3 -Z1 0.027 0.043 0.048 0.051 0.053 0.062 0.073 0.093 0.155 0.401 1.280 -Z2 2.641 4.131 5.427 6.601 7.336 7.864 7.969 7.952 7.682 7.024 5.929 -Z3 4.802 3.905 3.229 2.688 2.300 1.924 1.534 1.198 0.947 -A 35LAT 1M -T1 279.0 271.9 258.7 245.1 232.8 223.4 217.5 213.9 211.4 210.8 211.9 -T2 214.0 216.3 218.7 221.2 223.8 226.9 231.0 235.8 241.1 246.5 251.7 -T3 256.0 259.1 260.4 259.4 256.2 250.6 246.8 243.3 239.8 234.3 231.1 -T4 225.4 220.1 216.2 213.0 209.6 206.3 202.8 201.0 -Z1 0.027 0.043 0.048 0.052 0.066 0.127 0.235 0.360 0.563 1.152 2.107 -Z2 3.388 4.589 5.577 6.171 6.474 6.715 6.939 7.108 7.130 6.768 5.978 -Z3 4.987 4.088 3.408 2.884 2.455 2.030 1.635 1.295 1.035 -A 45LAT 1M -T1 269.9 263.6 251.3 238.3 227.1 220.2 217.8 217.2 216.4 215.7 215.5 -T2 215.9 216.9 218.3 220.1 222.2 224.7 228.3 232.5 237.0 241.5 245.9 -T3 249.8 253.0 254.9 255.0 252.8 247.5 244.3 241.5 238.7 234.3 232.3 -T4 229.3 224.7 221.3 218.0 214.6 211.3 207.8 206.2 -Z1 0.018 0.040 0.045 0.051 0.072 0.157 0.348 0.562 0.900 1.531 2.456 -Z2 3.584 4.640 5.496 5.927 6.033 6.122 6.282 6.457 6.577 6.472 6.047 -Z3 5.388 4.622 3.870 3.198 2.661 2.163 1.735 1.360 1.057 -A 55LAT 1M -T1 262.0 256.9 246.0 233.7 223.4 217.5 216.2 216.3 215.8 215.0 214.4 -T2 214.1 214.5 215.5 217.0 218.8 221.2 224.7 228.9 233.3 237.5 241.7 -T3 245.7 249.2 251.8 252.9 252.0 248.0 244.9 241.9 239.0 234.1 232.5 -T4 230.5 228.1 225.0 221.9 218.7 215.6 212.6 210.8 -Z1 0.019 0.042 0.048 0.054 0.072 0.168 0.370 0.611 0.999 1.628 2.510 -Z2 3.608 4.632 5.258 5.582 5.741 5.774 5.939 6.026 5.998 5.812 5.453 -Z3 4.967 4.379 3.719 3.065 2.482 1.985 1.598 1.342 1.165 -A 65LAT 1M -T1 256.6 252.2 242.1 230.3 220.4 214.9 213.5 213.1 212.0 210.7 209.7 -T2 209.2 209.6 210.7 212.4 214.4 217.0 220.9 225.4 230.2 235.0 239.7 -T3 244.2 248.4 251.7 253.7 254.0 251.7 247.6 243.4 239.2 232.1 230.1 -T4 228.0 225.9 223.3 221.0 218.6 216.2 213.8 212.5 -Z1 0.031 0.041 0.046 0.052 0.076 0.212 0.469 0.862 1.414 2.093 2.896 -Z2 3.661 4.315 4.752 5.069 5.288 5.401 5.565 5.620 5.531 5.256 4.925 -Z3 4.505 4.001 3.418 2.853 2.355 1.930 1.587 1.347 1.197 -A 75LAT 1M -T1 252.3 248.3 238.8 227.6 218.3 213.0 211.2 210.2 208.3 206.3 204.8 -T2 204.3 204.7 206.0 207.8 210.0 212.8 216.9 221.9 227.2 232.6 238.0 -T3 243.3 248.2 252.3 255.0 256.3 255.5 250.7 245.2 239.8 231.0 227.9 -T4 223.3 218.9 217.3 216.2 215.2 214.2 213.1 212.5 -Z1 0.031 0.039 0.044 0.051 0.087 0.237 0.492 0.930 1.537 2.252 2.966 -Z2 3.556 3.907 4.156 4.457 4.826 5.134 5.306 5.366 5.288 5.028 4.682 -Z3 4.247 3.730 3.135 2.596 2.146 1.790 1.533 1.378 1.313 -A 85LAT 1M -T1 249.8 245.8 236.4 225.6 216.7 211.5 209.6 208.2 205.9 203.3 201.6 -T2 201.1 201.6 202.8 204.6 206.6 209.5 213.6 218.8 224.4 230.3 236.2 -T3 242.0 247.5 252.2 255.7 257.8 258.3 252.9 246.6 240.4 231.9 226.3 -T4 220.3 216.0 214.4 214.0 213.6 213.2 212.8 212.5 -Z1 0.030 0.038 0.043 0.050 0.078 0.228 0.492 0.910 1.604 2.274 2.920 -Z2 3.345 3.602 3.743 4.176 4.684 5.075 5.243 5.300 5.234 5.014 4.653 -Z3 4.217 3.696 3.069 2.513 2.072 1.736 1.494 1.366 1.328 -A-85LAT 2M -T1 253.3 248.3 239.7 231.8 227.3 227.6 229.9 231.3 231.5 231.1 230.8 -T2 230.9 231.8 233.5 236.0 238.5 241.0 243.4 246.5 252.1 259.7 267.2 -T3 273.2 277.4 279.4 278.9 276.0 270.7 265.0 259.3 253.6 247.4 240.3 -T4 232.7 225.1 217.4 209.6 201.8 194.0 186.1 181.7 -Z1 0.021 0.021 0.019 0.028 0.067 0.232 0.313 0.555 1.047 1.746 2.457 -Z2 2.919 3.032 3.097 3.366 3.759 4.134 4.561 4.886 5.060 5.020 4.509 -Z3 3.838 3.103 2.418 1.915 1.535 1.250 1.024 0.829 0.668 -A-75LAT 2M -T1 259.6 254.2 244.3 234.6 228.2 226.7 228.2 229.6 230.1 229.9 229.9 -T2 230.2 231.2 233.0 235.4 237.9 240.4 243.1 246.6 252.0 258.9 265.6 -T3 271.0 274.8 276.4 275.6 272.5 267.1 261.7 256.4 251.1 245.5 238.5 -T4 230.8 223.3 215.6 207.9 200.3 192.6 184.7 180.4 -Z1 0.017 0.019 0.025 0.034 0.064 0.203 0.291 0.490 0.956 1.686 2.416 -Z2 3.008 3.395 3.671 3.826 4.112 4.535 4.961 5.234 5.305 5.108 4.466 -Z3 3.758 3.061 2.460 1.999 1.623 1.321 1.081 0.867 0.694 -A-65LAT 2M -T1 267.5 261.3 249.7 238.3 230.1 227.0 227.3 228.1 228.2 228.0 228.1 -T2 228.7 229.9 231.8 234.2 236.7 239.6 243.1 247.3 252.4 258.1 263.6 -T3 268.0 270.9 272.1 271.2 268.4 263.3 257.8 252.3 246.8 240.0 233.7 -T4 226.1 218.7 211.3 204.1 196.6 189.4 182.3 177.8 -Z1 0.014 0.016 0.024 0.031 0.067 0.182 0.266 0.444 0.846 1.568 2.352 -Z2 2.992 3.591 4.113 4.671 5.156 5.543 5.861 6.022 5.959 5.528 4.741 -Z3 3.873 3.178 2.690 2.291 1.969 1.663 1.364 1.093 0.874 -A-55LAT 2M -T1 273.9 267.3 255.0 242.6 232.3 226.3 224.4 224.1 223.9 224.0 224.6 -T2 225.9 227.7 229.9 232.5 235.3 238.5 242.7 247.4 252.3 257.1 261.5 -T3 264.9 267.1 267.8 267.0 264.3 259.3 253.5 247.5 241.6 234.1 227.6 -T4 220.0 212.7 206.3 200.0 193.7 187.5 181.8 177.5 -Z1 0.012 0.022 0.032 0.042 0.057 0.106 0.185 0.280 0.544 1.127 1.938 -Z2 2.893 3.529 4.626 5.515 6.103 6.461 6.684 6.747 6.569 5.988 5.082 -Z3 4.165 3.448 2.911 2.503 2.133 1.807 1.490 1.192 0.943 -A-45LAT 2M -T1 280.7 274.2 261.6 248.1 235.4 225.7 220.2 217.7 216.7 217.3 219.0 -T2 221.4 224.2 227.2 230.3 233.5 237.2 241.7 246.7 251.5 256.0 260.1 -T3 263.1 264.9 265.3 264.2 261.3 256.1 250.2 244.2 238.2 230.3 224.2 -T4 216.7 209.9 204.7 199.8 195.0 190.1 185.6 182.5 -Z1 0.018 0.024 0.034 0.040 0.051 0.080 0.138 0.201 0.378 0.865 1.658 -Z2 2.689 3.629 5.087 6.461 7.255 7.646 7.681 7.554 7.141 6.324 5.252 -Z3 4.263 3.566 3.052 2.643 2.278 1.932 1.591 1.276 1.013 -A-35LAT 2M -T1 287.7 280.9 267.8 253.6 239.5 227.2 217.9 211.8 209.0 209.5 212.4 -T2 216.2 220.0 223.8 227.3 231.0 235.1 239.8 245.0 250.1 255.0 259.5 -T3 262.7 264.4 264.6 263.2 260.1 254.8 249.6 244.4 239.3 233.2 227.1 -T4 220.0 213.6 209.1 204.9 200.9 196.8 193.1 190.3 -Z1 0.028 0.034 0.040 0.047 0.055 0.068 0.092 0.128 0.238 0.626 1.348 -Z2 2.472 3.639 5.597 7.210 8.234 8.691 8.622 8.251 7.654 6.692 5.508 -Z3 4.517 3.764 3.228 2.754 2.399 2.038 1.657 1.283 0.988 -A-25LAT 2M -T1 292.2 285.1 271.8 257.5 243.1 229.3 217.1 207.4 202.4 203.0 206.9 -T2 211.8 216.4 220.5 224.4 228.3 232.6 237.6 243.1 248.8 254.6 259.9 -T3 263.6 265.6 265.8 264.0 260.6 255.7 251.3 247.1 242.9 235.9 232.5 -T4 225.4 219.2 214.7 210.8 206.9 202.9 199.2 196.5 -Z1 0.037 0.037 0.050 0.060 0.070 0.072 0.078 0.094 0.134 0.376 1.044 -Z2 2.231 3.855 5.769 7.640 8.978 9.570 9.545 9.004 8.195 7.080 5.852 -Z3 4.749 3.911 3.307 2.802 2.399 2.021 1.625 1.257 0.960 -A-15LAT 2M -T1 293.6 286.6 273.4 259.2 244.6 230.2 216.6 204.9 198.5 199.0 203.5 -T2 208.8 213.7 218.0 221.9 225.9 230.3 235.7 241.8 248.3 254.9 260.9 -T3 265.2 267.4 267.6 265.6 262.1 257.9 253.5 249.1 244.6 237.2 233.7 -T4 226.4 220.0 215.5 211.8 208.0 204.3 200.8 198.4 -Z1 0.010 0.016 0.030 0.035 0.034 0.032 0.035 0.053 0.094 0.297 0.869 -Z2 2.044 3.760 5.806 7.916 9.526 10.401 10.392 9.756 8.631 7.235 5.863 -Z3 4.718 3.829 3.163 2.593 2.184 1.850 1.506 1.195 0.929 -A -5LAT 2M -T1 293.4 286.6 273.6 259.5 244.8 230.3 216.4 204.1 197.2 197.8 202.6 -T2 208.1 212.9 217.0 220.8 224.6 229.1 234.8 241.4 248.3 255.3 261.6 -T3 266.1 268.3 268.4 266.4 263.0 259.6 254.3 248.8 243.2 234.1 229.8 -T4 222.0 215.6 211.6 208.5 205.6 202.6 199.8 198.0 -Z1 0.013 0.030 0.038 0.045 0.043 0.043 0.046 0.058 0.080 0.214 0.819 -Z2 2.057 3.749 5.665 7.889 9.821 10.815 10.790 10.039 8.847 7.406 5.913 -Z3 4.623 3.530 2.867 2.361 2.046 1.760 1.448 1.182 0.958 -A 5LAT 2M -T1 293.1 286.3 273.4 259.3 244.7 230.2 216.3 204.1 197.2 197.9 203.1 -T2 208.8 213.6 217.6 221.0 224.5 228.8 234.5 241.1 248.1 255.2 261.6 -T3 266.0 268.3 268.4 266.4 263.0 259.4 253.5 247.2 241.0 232.8 226.1 -T4 217.8 211.4 207.8 205.5 203.4 201.1 198.9 197.5 -Z1 0.026 0.038 0.042 0.048 0.051 0.054 0.073 0.067 0.106 0.278 0.880 -Z2 2.032 3.587 5.509 7.707 9.599 10.493 10.321 9.706 8.690 7.374 5.956 -Z3 4.625 3.557 2.853 2.317 1.992 1.713 1.408 1.141 0.937 -A 15LAT 2M -T1 291.6 284.8 271.8 257.8 243.4 229.4 216.3 205.0 198.4 198.8 203.8 -T2 209.5 214.2 218.0 221.4 224.8 228.9 234.4 240.7 247.4 254.2 260.4 -T3 264.9 267.3 267.5 265.5 262.0 257.4 251.6 245.6 239.5 231.4 225.4 -T4 217.7 211.8 208.3 206.0 203.9 201.7 199.4 197.7 -Z1 0.021 0.038 0.047 0.049 0.051 0.046 0.051 0.058 0.098 0.314 1.068 -Z2 2.156 3.635 5.429 7.320 8.791 9.596 9.584 9.114 8.360 7.240 5.842 -Z3 4.646 3.726 3.041 2.467 2.099 1.780 1.452 1.160 0.935 -A 25LAT 2M -T1 286.7 279.8 266.7 252.7 239.2 227.1 216.8 208.5 203.5 203.2 206.5 -T2 210.8 214.7 218.2 221.4 224.7 228.6 233.7 239.5 245.7 252.0 257.7 -T3 262.0 264.4 265.0 263.3 259.8 254.5 249.5 244.5 239.6 232.7 227.9 -T4 221.4 215.9 212.3 209.5 206.7 203.9 201.2 199.0 -Z1 0.030 0.044 0.049 0.053 0.056 0.058 0.064 0.086 0.142 0.403 1.326 -Z2 2.768 4.233 5.503 6.710 7.747 8.509 8.692 8.528 7.979 7.010 5.777 -Z3 4.708 3.867 3.254 2.703 2.274 1.895 1.529 1.217 0.982 -A 35LAT 2M -T1 279.2 272.0 258.6 244.9 232.5 223.4 217.8 214.3 211.7 210.9 211.9 -T2 213.9 216.2 218.8 221.3 224.1 227.5 231.9 237.1 242.4 247.8 252.8 -T3 256.8 259.6 260.6 259.8 256.9 251.3 247.3 243.6 239.9 234.9 231.1 -T4 225.7 220.8 216.9 213.5 210.2 206.7 203.4 201.1 -Z1 0.030 0.046 0.052 0.056 0.071 0.145 0.268 0.368 0.589 1.180 2.194 -Z2 3.475 4.592 5.486 6.182 6.763 7.299 7.679 7.799 7.576 6.973 6.034 -Z3 5.000 4.131 3.428 2.893 2.420 1.996 1.612 1.280 1.020 -A 45LAT 2M -T1 270.2 263.7 251.1 238.0 226.9 220.3 218.3 218.0 217.2 216.4 216.2 -T2 216.6 217.6 219.2 221.2 223.4 226.1 229.8 234.1 238.5 242.9 247.1 -T3 250.9 253.8 255.6 255.8 254.0 249.2 245.8 242.8 239.8 234.9 232.7 -T4 228.9 224.6 220.8 217.4 213.9 210.5 207.0 204.7 -Z1 0.019 0.043 0.049 0.053 0.073 0.185 0.407 0.618 0.970 1.697 2.712 -Z2 3.756 4.741 5.469 5.886 6.206 6.579 6.871 7.040 7.004 6.712 6.142 -Z3 5.379 4.517 3.726 3.067 2.534 2.063 1.657 1.308 1.031 -A 55LAT 2M -T1 262.3 257.1 246.1 233.8 223.5 218.0 217.2 217.6 217.5 216.9 216.6 -T2 216.6 217.1 218.3 220.1 222.0 224.4 227.7 231.4 235.3 239.1 242.9 -T3 246.5 249.7 252.2 253.6 253.4 250.4 247.1 243.9 240.6 235.5 233.3 -T4 230.2 227.0 223.7 220.6 217.4 214.3 211.2 209.0 -Z1 0.024 0.044 0.050 0.056 0.083 0.219 0.462 0.703 1.047 1.787 2.804 -Z2 3.835 4.719 5.338 5.626 5.935 6.221 6.433 6.523 6.573 6.456 6.064 -Z3 5.396 4.540 3.708 2.994 2.445 1.994 1.615 1.293 1.043 -A 65LAT 2M -T1 256.5 252.2 242.2 230.6 221.0 215.9 215.0 215.3 214.9 214.3 214.0 -T2 214.2 214.9 216.3 218.2 220.2 222.7 225.9 229.5 233.3 237.1 240.8 -T3 244.6 248.1 251.2 253.7 255.2 254.7 250.4 245.6 240.8 233.4 230.3 -T4 227.2 224.2 221.6 219.3 217.1 214.8 212.7 210.9 -Z1 0.029 0.043 0.049 0.055 0.089 0.263 0.565 0.911 1.463 2.193 3.060 -Z2 3.839 4.448 4.878 5.273 5.597 5.840 6.074 6.173 6.126 5.924 5.576 -Z3 5.069 4.437 3.724 3.040 2.437 1.929 1.539 1.264 1.092 -A 75LAT 2M -T1 251.5 247.7 238.5 227.7 218.9 214.3 213.3 212.9 212.0 211.0 210.7 -T2 211.2 212.3 214.0 216.0 218.3 221.0 224.4 228.2 232.2 236.1 240.0 -T3 243.9 247.6 251.2 254.8 258.0 260.0 254.4 247.7 241.0 230.7 226.0 -T4 221.3 217.2 215.4 214.4 213.5 212.6 211.7 210.7 -Z1 0.031 0.041 0.047 0.055 0.095 0.277 0.587 1.033 1.647 2.431 3.119 -Z2 3.676 4.215 4.590 4.853 5.156 5.447 5.700 5.793 5.719 5.470 5.067 -Z3 4.541 3.939 3.328 2.785 2.303 1.884 1.536 1.258 1.090 -A 85LAT 2M -T1 249.0 245.1 235.9 225.4 216.9 212.4 211.2 210.8 209.5 208.0 207.6 -T2 208.4 209.8 211.7 213.9 216.1 218.9 222.6 226.9 231.1 235.3 239.4 -T3 243.4 247.3 251.5 256.0 260.8 265.1 258.5 250.3 242.1 229.9 224.0 -T4 218.3 213.4 212.1 212.0 211.8 211.6 211.4 210.6 -Z1 0.029 0.039 0.044 0.050 0.080 0.250 0.555 1.031 1.649 2.400 3.060 -Z2 3.503 3.939 4.396 4.656 5.007 5.321 5.600 5.724 5.659 5.360 4.926 -Z3 4.380 3.765 3.136 2.642 2.232 1.880 1.554 1.281 1.121 -A-85LAT 3M -T1 252.5 247.6 239.1 230.7 224.6 223.2 224.6 225.7 225.4 224.2 223.0 -T2 222.5 222.6 223.6 225.0 226.5 227.5 227.7 228.4 232.2 238.6 245.4 -T3 251.6 256.7 260.5 262.4 262.4 259.9 256.1 252.0 248.0 245.5 238.0 -T4 230.4 223.1 216.5 210.0 203.6 197.3 190.9 187.1 -Z1 0.018 0.018 0.022 0.027 0.061 0.216 0.319 0.581 1.152 1.863 2.463 -Z2 2.798 3.084 3.198 3.332 3.473 3.535 3.718 3.919 4.103 4.228 4.305 -Z3 4.163 3.807 3.249 2.644 2.069 1.568 1.205 0.901 0.673 -A-75LAT 3M -T1 256.9 251.9 242.5 232.8 225.9 223.8 224.7 225.6 225.4 224.3 223.3 -T2 222.9 223.2 224.1 225.6 227.0 228.2 229.0 230.5 234.4 240.4 246.8 -T3 252.5 257.3 260.4 261.5 260.6 257.3 253.5 249.7 245.8 243.4 236.4 -T4 228.8 221.6 214.9 208.4 201.9 195.5 188.9 185.4 -Z1 0.021 0.023 0.028 0.035 0.066 0.191 0.297 0.533 1.007 1.720 2.415 -Z2 2.944 3.298 3.554 3.665 3.790 3.920 4.276 4.608 4.865 4.986 4.913 -Z3 4.548 3.959 3.240 2.611 2.067 1.618 1.285 1.011 0.811 -A-65LAT 3M -T1 265.4 259.6 248.3 237.0 228.7 225.1 224.9 225.2 224.8 223.9 223.3 -T2 223.2 223.8 224.9 226.4 228.0 229.6 231.5 234.1 238.2 243.5 248.8 -T3 253.7 257.5 259.9 260.4 258.8 254.9 250.6 246.3 242.0 238.2 231.7 -T4 224.2 217.1 210.5 204.0 197.6 191.3 184.7 181.9 -Z1 0.018 0.020 0.023 0.031 0.064 0.176 0.289 0.460 0.895 1.512 2.331 -Z2 2.996 3.484 3.957 4.515 4.906 5.234 5.609 5.956 6.159 5.988 5.351 -Z3 4.426 3.540 2.911 2.421 2.038 1.703 1.385 1.104 0.875 -A-55LAT 3M -T1 272.8 266.4 254.3 241.8 231.4 225.0 222.8 222.2 221.7 221.5 221.8 -T2 222.5 223.6 225.2 226.9 228.9 231.1 234.1 237.6 241.7 246.3 250.8 -T3 254.7 257.8 259.5 259.5 257.6 253.3 248.0 242.7 237.4 232.0 224.8 -T4 217.5 210.8 205.0 199.5 194.2 188.8 183.4 181.3 -Z1 0.016 0.024 0.033 0.037 0.056 0.118 0.213 0.339 0.632 1.209 2.082 -Z2 2.882 3.896 4.891 5.476 5.909 6.277 6.585 6.800 6.838 6.499 5.666 -Z3 4.630 3.752 3.103 2.594 2.197 1.836 1.509 1.216 0.974 -A-45LAT 3M -T1 279.8 273.3 260.8 247.3 234.5 224.9 219.5 217.1 216.1 216.5 218.0 -T2 219.9 222.1 224.5 227.0 229.5 232.4 236.0 240.0 244.3 248.8 253.0 -T3 256.5 259.0 260.2 259.7 257.4 252.7 246.9 241.0 235.1 228.3 221.5 -T4 214.6 208.6 203.9 199.9 195.9 191.8 187.7 186.5 -Z1 0.019 0.025 0.033 0.040 0.046 0.064 0.137 0.206 0.408 0.889 1.736 -Z2 2.667 3.779 5.037 6.199 6.880 7.231 7.405 7.417 7.263 6.715 5.748 -Z3 4.700 3.821 3.186 2.694 2.280 1.911 1.572 1.263 0.994 -A-35LAT 3M -T1 286.9 280.0 266.9 252.6 238.6 226.5 217.7 212.0 209.4 210.0 212.7 -T2 216.1 219.6 222.9 226.1 229.4 232.8 236.8 241.1 245.8 250.7 255.3 -T3 258.9 261.2 262.0 260.8 257.9 252.9 248.0 243.0 238.1 232.7 226.5 -T4 219.8 214.2 209.9 206.3 202.7 199.1 195.6 193.8 -Z1 0.025 0.029 0.037 0.040 0.049 0.065 0.098 0.151 0.299 0.669 1.503 -Z2 2.559 3.814 5.616 7.104 7.967 8.277 8.233 7.993 7.618 6.908 5.838 -Z3 4.772 3.901 3.256 2.754 2.324 1.939 1.576 1.252 0.987 -A-25LAT 3M -T1 291.8 284.7 271.3 256.9 242.5 228.9 217.1 207.8 203.1 203.6 207.5 -T2 212.2 216.8 220.9 224.7 228.5 232.5 236.9 241.8 247.2 253.0 258.3 -T3 262.2 264.4 264.7 262.8 259.2 254.1 250.4 246.8 243.3 237.1 234.3 -T4 227.8 222.0 217.5 213.5 209.5 205.6 201.9 199.3 -Z1 0.037 0.037 0.049 0.060 0.070 0.074 0.078 0.098 0.147 0.380 1.092 -Z2 2.300 3.936 5.878 7.711 8.904 9.317 9.145 8.580 7.871 6.905 5.778 -Z3 4.721 3.873 3.208 2.639 2.218 1.851 1.507 1.206 0.964 -A-15LAT 3M -T1 293.8 286.7 273.4 259.2 244.6 230.3 216.8 205.1 198.8 199.4 204.0 -T2 209.4 214.5 219.1 223.2 227.5 232.0 237.2 243.0 249.2 255.7 261.6 -T3 265.7 267.6 267.5 265.1 261.0 256.1 252.3 248.7 245.1 239.0 236.2 -T4 229.3 223.3 218.9 214.8 210.8 206.8 203.0 200.7 -Z1 0.010 0.018 0.028 0.031 0.029 0.027 0.033 0.048 0.088 0.258 0.852 -Z2 2.123 3.870 5.916 8.062 9.644 10.345 10.120 9.232 8.085 6.797 5.518 -Z3 4.505 3.669 3.027 2.498 2.123 1.793 1.467 1.184 0.964 -A -5LAT 3M -T1 293.9 287.0 273.8 259.7 245.1 230.6 216.6 204.2 197.3 198.1 203.0 -T2 208.7 213.8 218.4 222.6 226.9 231.7 237.6 244.2 251.0 257.9 263.9 -T3 267.8 269.5 268.9 266.3 262.2 257.6 252.7 247.8 242.9 234.8 231.1 -T4 223.8 217.7 213.6 210.2 206.7 203.3 200.2 198.3 -Z1 0.020 0.027 0.038 0.046 0.047 0.044 0.046 0.053 0.076 0.226 0.846 -Z2 2.160 3.822 5.859 8.177 9.979 10.834 10.484 9.510 8.211 6.688 5.225 -Z3 4.180 3.416 2.873 2.408 2.067 1.756 1.442 1.171 0.961 -A 5LAT 3M -T1 293.7 286.8 273.7 259.5 244.9 230.4 216.5 204.2 197.3 198.1 203.4 -T2 209.3 214.5 218.9 222.8 226.8 231.6 237.6 244.5 251.5 258.4 264.5 -T3 268.4 270.0 269.4 266.7 262.6 257.7 251.8 245.8 239.8 233.3 225.7 -T4 218.1 211.9 208.4 205.7 203.0 200.3 197.8 196.2 -Z1 0.023 0.031 0.036 0.046 0.050 0.048 0.059 0.066 0.095 0.286 0.915 -Z2 2.170 3.732 5.743 8.093 9.942 10.709 10.261 9.357 8.221 6.709 5.235 -Z3 4.158 3.384 2.839 2.418 2.067 1.750 1.435 1.166 0.963 -A 15LAT 3M -T1 292.6 285.6 272.2 258.0 243.5 229.5 216.3 205.0 198.5 199.0 204.1 -T2 210.0 215.1 219.3 223.2 227.1 231.6 237.3 243.7 250.4 257.1 263.1 -T3 267.2 269.1 268.7 266.2 261.9 256.3 250.3 244.3 238.3 231.0 224.4 -T4 217.5 211.9 208.6 206.1 203.7 201.4 199.0 197.3 -Z1 0.024 0.044 0.055 0.057 0.056 0.058 0.072 0.093 0.157 0.448 1.145 -Z2 2.263 3.737 5.654 7.757 9.296 9.937 9.757 8.985 7.937 6.618 5.402 -Z3 4.348 3.559 2.953 2.477 2.120 1.786 1.455 1.174 0.958 -A 25LAT 3M -T1 288.2 281.0 267.5 253.1 239.2 226.9 216.5 208.3 203.4 203.2 206.7 -T2 211.2 215.4 219.2 222.9 226.6 230.9 236.1 242.0 248.2 254.5 260.2 -T3 264.3 266.5 266.7 264.6 260.5 254.6 249.3 244.2 239.1 232.9 227.4 -T4 221.5 216.6 213.2 210.4 207.7 204.9 202.2 199.8 -Z1 0.035 0.049 0.055 0.058 0.064 0.073 0.086 0.106 0.176 0.455 1.398 -Z2 2.796 4.208 5.624 7.107 8.204 8.861 8.915 8.461 7.640 6.580 5.540 -Z3 4.544 3.767 3.156 2.604 2.225 1.848 1.499 1.203 0.974 -A 35LAT 3M -T1 281.3 273.9 260.2 246.0 232.9 223.0 217.1 213.6 211.2 210.4 211.5 -T2 213.7 216.2 219.0 222.0 225.1 228.8 233.6 239.1 244.9 250.6 256.0 -T3 260.2 263.0 263.8 262.6 259.2 253.5 249.1 244.9 240.7 235.5 230.9 -T4 225.8 221.3 217.6 214.2 210.7 207.3 204.0 201.2 -Z1 0.039 0.053 0.056 0.058 0.077 0.156 0.343 0.436 0.657 1.246 2.158 -Z2 3.367 4.554 5.499 6.376 7.248 7.981 8.278 8.128 7.626 6.774 5.751 -Z3 4.738 3.896 3.236 2.714 2.294 1.898 1.534 1.225 0.980 -A 45LAT 3M -T1 273.0 266.0 253.0 239.5 227.7 220.4 218.0 217.6 216.9 216.1 215.9 -T2 216.4 217.4 219.1 221.1 223.4 226.4 230.7 235.7 240.9 246.1 251.0 -T3 255.3 258.6 260.3 260.0 257.7 252.9 249.1 245.4 241.8 235.7 233.0 -T4 228.6 224.2 220.3 216.8 213.2 209.6 206.1 203.1 -Z1 0.030 0.048 0.054 0.059 0.078 0.194 0.446 0.595 0.967 1.631 2.630 -Z2 3.675 4.574 5.328 5.967 6.545 7.133 7.562 7.742 7.663 7.140 6.201 -Z3 5.071 4.063 3.314 2.769 2.312 1.903 1.535 1.221 0.980 -A 55LAT 3M -T1 265.3 259.2 247.4 234.9 224.7 219.3 218.6 219.1 219.0 218.5 218.1 -T2 218.1 218.5 219.5 221.0 222.8 225.2 228.7 233.0 237.5 242.1 246.6 -T3 250.7 254.3 256.7 257.5 256.5 252.9 249.3 245.7 242.2 236.5 233.9 -T4 229.7 225.6 222.3 219.2 216.1 213.0 209.8 207.1 -Z1 0.028 0.049 0.055 0.061 0.089 0.235 0.476 0.689 1.018 1.799 2.776 -Z2 3.774 4.605 5.235 5.733 6.156 6.544 6.848 7.037 7.137 6.993 6.416 -Z3 5.451 4.397 3.520 2.843 2.338 1.916 1.547 1.233 0.995 -A 65LAT 3M -T1 258.6 253.6 243.0 231.5 222.7 218.7 218.7 219.4 219.4 219.1 219.0 -T2 219.1 219.5 220.5 221.8 223.3 225.3 228.1 231.5 235.2 239.1 243.1 -T3 247.1 250.8 253.9 255.8 256.3 254.3 250.0 245.4 240.9 234.8 230.5 -T4 226.2 222.2 219.8 217.7 215.6 213.5 211.4 209.3 -Z1 0.030 0.046 0.053 0.060 0.096 0.317 0.593 0.902 1.336 2.051 2.919 -Z2 3.738 4.402 5.002 5.532 5.983 6.294 6.525 6.671 6.773 6.697 6.250 -Z3 5.420 4.388 3.473 2.783 2.301 1.887 1.512 1.193 0.954 -A 75LAT 3M -T1 253.0 248.8 239.4 228.9 221.3 218.3 218.5 219.2 219.2 218.9 219.0 -T2 219.5 220.3 221.4 222.5 223.8 225.4 227.5 230.1 233.2 236.7 240.3 -T3 244.1 248.0 251.6 254.7 256.9 256.7 251.2 244.9 238.7 229.6 224.7 -T4 219.1 214.8 213.3 212.5 211.8 211.1 210.2 208.9 -Z1 0.029 0.045 0.051 0.059 0.103 0.331 0.676 1.077 1.629 2.265 3.040 -Z2 3.716 4.295 4.810 5.218 5.596 5.878 6.131 6.270 6.263 6.071 5.611 -Z3 4.990 4.274 3.551 2.895 2.307 1.807 1.427 1.137 0.938 -A 85LAT 3M -T1 250.9 246.8 237.5 227.3 219.9 217.0 217.4 218.3 218.3 217.8 218.0 -T2 218.9 220.1 221.3 222.3 223.4 224.6 226.3 228.4 231.1 234.2 237.6 -T3 241.5 245.6 249.8 254.0 257.5 258.9 252.7 245.4 238.1 227.7 221.9 -T4 215.6 211.4 210.1 210.0 210.0 210.0 209.8 209.0 -Z1 0.027 0.042 0.047 0.055 0.118 0.367 0.690 1.162 1.733 2.471 3.229 -Z2 3.967 4.460 4.773 5.122 5.487 5.793 6.057 6.184 6.149 5.918 5.392 -Z3 4.723 3.993 3.309 2.767 2.269 1.818 1.426 1.096 0.848 -A-85LAT 4M -T1 248.7 244.6 236.8 228.4 221.7 218.7 218.4 218.0 216.5 214.1 211.9 -T2 210.5 210.0 210.2 211.0 211.8 212.4 212.6 213.8 218.1 224.9 232.2 -T3 239.2 245.4 250.7 254.6 257.3 258.3 254.5 250.0 245.6 242.1 234.8 -T4 228.0 221.4 216.6 212.1 207.5 203.1 198.9 196.0 -Z1 0.024 0.024 0.026 0.031 0.061 0.185 0.310 0.610 1.150 1.927 2.536 -Z2 2.772 2.936 3.058 3.296 3.351 3.286 3.269 3.300 3.366 3.449 3.637 -Z3 3.704 3.621 3.360 2.907 2.392 1.861 1.370 1.117 0.919 -A-75LAT 4M -T1 253.9 249.3 240.3 230.4 222.8 219.4 219.2 219.2 218.0 216.0 214.0 -T2 212.8 212.2 212.3 212.9 213.5 214.1 214.8 216.5 220.7 226.9 233.7 -T3 240.2 246.0 250.6 253.7 255.3 255.3 251.8 247.7 243.7 239.6 234.0 -T4 227.8 221.4 216.5 211.7 206.9 202.2 197.4 195.1 -Z1 0.025 0.026 0.031 0.040 0.064 0.177 0.310 0.560 1.032 1.772 2.475 -Z2 3.063 3.467 3.707 3.709 3.638 3.581 3.701 3.888 4.100 4.288 4.458 -Z3 4.407 4.136 3.654 3.031 2.423 1.863 1.387 1.129 0.929 -A-65LAT 4M -T1 263.3 257.5 246.2 234.6 225.8 221.6 220.9 220.9 219.9 218.5 217.2 -T2 216.3 215.9 216.0 216.4 216.9 217.8 219.2 221.6 225.5 230.7 236.2 -T3 241.5 246.3 250.2 252.5 253.3 252.2 248.5 244.5 240.5 235.8 231.0 -T4 225.8 220.6 215.3 210.2 205.2 200.0 194.9 192.5 -Z1 0.021 0.023 0.026 0.031 0.048 0.152 0.268 0.500 0.938 1.626 2.403 -Z2 3.000 3.425 3.940 4.487 4.765 4.825 5.158 5.529 5.856 6.041 5.973 -Z3 5.519 4.771 3.860 3.056 2.395 1.865 1.452 1.193 0.997 -A-55LAT 4M -T1 271.3 264.6 252.1 239.4 228.9 222.5 220.4 220.0 219.4 218.9 218.6 -T2 218.5 218.7 219.2 219.9 220.8 222.2 224.6 227.7 231.5 235.7 240.1 -T3 244.3 248.1 251.1 252.7 252.8 250.8 246.6 242.1 237.6 232.4 227.1 -T4 222.1 217.1 212.1 207.5 202.8 198.2 193.9 191.3 -Z1 0.019 0.027 0.032 0.037 0.062 0.129 0.211 0.345 0.757 1.386 2.161 -Z2 2.977 3.967 4.999 5.500 5.732 5.934 6.210 6.511 6.819 6.888 6.472 -Z3 5.621 4.595 3.689 2.958 2.441 1.988 1.585 1.234 0.961 -A-45LAT 4M -T1 278.1 271.3 258.4 244.7 232.1 222.9 218.4 216.6 215.9 216.1 217.0 -T2 218.2 219.5 221.0 222.6 224.3 226.5 229.6 233.4 237.4 241.6 245.7 -T3 249.4 252.6 254.7 255.4 254.6 251.6 246.8 241.7 236.6 230.0 224.9 -T4 219.6 214.0 209.8 206.1 202.3 198.6 194.9 193.4 -Z1 0.022 0.029 0.035 0.039 0.047 0.068 0.139 0.241 0.484 0.980 1.802 -Z2 2.815 3.923 5.201 5.973 6.310 6.566 6.808 7.031 7.219 7.133 6.579 -Z3 5.622 4.564 3.657 2.946 2.440 1.998 1.585 1.229 0.947 -A-35LAT 4M -T1 284.9 277.9 264.5 250.2 236.3 224.9 217.2 212.6 210.5 210.9 213.1 -T2 215.9 218.7 221.4 224.0 226.6 229.7 233.4 237.6 242.2 246.9 251.4 -T3 255.1 257.9 259.2 258.8 256.7 252.8 248.2 243.6 239.0 233.0 228.0 -T4 221.6 216.0 211.7 208.2 204.8 201.3 197.7 196.3 -Z1 0.023 0.031 0.038 0.041 0.046 0.060 0.119 0.174 0.357 0.828 1.611 -Z2 2.666 3.908 5.505 6.697 7.377 7.704 7.760 7.749 7.626 7.198 6.314 -Z3 5.200 4.155 3.385 2.771 2.322 1.917 1.531 1.204 0.956 -A-25LAT 4M -T1 290.3 283.2 269.8 255.4 241.0 228.0 217.0 208.6 204.2 204.7 208.3 -T2 212.8 217.1 221.0 224.5 227.9 231.7 236.1 241.0 246.3 251.7 256.8 -T3 260.6 262.9 263.5 262.0 258.8 254.0 250.0 246.2 242.3 235.7 232.5 -T4 225.6 219.5 215.2 211.6 208.0 204.4 201.0 198.6 -Z1 0.038 0.038 0.044 0.051 0.055 0.066 0.076 0.097 0.169 0.377 1.126 -Z2 2.370 3.993 5.897 7.559 8.572 8.904 8.750 8.421 7.917 7.131 6.010 -Z3 4.843 3.889 3.182 2.633 2.224 1.863 1.512 1.203 0.967 -A-15LAT 4M -T1 293.4 286.3 273.1 258.8 244.3 230.2 216.9 205.5 199.3 200.0 204.7 -T2 210.3 215.5 220.1 224.3 228.6 233.2 238.5 244.3 250.3 256.3 261.6 -T3 265.2 266.9 266.7 264.5 260.7 255.5 251.3 247.3 243.3 236.9 233.4 -T4 225.6 219.2 215.2 211.8 208.5 205.2 202.1 199.9 -Z1 0.013 0.023 0.033 0.036 0.035 0.036 0.039 0.053 0.092 0.262 0.902 -Z2 2.147 3.911 5.953 8.061 9.507 9.983 9.582 8.679 7.688 6.637 5.508 -Z3 4.470 3.630 3.036 2.532 2.147 1.816 1.493 1.203 0.968 -A -5LAT 4M -T1 294.1 287.2 274.0 259.9 245.3 230.9 216.8 204.4 197.5 198.4 203.6 -T2 209.5 215.0 219.9 224.3 228.8 233.8 239.9 246.5 253.0 259.2 264.5 -T3 267.8 268.9 268.1 265.5 261.5 256.4 251.4 246.5 241.6 234.0 230.0 -T4 221.5 214.8 211.3 208.5 205.9 203.2 200.7 198.9 -Z1 0.017 0.025 0.035 0.041 0.040 0.039 0.044 0.053 0.077 0.224 0.873 -Z2 2.215 3.909 6.006 8.322 10.041 10.643 9.767 8.742 7.643 6.352 5.221 -Z3 4.253 3.511 2.961 2.482 2.112 1.775 1.449 1.168 0.944 -A 5LAT 4M -T1 294.3 287.3 274.0 259.9 245.3 230.7 216.7 204.3 197.5 198.5 204.1 -T2 210.4 215.9 220.5 224.7 229.0 233.9 240.0 246.8 253.3 259.6 264.9 -T3 268.2 269.2 268.3 265.6 261.6 256.2 250.7 245.2 239.7 233.2 226.6 -T4 218.2 211.4 208.1 205.5 203.1 200.6 198.3 196.7 -Z1 0.024 0.031 0.038 0.042 0.042 0.041 0.043 0.067 0.096 0.280 0.967 -Z2 2.263 3.881 5.984 8.309 10.033 10.545 9.757 8.769 7.665 6.375 5.231 -Z3 4.265 3.495 2.948 2.473 2.109 1.776 1.450 1.165 0.941 -A 15LAT 4M -T1 294.0 286.6 272.9 258.4 243.7 229.6 216.4 205.2 198.9 199.7 205.1 -T2 211.3 216.6 221.2 225.2 229.3 233.9 239.6 245.8 252.0 258.1 263.3 -T3 266.8 268.3 267.7 265.2 260.9 254.9 249.4 244.0 238.7 232.0 226.0 -T4 218.3 212.2 208.7 206.0 203.4 200.7 198.2 196.3 -Z1 0.027 0.046 0.063 0.069 0.072 0.071 0.085 0.120 0.194 0.551 1.196 -Z2 2.375 3.977 5.962 7.988 9.365 9.914 9.683 8.826 7.746 6.600 5.443 -Z3 4.398 3.611 3.015 2.527 2.165 1.830 1.493 1.188 0.941 -A 25LAT 4M -T1 290.6 283.2 269.2 254.3 239.8 226.9 216.3 208.3 203.7 203.8 207.6 -T2 212.4 217.0 221.2 225.1 229.0 233.5 238.7 244.5 250.4 256.2 261.3 -T3 265.0 266.9 266.8 264.7 260.5 254.3 249.2 244.3 239.4 233.3 227.8 -T4 221.2 215.7 211.8 208.7 205.6 202.5 199.5 197.0 -Z1 0.035 0.051 0.062 0.068 0.073 0.078 0.099 0.136 0.209 0.501 1.394 -Z2 2.784 4.330 5.910 7.498 8.641 9.247 9.217 8.639 7.799 6.736 5.536 -Z3 4.514 3.708 3.092 2.613 2.221 1.867 1.521 1.201 0.947 -A 35LAT 4M -T1 284.8 277.3 263.3 248.5 234.6 223.5 216.7 212.9 210.7 210.2 211.7 -T2 214.4 217.4 220.7 224.0 227.5 231.6 236.8 242.7 248.5 254.3 259.5 -T3 263.5 265.9 266.5 265.0 261.4 255.7 250.8 246.0 241.2 235.1 230.0 -T4 224.0 218.5 214.2 210.3 206.4 202.4 198.6 195.4 -Z1 0.047 0.059 0.061 0.067 0.084 0.152 0.318 0.429 0.615 1.098 2.010 -Z2 3.258 4.411 5.599 6.788 7.811 8.515 8.749 8.440 7.714 6.608 5.403 -Z3 4.392 3.612 3.045 2.614 2.200 1.838 1.505 1.201 0.955 -A 45LAT 4M -T1 277.7 270.4 256.8 242.8 230.1 221.4 217.9 217.0 216.2 215.5 215.6 -T2 216.4 217.9 220.0 222.6 225.4 229.1 234.3 240.4 246.5 252.3 257.7 -T3 262.0 265.0 266.2 265.3 262.4 257.3 252.5 247.7 243.0 235.4 231.9 -T4 226.1 220.6 215.7 211.1 206.6 202.1 197.7 194.0 -Z1 0.037 0.055 0.061 0.067 0.088 0.217 0.476 0.624 0.924 1.549 2.463 -Z2 3.483 4.410 5.309 6.153 6.995 7.731 8.171 8.175 7.658 6.666 5.406 -Z3 4.319 3.507 2.928 2.499 2.110 1.774 1.458 1.173 0.939 -A 55LAT 4M -T1 270.4 263.8 251.2 238.2 227.3 221.0 219.6 219.8 219.4 218.8 218.5 -T2 218.5 219.1 220.4 222.3 224.6 227.8 232.6 238.4 244.2 249.9 255.2 -T3 259.8 263.3 265.1 264.9 262.6 257.9 253.3 248.8 244.3 237.3 233.6 -T4 228.2 222.8 217.9 213.1 208.4 203.7 199.2 195.0 -Z1 0.035 0.053 0.060 0.067 0.093 0.255 0.528 0.663 1.019 1.710 2.614 -Z2 3.585 4.387 5.083 5.744 6.381 6.974 7.492 7.728 7.554 6.849 5.686 -Z3 4.509 3.579 2.952 2.470 2.108 1.771 1.452 1.164 0.924 -A 65LAT 4M -T1 263.1 257.5 246.2 234.6 225.7 221.8 221.8 222.4 222.1 221.6 221.3 -T2 221.1 221.4 222.3 223.8 225.5 228.0 231.9 236.6 241.7 246.9 252.0 -T3 256.6 260.4 262.9 263.5 262.1 258.2 253.6 248.8 244.1 237.6 233.0 -T4 227.6 222.3 217.7 213.2 208.8 204.3 199.9 196.1 -Z1 0.028 0.052 0.060 0.068 0.121 0.321 0.606 0.810 1.240 1.966 2.890 -Z2 3.671 4.312 4.848 5.370 5.891 6.373 6.752 6.989 7.010 6.648 5.841 -Z3 4.742 3.746 3.034 2.516 2.124 1.777 1.437 1.132 0.889 -A 75LAT 4M -T1 256.2 251.6 241.8 231.6 225.0 223.1 223.9 224.7 224.6 224.2 224.0 -T2 223.9 224.1 224.8 225.7 226.9 228.6 231.3 234.8 239.0 243.6 248.2 -T3 252.8 257.0 260.1 261.7 261.5 258.6 253.6 248.3 243.0 236.9 230.6 -T4 224.5 219.0 214.6 210.7 206.9 203.1 199.2 196.0 -Z1 0.028 0.048 0.055 0.068 0.141 0.423 0.694 0.996 1.477 2.225 3.032 -Z2 3.779 4.415 4.693 4.980 5.396 5.759 6.025 6.164 6.182 6.088 5.496 -Z3 4.659 3.710 2.822 2.209 1.745 1.389 1.098 0.870 0.692 -A 85LAT 4M -T1 252.8 248.8 239.7 230.1 224.2 222.7 223.8 225.0 225.2 224.9 224.8 -T2 225.0 225.4 225.9 226.5 227.2 228.4 230.2 232.8 236.4 240.5 245.0 -T3 249.6 254.0 257.7 260.2 260.9 258.8 253.6 248.0 242.4 236.2 229.4 -T4 223.0 217.3 213.1 209.6 206.1 202.6 199.0 196.1 -Z1 0.022 0.047 0.054 0.066 0.154 0.467 0.774 1.205 1.623 2.368 3.210 -Z2 3.822 4.425 4.605 4.853 5.212 5.510 5.779 5.936 5.989 5.951 5.476 -Z3 4.687 3.730 2.796 2.173 1.714 1.367 1.072 0.854 0.678 -A-85LAT 5M -T1 247.3 243.4 235.8 226.8 218.6 213.7 211.7 210.2 207.2 203.0 199.7 -T2 198.0 197.8 198.6 200.1 201.6 202.8 203.6 205.3 210.6 218.9 227.8 -T3 236.1 243.3 249.3 253.8 257.0 259.3 254.9 249.5 244.1 237.6 231.7 -T4 225.1 220.0 216.6 214.0 211.5 209.0 206.7 205.0 -Z1 0.026 0.026 0.030 0.033 0.048 0.142 0.276 0.515 1.067 1.924 2.550 -Z2 2.816 2.862 3.011 3.299 3.514 3.701 4.057 4.413 4.713 4.888 4.951 -Z3 4.751 4.333 3.763 3.048 2.397 1.855 1.473 1.326 1.292 -A-75LAT 5M -T1 252.2 248.1 239.4 229.1 220.0 214.7 212.8 211.7 209.3 205.8 202.9 -T2 201.2 200.7 201.0 201.8 202.8 203.8 204.8 207.0 212.1 219.7 227.8 -T3 235.6 242.5 248.2 252.2 255.1 257.7 253.5 248.4 243.2 235.8 231.7 -T4 226.5 221.3 217.9 214.9 212.0 209.0 206.2 204.5 -Z1 0.028 0.030 0.033 0.038 0.057 0.156 0.303 0.551 1.139 1.929 2.554 -Z2 3.109 3.476 3.580 3.610 3.742 3.926 4.259 4.603 4.903 5.086 5.189 -Z3 4.998 4.561 3.956 3.204 2.519 1.939 1.510 1.341 1.281 -A-65LAT 5M -T1 261.5 256.1 245.0 233.0 223.2 217.7 216.1 215.4 213.8 211.6 209.5 -T2 208.0 207.0 206.6 206.6 206.7 207.2 208.5 210.9 215.2 221.1 227.5 -T3 233.8 239.8 245.0 248.9 252.0 254.7 250.8 245.9 241.1 233.4 230.4 -T4 227.3 224.2 220.2 216.4 212.5 208.8 204.9 203.6 -Z1 0.026 0.028 0.032 0.036 0.048 0.124 0.289 0.558 1.178 1.881 2.652 -Z2 3.232 3.695 3.962 4.146 4.238 4.332 4.603 4.929 5.250 5.489 5.637 -Z3 5.450 4.977 4.295 3.475 2.720 2.075 1.593 1.332 1.190 -A-55LAT 5M -T1 269.7 263.0 250.2 237.3 226.5 220.0 218.1 217.7 217.1 216.2 215.2 -T2 214.3 213.5 213.0 212.7 212.6 213.1 214.6 217.1 220.6 224.9 229.4 -T3 234.3 239.1 243.5 246.9 249.5 251.2 247.7 243.4 239.0 232.5 229.4 -T4 226.6 223.2 219.3 215.3 211.5 207.6 203.9 201.9 -Z1 0.025 0.032 0.038 0.040 0.050 0.096 0.211 0.332 0.674 1.337 2.158 -Z2 3.029 4.067 5.055 5.661 5.853 5.964 6.173 6.478 6.884 7.185 7.071 -Z3 6.445 5.389 4.270 3.294 2.627 2.092 1.612 1.199 0.882 -A-45LAT 5M -T1 276.3 269.2 255.8 242.1 229.9 221.5 217.8 216.7 216.3 216.2 216.4 -T2 216.7 217.1 217.6 218.1 218.8 220.1 222.3 225.2 228.7 232.5 236.5 -T3 240.5 244.4 247.5 249.6 250.4 249.8 246.1 241.9 237.7 231.9 228.3 -T4 224.7 219.5 215.8 212.3 208.9 205.3 202.0 200.5 -Z1 0.025 0.030 0.035 0.038 0.046 0.078 0.182 0.317 0.571 1.161 1.964 -Z2 3.043 4.267 5.424 5.913 6.029 6.184 6.380 6.679 7.078 7.363 7.219 -Z3 6.509 5.400 4.260 3.279 2.644 2.117 1.626 1.210 0.897 -A-35LAT 5M -T1 283.1 275.8 262.2 247.9 234.5 223.9 217.1 213.4 211.7 212.1 213.8 -T2 216.0 218.1 220.1 221.9 223.8 226.1 229.1 232.8 236.9 241.4 245.8 -T3 249.8 252.9 254.8 255.0 253.7 250.9 247.1 243.2 239.3 233.5 229.6 -T4 223.5 217.8 213.7 210.2 206.8 203.5 200.0 198.6 -Z1 0.023 0.035 0.038 0.042 0.046 0.074 0.161 0.250 0.412 0.962 1.744 -Z2 2.813 4.177 5.598 6.520 6.987 7.260 7.391 7.495 7.615 7.492 6.910 -Z3 5.830 4.640 3.684 2.934 2.425 1.980 1.565 1.208 0.933 -A-25LAT 5M -T1 288.8 281.7 268.4 254.1 240.1 227.4 217.0 209.1 205.2 206.0 209.4 -T2 213.6 217.5 220.9 223.9 226.9 230.3 234.2 238.8 243.8 249.2 254.2 -T3 258.1 260.7 261.5 260.2 257.4 253.2 249.2 245.2 241.1 234.2 230.8 -T4 223.5 217.1 212.9 209.7 206.5 203.2 200.1 197.9 -Z1 0.037 0.037 0.041 0.042 0.047 0.062 0.081 0.123 0.188 0.464 1.215 -Z2 2.466 4.081 5.876 7.267 8.051 8.326 8.293 8.082 7.827 7.283 6.269 -Z3 5.078 4.012 3.261 2.665 2.263 1.892 1.523 1.204 0.954 -A-15LAT 5M -T1 292.5 285.6 272.6 258.4 244.0 230.1 217.1 205.9 200.1 201.1 205.8 -T2 211.3 216.3 220.6 224.5 228.4 232.7 237.6 243.1 248.9 254.8 260.1 -T3 263.8 265.6 265.5 263.5 260.0 255.3 250.8 246.2 241.7 234.7 230.5 -T4 221.9 215.1 211.5 208.8 206.2 203.7 201.2 199.1 -Z1 0.017 0.025 0.033 0.038 0.037 0.037 0.039 0.059 0.093 0.236 0.911 -Z2 2.135 3.853 5.978 7.982 9.221 9.545 9.088 8.333 7.665 6.764 5.624 -Z3 4.530 3.687 3.079 2.586 2.191 1.838 1.493 1.200 0.969 -A -5LAT 5M -T1 293.8 286.9 274.0 259.9 245.4 231.0 217.1 204.8 198.2 199.3 204.7 -T2 210.6 216.0 220.6 224.7 229.0 233.7 239.4 245.7 251.8 257.8 263.0 -T3 266.3 267.5 266.8 264.5 260.9 256.3 251.2 246.1 240.9 233.3 228.4 -T4 219.3 212.4 209.0 207.0 205.0 203.0 201.0 199.3 -Z1 0.019 0.027 0.037 0.044 0.041 0.041 0.045 0.056 0.080 0.236 0.863 -Z2 2.155 3.945 6.045 8.313 9.940 10.212 9.509 8.562 7.360 6.280 5.241 -Z3 4.280 3.523 2.929 2.461 2.100 1.774 1.455 1.181 0.972 -A 5LAT 5M -T1 294.3 287.4 274.2 260.0 245.4 230.9 217.0 204.7 198.2 199.4 205.2 -T2 211.5 216.8 221.3 225.2 229.2 233.8 239.6 246.0 252.3 258.3 263.5 -T3 266.7 267.9 267.1 264.6 260.8 256.0 250.7 245.4 240.1 233.0 227.5 -T4 218.3 211.2 207.8 205.5 203.3 201.0 198.8 197.1 -Z1 0.024 0.024 0.032 0.036 0.035 0.036 0.058 0.068 0.106 0.318 1.007 -Z2 2.311 4.063 6.182 8.440 10.063 10.275 9.596 8.731 7.517 6.327 5.242 -Z3 4.226 3.463 2.891 2.478 2.086 1.763 1.479 1.227 1.030 -A 15LAT 5M -T1 294.9 287.4 273.6 259.1 244.4 230.1 216.7 205.4 199.4 200.7 206.3 -T2 212.5 217.7 222.0 225.8 229.6 234.0 239.4 245.4 251.5 257.4 262.7 -T3 266.2 267.7 267.2 264.8 260.7 255.0 249.9 244.8 239.7 232.8 227.6 -T4 219.3 212.6 208.8 205.8 202.9 200.0 197.3 195.3 -Z1 0.022 0.042 0.057 0.062 0.068 0.074 0.103 0.163 0.266 0.551 1.247 -Z2 2.475 4.258 6.237 8.176 9.605 10.054 9.631 8.796 7.816 6.604 5.354 -Z3 4.312 3.548 2.990 2.479 2.119 1.801 1.495 1.217 0.981 -A 25LAT 5M -T1 292.8 285.3 271.1 256.2 241.5 228.0 216.6 208.1 203.7 204.5 208.7 -T2 213.8 218.4 222.4 226.1 229.9 234.1 239.3 245.1 251.0 256.8 262.0 -T3 265.7 267.5 267.4 265.2 261.0 255.0 249.9 245.0 240.1 233.4 228.5 -T4 220.9 214.7 210.5 206.9 203.4 200.0 196.6 193.9 -Z1 0.034 0.052 0.061 0.069 0.074 0.082 0.102 0.148 0.239 0.514 1.426 -Z2 2.836 4.443 6.141 7.835 8.955 9.429 9.300 8.669 7.747 6.612 5.390 -Z3 4.358 3.568 2.987 2.495 2.127 1.788 1.485 1.225 0.998 -A 35LAT 5M -T1 288.4 280.8 266.5 251.6 237.2 225.2 217.2 212.8 210.5 210.5 212.6 -T2 215.7 219.2 222.6 226.1 229.7 233.9 239.2 245.2 251.2 256.8 262.0 -T3 265.8 267.9 268.2 266.4 262.5 256.4 251.2 246.2 241.2 234.3 229.3 -T4 222.0 215.7 210.8 206.4 202.0 197.5 193.2 189.7 -Z1 0.051 0.061 0.065 0.071 0.076 0.107 0.229 0.374 0.539 0.990 1.938 -Z2 3.136 4.397 5.831 7.244 8.220 8.758 8.779 8.327 7.464 6.322 5.148 -Z3 4.175 3.436 2.901 2.463 2.102 1.772 1.467 1.198 0.968 -A 45LAT 5M -T1 282.4 274.8 260.8 246.3 233.0 223.4 219.0 217.6 216.7 216.1 216.6 -T2 218.0 220.0 222.8 225.9 229.4 233.6 239.1 245.5 251.5 257.2 262.4 -T3 266.3 268.8 269.5 268.0 264.6 258.7 253.4 248.3 243.1 235.0 231.0 -T4 223.5 216.9 211.1 205.6 200.2 194.6 189.3 184.7 -Z1 0.035 0.057 0.065 0.072 0.086 0.170 0.417 0.561 0.808 1.403 2.240 -Z2 3.287 4.282 5.396 6.521 7.554 8.220 8.338 7.979 7.202 6.116 4.944 -Z3 4.000 3.278 2.770 2.350 2.019 1.712 1.420 1.155 0.927 -A 55LAT 5M -T1 276.1 268.9 255.6 241.9 230.1 223.1 221.2 221.2 220.8 220.2 220.1 -T2 220.5 221.7 223.8 226.5 229.7 233.7 239.2 245.5 251.6 257.3 262.5 -T3 266.7 269.5 270.6 269.6 266.7 261.3 256.1 250.9 245.8 237.7 233.8 -T4 226.6 219.8 213.3 207.1 200.8 194.5 188.4 183.0 -Z1 0.038 0.055 0.064 0.072 0.093 0.208 0.464 0.623 0.890 1.547 2.391 -Z2 3.336 4.166 5.001 5.918 6.806 7.430 7.665 7.511 6.948 5.974 4.862 -Z3 3.916 3.201 2.691 2.292 1.959 1.660 1.383 1.129 0.902 -A 65LAT 5M -T1 269.8 263.6 251.4 238.7 228.7 224.1 223.9 224.3 224.0 223.6 223.4 -T2 223.6 224.4 226.1 228.4 231.1 234.6 239.5 245.3 251.1 256.8 262.1 -T3 266.5 269.8 271.4 271.0 268.5 263.7 258.5 253.2 248.0 240.4 235.7 -T4 228.9 222.2 215.5 208.6 201.8 195.1 188.6 183.1 -Z1 0.029 0.052 0.063 0.074 0.123 0.343 0.583 0.728 1.119 1.801 2.632 -Z2 3.431 4.010 4.546 5.135 5.744 6.288 6.626 6.646 6.315 5.589 4.605 -Z3 3.712 3.047 2.584 2.230 1.930 1.647 1.357 1.090 0.872 -A 75LAT 5M -T1 263.7 258.5 247.7 236.3 228.5 226.0 226.7 227.2 227.0 226.6 226.6 -T2 226.8 227.5 228.8 230.6 232.6 235.5 239.6 244.7 250.2 255.8 261.2 -T3 265.9 269.6 271.8 272.0 270.1 266.0 260.7 255.2 249.7 243.7 236.7 -T4 229.8 222.8 215.9 209.0 202.0 195.1 188.3 183.1 -Z1 0.023 0.048 0.060 0.079 0.177 0.488 0.700 0.928 1.390 2.136 2.922 -Z2 3.590 3.972 4.281 4.618 5.002 5.451 5.860 6.106 6.163 5.998 5.207 -Z3 4.272 3.335 2.563 2.054 1.655 1.341 1.084 0.867 0.694 -A 85LAT 5M -T1 260.8 256.0 245.6 234.9 228.2 226.5 227.5 228.3 228.1 227.6 227.5 -T2 228.0 228.9 230.0 231.4 232.9 235.3 238.9 243.6 248.8 254.4 259.8 -T3 264.8 268.9 271.6 272.4 271.4 268.1 262.5 256.6 250.8 244.1 237.2 -T4 230.2 223.1 216.2 209.2 202.2 195.2 188.4 183.1 -Z1 0.014 0.047 0.060 0.070 0.151 0.486 0.670 0.870 1.372 2.100 2.870 -Z2 3.503 3.858 4.201 4.363 4.662 5.081 5.542 5.868 6.039 6.033 5.301 -Z3 4.330 3.309 2.472 1.972 1.602 1.317 1.072 0.851 0.672 -A-85LAT 6M -T1 245.1 241.3 233.6 224.3 215.5 209.5 206.2 203.7 200.2 195.9 192.6 -T2 191.1 191.3 192.7 194.9 197.1 199.0 200.2 202.6 209.0 218.6 228.9 -T3 238.3 246.3 252.7 257.3 261.0 264.9 259.1 251.9 244.6 233.6 228.7 -T4 222.7 218.1 216.5 216.0 215.4 214.8 214.2 214.2 -Z1 0.030 0.030 0.032 0.034 0.041 0.101 0.274 0.503 1.032 1.879 2.573 -Z2 2.862 2.901 3.055 3.180 3.236 3.381 3.851 4.344 4.744 4.899 4.773 -Z3 4.401 3.834 3.137 2.492 1.983 1.580 1.232 1.224 1.247 -A-75LAT 6M -T1 250.4 246.3 237.4 226.8 217.1 210.6 207.4 205.3 202.4 198.6 195.6 -T2 194.0 193.8 194.8 196.4 198.2 199.9 201.6 204.5 210.7 219.6 229.0 -T3 237.8 245.3 251.3 255.6 259.0 263.0 257.6 250.8 244.0 231.5 229.3 -T4 225.3 221.5 219.3 218.1 216.9 215.7 214.6 214.1 -Z1 0.031 0.033 0.036 0.038 0.049 0.118 0.266 0.524 1.121 1.989 2.662 -Z2 3.056 3.266 3.470 3.458 3.395 3.519 3.952 4.409 4.788 4.962 4.888 -Z3 4.539 3.974 3.272 2.596 2.045 1.602 1.244 1.217 1.229 -A-65LAT 6M -T1 260.2 254.7 243.4 231.1 220.7 214.2 211.5 210.1 208.0 205.4 203.0 -T2 201.4 200.6 200.5 200.9 201.6 202.6 204.3 207.3 212.6 219.7 227.2 -T3 234.4 241.1 246.7 251.0 254.7 259.0 254.4 248.4 242.4 230.9 229.7 -T4 229.0 227.7 225.0 222.5 220.1 217.6 215.1 214.3 -Z1 0.030 0.032 0.034 0.038 0.046 0.089 0.242 0.530 0.973 1.686 2.362 -Z2 3.189 3.694 4.021 4.050 3.966 3.958 4.260 4.627 4.978 5.215 5.250 -Z3 4.973 4.426 3.671 2.905 2.265 1.744 1.331 1.204 1.138 -A-55LAT 6M -T1 268.7 261.8 248.7 235.5 224.5 217.7 215.3 214.7 213.8 212.5 211.0 -T2 209.8 208.8 208.1 207.7 207.5 207.9 209.5 212.2 216.2 221.1 226.5 -T3 232.1 237.6 242.7 246.8 250.4 254.0 250.5 246.0 241.4 232.7 231.8 -T4 230.9 229.6 226.4 223.3 220.1 217.1 213.8 212.5 -Z1 0.026 0.035 0.038 0.041 0.048 0.121 0.306 0.519 0.835 1.466 2.335 -Z2 3.447 4.354 5.045 5.429 5.526 5.723 6.092 6.563 7.011 7.220 6.912 -Z3 6.123 5.102 4.049 3.135 2.498 1.983 1.544 1.169 0.886 -A-45LAT 6M -T1 275.2 267.8 254.1 240.3 228.3 220.4 217.1 216.1 215.6 215.3 215.1 -T2 215.0 215.0 215.0 215.1 215.4 216.2 218.2 221.0 224.6 228.7 233.0 -T3 237.6 242.0 245.8 248.4 250.1 251.0 247.8 243.9 240.0 233.6 231.8 -T4 229.5 225.2 221.7 218.5 215.3 212.1 209.0 207.6 -Z1 0.028 0.033 0.036 0.039 0.044 0.088 0.252 0.401 0.706 1.285 2.202 -Z2 3.279 4.554 5.480 5.838 5.874 5.918 6.093 6.426 6.890 7.229 7.090 -Z3 6.377 5.242 4.073 3.070 2.433 1.928 1.497 1.149 0.890 -A-35LAT 6M -T1 281.5 274.1 260.5 246.3 233.5 223.6 217.5 214.0 212.4 212.6 214.1 -T2 215.9 217.7 219.3 220.8 222.4 224.4 227.3 230.9 235.1 239.8 244.4 -T3 248.6 252.1 254.2 254.6 253.5 251.3 247.8 244.1 240.5 233.9 231.2 -T4 225.3 219.6 215.6 212.4 209.0 205.7 202.3 200.9 -Z1 0.023 0.036 0.041 0.043 0.052 0.092 0.210 0.311 0.534 1.095 1.987 -Z2 3.188 4.610 5.755 6.393 6.764 7.022 7.153 7.294 7.441 7.345 6.711 -Z3 5.600 4.388 3.446 2.749 2.308 1.931 1.586 1.276 1.026 -A-25LAT 6M -T1 287.2 280.3 267.2 253.3 239.6 227.4 217.4 209.8 206.1 206.9 210.3 -T2 214.1 217.6 220.8 223.5 226.4 229.6 233.5 238.0 243.1 248.6 253.8 -T3 257.9 260.6 261.5 260.2 257.3 253.2 248.8 244.5 240.2 232.9 228.9 -T4 221.3 214.7 210.6 207.8 204.9 202.1 199.2 197.4 -Z1 0.031 0.031 0.041 0.048 0.051 0.072 0.093 0.119 0.180 0.432 1.280 -Z2 2.693 4.297 5.833 6.928 7.597 7.905 7.851 7.758 7.551 7.062 6.061 -Z3 4.834 3.837 3.149 2.578 2.215 1.891 1.569 1.267 1.010 -A-15LAT 6M -T1 291.4 284.7 272.0 258.1 243.8 230.0 217.2 206.5 201.1 202.4 207.1 -T2 212.1 216.6 220.6 224.2 227.8 231.8 236.6 241.9 247.6 253.6 258.9 -T3 262.7 264.7 264.7 262.9 259.4 254.8 249.9 244.9 240.0 232.6 227.4 -T4 218.2 211.1 207.7 205.8 204.0 202.1 200.2 198.4 -Z1 0.019 0.029 0.037 0.042 0.047 0.044 0.049 0.066 0.103 0.268 1.019 -Z2 2.196 3.863 5.893 7.728 8.837 8.961 8.420 7.964 7.507 6.768 5.700 -Z3 4.588 3.765 3.112 2.588 2.185 1.833 1.496 1.201 0.959 -A -5LAT 6M -T1 292.9 286.2 273.4 259.5 245.0 230.8 217.3 205.6 199.5 200.9 206.1 -T2 211.6 216.4 220.5 224.3 228.2 232.5 237.9 243.9 249.9 255.9 261.1 -T3 264.5 265.9 265.4 263.3 259.9 255.6 250.5 245.2 240.0 232.5 226.9 -T4 217.1 209.9 206.8 205.4 204.1 202.8 201.5 199.8 -Z1 0.026 0.030 0.041 0.047 0.047 0.045 0.050 0.063 0.102 0.304 0.942 -Z2 2.069 3.832 5.925 8.086 9.500 9.627 9.039 8.161 7.522 6.684 5.606 -Z3 4.598 3.800 3.174 2.636 2.208 1.838 1.477 1.164 0.920 -A 5LAT 6M -T1 293.8 286.9 273.8 259.7 245.2 230.9 217.2 205.5 199.4 201.0 206.7 -T2 212.5 217.3 221.3 224.8 228.5 232.7 238.2 244.3 250.4 256.4 261.5 -T3 264.9 266.1 265.6 263.5 260.0 255.6 250.6 245.6 240.5 232.8 228.1 -T4 218.4 211.0 207.5 205.4 203.4 201.3 199.4 197.6 -Z1 0.023 0.024 0.035 0.048 0.044 0.047 0.060 0.082 0.123 0.362 1.051 -Z2 2.285 4.064 6.141 8.209 9.604 9.757 9.368 8.537 7.722 6.653 5.580 -Z3 4.601 3.831 3.207 2.631 2.229 1.861 1.496 1.186 0.943 -A 15LAT 6M -T1 295.3 287.8 273.9 259.5 245.0 230.6 217.1 205.9 200.3 201.9 207.5 -T2 213.3 218.1 222.0 225.4 228.9 233.0 238.2 244.0 250.0 255.9 261.1 -T3 264.6 266.2 266.0 263.9 260.3 255.2 250.4 245.7 240.9 233.8 229.3 -T4 220.2 213.0 208.8 205.7 202.6 199.4 196.5 194.2 -Z1 0.018 0.038 0.050 0.049 0.051 0.053 0.095 0.168 0.249 0.474 1.193 -Z2 2.442 4.152 6.166 8.125 9.363 9.807 9.459 8.787 7.885 6.714 5.565 -Z3 4.568 3.759 3.152 2.639 2.260 1.917 1.558 1.223 0.947 -A 25LAT 6M -T1 295.0 287.3 273.0 258.3 243.8 229.9 217.6 208.1 203.4 204.6 209.2 -T2 214.3 218.8 222.6 226.1 229.7 233.8 238.9 244.6 250.4 256.0 261.1 -T3 264.6 266.4 266.4 264.6 260.9 255.3 250.3 245.5 240.7 233.5 229.2 -T4 220.6 213.7 209.1 205.2 201.4 197.5 193.8 191.0 -Z1 0.023 0.038 0.052 0.057 0.061 0.061 0.084 0.131 0.215 0.483 1.394 -Z2 2.672 4.320 6.119 7.787 8.863 9.361 9.209 8.647 7.766 6.625 5.411 -Z3 4.393 3.677 3.115 2.653 2.281 1.940 1.599 1.271 0.988 -A 35LAT 6M -T1 292.1 284.3 269.9 255.1 240.7 228.1 218.7 212.6 209.6 209.9 212.7 -T2 216.4 220.1 223.7 227.1 230.6 234.8 240.1 245.9 251.7 257.1 262.0 -T3 265.6 267.6 267.8 266.1 262.5 256.6 251.3 246.1 240.9 233.3 228.6 -T4 220.2 212.8 207.5 202.5 197.5 192.5 187.8 183.9 -Z1 0.056 0.065 0.068 0.074 0.078 0.093 0.178 0.287 0.445 0.904 1.874 -Z2 2.985 4.339 5.878 7.332 8.305 8.754 8.722 8.242 7.419 6.269 5.103 -Z3 4.188 3.505 2.978 2.549 2.216 1.888 1.562 1.261 0.996 -A 45LAT 6M -T1 286.6 279.0 264.8 250.2 236.4 225.9 220.4 218.1 216.7 216.4 217.4 -T2 219.4 221.9 225.0 228.3 231.9 236.1 241.6 247.8 253.6 259.1 263.9 -T3 267.6 269.8 270.2 268.7 265.3 259.5 253.9 248.4 242.9 234.3 229.6 -T4 221.1 213.1 206.3 200.0 193.6 187.1 181.0 175.6 -Z1 0.028 0.056 0.066 0.078 0.092 0.157 0.353 0.478 0.711 1.183 2.018 -Z2 3.111 4.221 5.508 6.801 7.734 8.239 8.296 7.972 7.270 6.195 5.036 -Z3 4.109 3.421 2.912 2.539 2.178 1.851 1.534 1.249 1.000 -A 55LAT 6M -T1 281.2 273.9 260.3 246.1 233.3 225.0 222.5 222.2 221.8 221.4 221.7 -T2 222.7 224.3 226.9 230.0 233.5 237.8 243.4 249.7 255.7 261.2 266.1 -T3 269.9 272.2 272.9 271.7 268.7 263.3 257.7 252.2 246.6 238.3 233.1 -T4 225.1 216.8 208.9 201.1 193.1 185.2 177.5 171.1 -Z1 0.033 0.049 0.063 0.071 0.094 0.200 0.396 0.498 0.792 1.367 2.182 -Z2 3.127 4.037 5.060 6.086 6.874 7.368 7.515 7.344 6.777 5.830 4.748 -Z3 3.844 3.195 2.728 2.402 2.049 1.734 1.433 1.147 0.906 -A 65LAT 6M -T1 276.4 269.8 257.1 243.5 232.0 225.8 225.0 225.4 225.3 225.3 225.6 -T2 226.3 227.6 229.8 232.6 235.8 239.8 245.2 251.3 257.2 262.8 267.8 -T3 271.8 274.4 275.3 274.5 271.8 266.6 261.4 256.1 250.9 243.2 237.8 -T4 230.3 222.0 213.1 204.1 195.0 185.9 176.7 170.5 -Z1 0.026 0.049 0.063 0.071 0.097 0.245 0.468 0.576 0.916 1.555 2.349 -Z2 3.039 3.707 4.382 5.150 5.847 6.358 6.609 6.574 6.197 5.427 4.457 -Z3 3.625 3.016 2.600 2.262 1.981 1.694 1.394 1.116 0.897 -A 75LAT 6M -T1 270.9 265.3 253.9 241.4 232.0 228.0 228.2 228.8 228.8 228.8 229.2 -T2 229.9 231.0 232.9 235.3 238.0 241.4 246.3 252.0 257.8 263.5 268.7 -T3 273.0 275.9 277.3 276.8 274.4 269.5 264.6 259.7 254.8 250.3 242.8 -T4 235.2 226.8 217.2 207.2 197.1 187.0 177.6 170.1 -Z1 0.027 0.045 0.058 0.072 0.134 0.412 0.562 0.747 1.183 1.855 2.565 -Z2 3.109 3.495 3.817 4.194 4.585 4.989 5.427 5.842 5.960 5.384 4.639 -Z3 3.841 3.039 2.293 1.956 1.653 1.394 1.217 1.040 0.873 -A 85LAT 6M -T1 267.2 262.1 251.3 239.9 232.2 229.5 230.0 230.7 230.6 230.3 230.6 -T2 231.4 232.6 234.3 236.3 238.6 241.7 246.2 251.6 257.3 263.0 268.5 -T3 273.0 276.4 278.2 278.2 276.3 271.8 266.8 261.9 256.9 252.3 244.8 -T4 237.4 229.2 219.2 208.8 198.3 187.7 178.0 157.7 -Z1 0.020 0.040 0.053 0.065 0.139 0.439 0.553 0.700 1.168 1.855 2.564 -Z2 3.014 3.288 3.671 4.046 4.503 5.039 5.497 5.785 5.877 5.732 4.918 -Z3 3.972 3.045 2.311 1.883 1.555 1.291 1.057 0.833 0.649 -A-85LAT 7M -T1 246.2 242.2 234.0 224.1 214.2 206.5 201.6 198.1 194.3 190.1 187.1 -T2 186.0 186.8 189.3 192.7 196.2 199.3 201.7 205.2 212.9 223.9 235.3 -T3 245.5 253.7 260.1 264.2 267.3 270.8 263.5 254.7 245.8 232.0 226.3 -T4 220.5 215.6 214.3 214.0 213.6 213.2 212.8 212.5 -Z1 0.029 0.029 0.033 0.035 0.040 0.083 0.253 0.507 1.033 1.849 2.559 -Z2 2.874 2.910 3.132 3.292 3.484 3.776 4.248 4.535 4.625 4.522 4.241 -Z3 3.810 3.289 2.754 2.240 1.811 1.479 1.264 1.231 1.255 -A-75LAT 7M -T1 250.2 246.1 237.1 226.1 215.4 207.4 202.8 200.0 196.7 193.0 190.1 -T2 188.9 189.3 191.3 194.2 197.3 200.4 203.5 207.8 215.5 225.9 236.6 -T3 246.1 253.8 259.6 263.1 265.5 268.3 261.6 253.5 245.4 231.1 227.7 -T4 223.4 219.2 217.3 216.3 215.2 214.2 213.1 212.5 -Z1 0.032 0.034 0.037 0.040 0.049 0.102 0.277 0.569 1.049 1.970 2.610 -Z2 3.006 3.232 3.330 3.459 3.661 3.926 4.371 4.653 4.772 4.743 4.550 -Z3 4.155 3.610 2.988 2.398 1.917 1.550 1.305 1.227 1.221 -A-65LAT 7M -T1 259.3 253.8 242.5 230.1 219.0 211.5 207.9 205.8 203.5 200.7 198.4 -T2 197.0 196.7 197.5 199.0 200.8 203.1 206.4 211.0 218.0 226.7 235.5 -T3 243.5 250.2 255.3 258.6 260.9 263.5 257.9 251.2 244.4 232.0 230.1 -T4 228.1 225.9 223.4 221.0 218.6 216.3 214.0 212.5 -Z1 0.030 0.033 0.037 0.041 0.049 0.098 0.277 0.565 1.082 1.839 2.509 -Z2 3.105 3.493 3.918 3.974 3.960 4.079 4.469 4.812 5.065 5.183 5.088 -Z3 4.728 4.150 3.417 2.707 2.125 1.681 1.389 1.203 1.090 -A-55LAT 7M -T1 267.9 261.1 248.0 234.7 223.4 216.2 213.5 212.6 211.5 210.1 208.7 -T2 207.5 206.8 206.7 206.9 207.5 208.9 211.8 215.9 221.3 227.6 234.0 -T3 240.1 245.5 249.9 252.9 255.0 256.6 252.6 247.8 243.0 234.1 232.6 -T4 230.5 228.3 225.0 222.0 218.8 215.7 212.6 211.0 -Z1 0.029 0.036 0.040 0.042 0.056 0.137 0.319 0.641 1.029 1.669 2.484 -Z2 3.559 4.403 4.905 5.099 5.199 5.482 6.012 6.648 7.139 7.256 6.753 -Z3 5.802 4.814 3.827 2.976 2.370 1.873 1.476 1.139 0.889 -A-45LAT 7M -T1 274.6 267.2 253.5 239.7 227.8 220.1 216.9 216.0 215.3 214.8 214.6 -T2 214.6 214.8 215.2 215.7 216.4 217.9 220.6 224.3 228.6 233.4 238.3 -T3 242.9 247.1 250.2 251.9 252.4 251.4 248.0 244.3 240.5 234.2 232.3 -T4 229.0 224.9 221.3 218.0 214.6 211.3 208.1 205.9 -Z1 0.029 0.034 0.038 0.040 0.050 0.110 0.307 0.492 0.834 1.459 2.377 -Z2 3.580 4.679 5.474 5.797 5.868 6.036 6.334 6.730 7.119 7.183 6.692 -Z3 5.753 4.673 3.745 2.998 2.485 2.038 1.627 1.265 0.983 -A-35LAT 7M -T1 280.7 273.3 259.7 245.7 233.2 223.8 218.0 214.6 213.0 213.1 214.5 -T2 216.2 218.1 219.8 221.5 223.3 225.7 228.9 232.9 237.4 242.2 246.9 -T3 251.0 254.2 256.0 256.0 254.2 250.6 247.0 243.5 239.9 234.3 231.1 -T4 225.4 220.1 216.3 212.9 209.6 206.3 202.8 201.1 -Z1 0.022 0.036 0.042 0.046 0.059 0.120 0.255 0.347 0.550 1.097 2.070 -Z2 3.426 4.721 5.717 6.385 6.807 7.151 7.339 7.473 7.564 7.386 6.663 -Z3 5.475 4.365 3.532 2.923 2.507 2.115 1.720 1.360 1.075 -A-25LAT 7M -T1 286.4 279.6 266.7 252.8 239.3 227.3 217.6 210.4 207.0 207.9 211.1 -T2 214.6 217.9 220.9 223.6 226.4 229.6 233.6 238.2 243.4 249.0 254.2 -T3 258.2 260.9 261.7 260.4 257.3 252.6 248.2 243.8 239.4 232.9 228.4 -T4 221.4 215.3 211.5 208.6 205.8 203.0 200.1 198.3 -Z1 0.042 0.042 0.051 0.055 0.063 0.073 0.096 0.123 0.216 0.545 1.468 -Z2 2.964 4.531 5.859 6.904 7.585 7.917 7.919 7.840 7.684 7.179 6.211 -Z3 4.977 4.005 3.292 2.722 2.342 1.985 1.632 1.306 1.036 -A-15LAT 7M -T1 290.6 284.1 271.5 257.6 243.2 229.5 217.0 206.8 202.1 203.8 208.3 -T2 212.8 216.8 220.4 223.7 227.0 230.8 235.5 240.8 246.6 252.6 258.1 -T3 262.1 264.3 264.5 262.7 259.3 254.8 249.7 244.4 239.2 232.0 226.4 -T4 218.0 211.5 208.0 205.9 203.9 201.9 199.9 198.1 -Z1 0.022 0.028 0.038 0.041 0.040 0.041 0.046 0.068 0.115 0.329 1.192 -Z2 2.373 4.072 5.875 7.538 8.524 8.682 8.404 8.144 7.746 7.025 5.871 -Z3 4.712 3.827 3.169 2.652 2.239 1.867 1.518 1.223 1.000 -A -5LAT 7M -T1 292.0 285.4 272.8 258.8 244.2 230.1 217.0 205.9 200.6 202.5 207.5 -T2 212.4 216.6 220.3 223.7 227.2 231.2 236.4 242.2 248.3 254.5 259.9 -T3 263.6 265.3 265.1 263.2 260.1 256.2 250.9 245.4 239.9 232.5 226.5 -T4 217.5 210.7 207.3 205.5 203.7 201.9 200.2 198.6 -Z1 0.028 0.035 0.045 0.049 0.049 0.048 0.053 0.067 0.113 0.365 1.052 -Z2 2.213 3.895 5.997 8.120 9.164 9.322 8.916 8.430 7.800 6.905 5.739 -Z3 4.633 3.816 3.135 2.592 2.164 1.802 1.475 1.192 0.959 -A 5LAT 7M -T1 293.1 286.1 273.1 259.0 244.5 230.2 216.9 205.9 200.6 202.6 207.9 -T2 213.2 217.5 221.0 224.3 227.6 231.5 236.6 242.5 248.6 254.8 260.2 -T3 263.9 265.5 265.3 263.4 260.2 256.5 251.6 246.5 241.4 233.4 229.1 -T4 220.2 213.2 209.6 207.0 204.5 202.0 199.6 197.8 -Z1 0.026 0.030 0.039 0.048 0.052 0.058 0.066 0.094 0.134 0.480 1.207 -Z2 2.435 4.164 6.249 8.295 9.392 9.680 9.425 8.726 7.925 6.848 5.650 -Z3 4.582 3.766 3.113 2.551 2.122 1.773 1.468 1.191 0.968 -A 15LAT 7M -T1 295.1 287.4 273.6 259.3 244.8 230.5 217.2 206.4 201.3 203.2 208.6 -T2 213.9 218.2 221.7 224.9 228.1 232.0 236.8 242.4 248.2 254.2 259.6 -T3 263.3 265.2 265.3 263.4 260.1 255.5 251.1 246.7 242.3 235.5 231.5 -T4 223.3 216.5 212.2 208.8 205.3 201.8 198.6 196.4 -Z1 0.014 0.036 0.047 0.040 0.037 0.037 0.049 0.095 0.210 0.501 1.245 -Z2 2.562 4.320 6.268 8.111 9.275 9.740 9.511 8.882 7.986 6.807 5.591 -Z3 4.550 3.744 3.121 2.638 2.254 1.881 1.517 1.207 0.951 -A 25LAT 7M -T1 295.7 287.8 273.4 259.0 244.7 230.8 218.2 208.4 203.9 205.2 209.8 -T2 214.6 218.8 222.4 225.6 229.0 232.8 237.6 243.0 248.5 254.1 259.1 -T3 262.7 264.7 264.9 263.2 259.8 254.5 250.0 245.7 241.3 234.7 231.1 -T4 223.1 216.3 211.9 208.0 204.1 200.2 196.6 193.8 -Z1 0.016 0.029 0.043 0.053 0.054 0.053 0.062 0.095 0.202 0.529 1.378 -Z2 2.700 4.394 6.174 7.773 8.788 9.197 9.095 8.596 7.788 6.664 5.431 -Z3 4.455 3.698 3.128 2.680 2.321 1.956 1.589 1.265 0.994 -A 35LAT 7M -T1 294.2 286.3 271.8 257.3 243.2 230.3 219.8 212.5 209.1 209.7 212.8 -T2 216.6 220.3 223.7 226.9 230.3 234.2 239.0 244.4 249.8 254.9 259.6 -T3 263.1 265.2 265.6 264.1 260.7 254.9 249.7 244.7 239.7 233.1 227.7 -T4 220.2 213.2 208.2 203.7 199.2 194.7 190.5 187.2 -Z1 0.051 0.059 0.063 0.072 0.074 0.081 0.108 0.174 0.364 0.842 1.694 -Z2 2.868 4.302 5.923 7.346 8.242 8.629 8.577 8.191 7.460 6.362 5.202 -Z3 4.268 3.554 3.035 2.627 2.242 1.887 1.572 1.285 1.026 -A 45LAT 7M -T1 289.7 282.0 267.8 253.3 239.5 228.3 221.5 217.9 216.0 216.0 217.4 -T2 219.8 222.5 225.5 228.7 232.1 236.1 241.1 246.6 252.0 257.1 261.7 -T3 265.3 267.5 268.0 266.6 263.2 257.4 251.7 246.0 240.3 232.3 226.7 -T4 219.0 211.6 205.6 200.0 194.3 188.6 183.2 179.1 -Z1 0.023 0.054 0.066 0.079 0.091 0.132 0.250 0.351 0.580 1.064 1.906 -Z2 2.965 4.153 5.549 6.780 7.545 7.958 7.992 7.696 7.024 5.982 4.890 -Z3 3.984 3.294 2.808 2.438 2.087 1.768 1.488 1.222 0.980 -A 55LAT 7M -T1 284.4 277.0 263.5 249.2 235.8 226.6 223.2 222.5 221.9 221.6 222.1 -T2 223.3 225.1 227.7 230.8 234.2 238.2 243.5 249.3 254.9 260.1 264.8 -T3 268.4 270.6 271.3 270.1 267.1 261.6 255.8 250.0 244.3 236.3 230.2 -T4 222.6 214.8 207.6 200.5 193.4 186.4 179.2 174.8 -Z1 0.032 0.048 0.060 0.073 0.087 0.177 0.348 0.447 0.718 1.255 2.071 -Z2 2.992 4.016 5.157 6.086 6.711 7.149 7.272 7.077 6.501 5.562 4.520 -Z3 3.661 3.027 2.577 2.250 1.955 1.671 1.415 1.184 0.980 -A 65LAT 7M -T1 279.9 273.1 260.2 246.3 233.9 226.7 225.4 225.9 225.9 225.9 226.2 -T2 226.9 228.3 230.6 233.4 236.6 240.5 245.6 251.4 257.0 262.4 267.2 -T3 270.9 273.3 274.2 273.5 270.9 265.9 260.4 254.8 249.2 242.0 236.0 -T4 228.1 220.4 212.2 204.0 195.8 187.5 179.8 165.1 -Z1 0.022 0.045 0.060 0.068 0.091 0.207 0.418 0.529 0.863 1.444 2.242 -Z2 2.919 3.657 4.304 4.930 5.483 5.963 6.196 6.167 5.802 5.047 4.152 -Z3 3.402 2.841 2.441 2.139 1.890 1.648 1.390 1.137 0.928 -A 75LAT 7M -T1 274.7 269.0 257.2 244.2 233.5 228.4 228.3 229.2 229.3 229.4 229.7 -T2 230.3 231.4 233.3 235.8 238.5 242.0 246.7 252.3 257.8 263.3 268.4 -T3 272.4 275.2 276.5 276.1 273.9 269.2 264.0 258.6 253.3 248.2 240.5 -T4 232.9 225.0 216.3 207.5 198.6 189.8 181.1 167.6 -Z1 0.023 0.041 0.055 0.070 0.120 0.330 0.481 0.623 1.031 1.664 2.393 -Z2 2.841 3.225 3.568 4.029 4.651 5.255 5.661 5.835 5.762 5.415 4.528 -Z3 3.647 2.859 2.252 1.858 1.535 1.267 1.040 0.834 0.662 -A 85LAT 7M -T1 270.8 265.7 254.7 242.7 233.8 230.1 230.2 231.0 231.0 230.6 230.8 -T2 231.6 232.8 234.5 236.7 239.1 242.2 246.7 252.0 257.6 263.2 268.5 -T3 272.8 275.9 277.6 277.7 276.0 271.8 266.4 261.0 255.6 249.9 242.5 -T4 235.0 227.0 218.2 209.1 200.0 190.9 181.6 169.1 -Z1 0.019 0.031 0.046 0.061 0.110 0.368 0.489 0.628 1.077 1.688 2.368 -Z2 2.782 3.060 3.319 3.729 4.344 4.998 5.452 5.703 5.716 5.431 4.535 -Z3 3.615 2.780 2.150 1.795 1.509 1.266 1.042 0.816 0.625 -A-85LAT 8M -T1 244.5 240.7 232.7 223.0 213.2 205.2 199.7 196.0 192.4 188.5 186.1 -T2 185.9 187.7 191.2 195.9 200.8 205.4 209.5 214.8 223.7 235.7 247.9 -T3 258.1 265.9 271.4 274.4 275.9 277.4 268.3 257.7 247.1 229.8 224.1 -T4 218.1 213.2 212.2 211.9 211.8 211.6 211.3 210.7 -Z1 0.032 0.032 0.033 0.036 0.041 0.075 0.230 0.464 0.878 1.591 2.279 -Z2 2.692 2.870 3.017 3.420 3.948 4.271 4.278 4.171 4.040 3.995 3.889 -Z3 3.609 3.175 2.621 2.146 1.767 1.495 1.345 1.129 1.010 -A-75LAT 8M -T1 249.4 245.4 236.4 225.4 214.5 206.1 200.9 197.8 194.6 191.2 189.1 -T2 188.9 190.5 193.9 198.4 203.2 208.0 212.9 218.9 227.8 238.9 250.0 -T3 259.1 266.0 270.4 272.4 272.6 271.9 263.9 254.8 245.8 230.5 226.1 -T4 221.4 216.9 215.3 214.4 213.5 212.6 211.7 210.7 -Z1 0.030 0.032 0.035 0.039 0.049 0.106 0.273 0.507 0.947 1.582 2.101 -Z2 2.480 2.638 2.855 3.389 3.957 4.308 4.373 4.351 4.298 4.279 4.145 -Z3 3.820 3.350 2.804 2.317 1.896 1.563 1.356 1.129 1.002 -A-65LAT 8M -T1 258.8 253.3 242.1 229.5 218.1 210.1 206.1 204.0 201.9 199.6 198.1 -T2 197.8 198.8 201.1 204.3 207.9 212.0 216.9 223.0 230.8 239.8 248.5 -T3 255.7 261.0 264.5 266.0 265.7 263.8 257.7 251.1 244.5 233.3 230.3 -T4 227.2 224.2 221.6 219.4 217.2 214.9 212.7 210.9 -Z1 0.029 0.032 0.037 0.040 0.050 0.102 0.283 0.521 0.932 1.444 2.016 -Z2 2.493 2.768 3.159 3.656 4.200 4.723 5.096 5.267 5.286 5.220 4.957 -Z3 4.477 3.848 3.164 2.575 2.078 1.688 1.430 1.202 1.054 -A-55LAT 8M -T1 267.7 260.7 247.6 234.3 222.9 215.6 212.9 212.2 211.4 210.4 209.7 -T2 209.5 209.8 210.9 212.5 214.4 217.1 221.2 226.2 232.0 238.1 244.1 -T3 249.2 253.3 256.0 257.3 256.9 254.1 250.2 246.2 242.2 235.3 233.2 -T4 230.2 227.0 223.7 220.6 217.4 214.3 211.3 208.9 -Z1 0.028 0.036 0.040 0.047 0.061 0.163 0.399 0.609 1.038 1.733 2.801 -Z2 3.895 4.653 4.985 5.145 5.552 6.086 6.457 6.628 6.639 6.367 5.796 -Z3 5.035 4.204 3.471 2.836 2.352 1.928 1.560 1.254 1.007 -A-45LAT 8M -T1 274.4 267.0 253.3 239.6 227.9 220.4 217.5 216.7 216.3 216.1 216.2 -T2 216.7 217.5 218.5 219.7 221.2 223.3 226.6 230.7 235.0 239.5 243.9 -T3 247.8 251.0 253.1 253.7 252.4 248.4 245.3 242.4 239.5 235.1 232.8 -T4 229.0 224.4 220.9 217.4 213.8 210.4 207.1 204.8 -Z1 0.029 0.035 0.039 0.043 0.057 0.154 0.356 0.506 0.899 1.579 2.616 -Z2 3.847 4.929 5.556 5.892 6.268 6.638 6.959 7.136 7.216 6.993 6.348 -Z3 5.435 4.495 3.682 3.006 2.495 2.026 1.611 1.263 0.993 -A-35LAT 8M -T1 280.6 273.3 259.7 245.8 233.5 224.4 218.7 215.4 213.9 214.2 215.6 -T2 217.5 219.5 221.4 223.4 225.5 228.1 231.5 235.6 240.1 244.7 249.0 -T3 252.8 255.5 256.9 256.4 254.0 248.9 245.4 242.2 239.0 234.9 231.0 -T4 225.7 220.8 216.9 213.5 210.2 206.7 203.4 201.1 -Z1 0.024 0.037 0.044 0.048 0.067 0.135 0.260 0.349 0.644 1.310 2.446 -Z2 3.734 5.017 5.759 6.382 6.914 7.255 7.435 7.559 7.558 7.208 6.309 -Z3 5.201 4.228 3.518 2.921 2.435 1.999 1.607 1.274 1.024 -A-25LAT 8M -T1 286.5 279.7 266.7 253.0 239.6 227.8 218.1 210.9 207.6 208.6 211.7 -T2 215.1 218.3 221.2 224.0 226.9 230.2 234.3 239.1 244.3 249.9 255.0 -T3 259.0 261.4 262.1 260.7 257.4 252.0 247.5 243.0 238.6 232.8 227.9 -T4 221.4 216.0 212.3 209.5 206.7 203.9 201.2 199.1 -Z1 0.048 0.048 0.055 0.059 0.067 0.085 0.113 0.148 0.243 0.552 1.669 -Z2 3.126 4.564 5.762 6.692 7.550 7.912 8.024 8.046 7.816 7.165 5.975 -Z3 4.793 3.907 3.256 2.690 2.274 1.890 1.533 1.228 0.993 -A-15LAT 8M -T1 290.7 284.2 271.7 257.8 243.5 229.8 217.3 207.2 202.6 204.3 208.7 -T2 213.0 216.8 220.3 223.5 226.8 230.7 235.5 241.1 247.1 253.3 258.9 -T3 262.9 265.0 265.2 263.4 259.8 254.9 249.5 244.0 238.5 231.5 225.4 -T4 217.7 211.7 208.3 206.0 203.8 201.6 199.4 197.7 -Z1 0.024 0.032 0.042 0.044 0.042 0.038 0.044 0.063 0.114 0.389 1.224 -Z2 2.363 3.996 5.808 7.468 8.623 9.227 9.030 8.572 8.023 7.050 5.689 -Z3 4.520 3.665 3.059 2.545 2.177 1.821 1.471 1.169 0.945 -A -5LAT 8M -T1 291.9 285.5 273.0 259.0 244.5 230.3 217.2 206.2 201.1 203.0 207.9 -T2 212.5 216.5 220.0 223.3 226.8 230.9 236.2 242.4 248.7 255.1 260.7 -T3 264.5 266.2 266.0 264.1 260.8 256.7 251.2 245.5 239.8 232.8 226.1 -T4 217.8 211.3 207.9 205.5 203.3 201.1 198.9 197.4 -Z1 0.029 0.041 0.049 0.051 0.050 0.051 0.051 0.063 0.115 0.382 1.038 -Z2 2.132 3.808 5.852 8.081 9.470 10.065 9.721 8.983 8.119 6.974 5.653 -Z3 4.488 3.656 3.032 2.516 2.148 1.801 1.463 1.175 0.959 -A 5LAT 8M -T1 293.1 286.3 273.4 259.3 244.7 230.4 217.1 206.1 201.0 203.0 208.3 -T2 213.3 217.3 220.7 223.8 227.1 231.1 236.4 242.6 249.0 255.4 261.0 -T3 264.8 266.5 266.2 264.2 260.9 256.9 252.0 247.0 242.1 234.0 230.2 -T4 221.9 215.4 211.5 208.5 205.6 202.6 200.0 198.0 -Z1 0.024 0.028 0.038 0.057 0.063 0.058 0.072 0.106 0.140 0.493 1.161 -Z2 2.317 4.028 6.077 8.250 9.724 10.390 10.075 9.263 8.126 6.842 5.566 -Z3 4.481 3.654 3.045 2.529 2.168 1.835 1.481 1.169 0.937 -A 15LAT 8M -T1 295.3 287.7 274.0 259.7 245.1 230.7 217.3 206.4 201.5 203.6 208.9 -T2 213.9 217.9 221.3 224.3 227.5 231.4 236.3 242.1 248.1 254.3 259.9 -T3 263.8 265.7 265.8 263.9 260.4 255.7 251.6 247.6 243.6 237.3 234.0 -T4 226.3 219.9 215.5 211.8 208.0 204.3 200.8 198.5 -Z1 0.013 0.031 0.046 0.040 0.034 0.033 0.041 0.073 0.193 0.529 1.203 -Z2 2.434 4.170 6.188 8.126 9.516 10.111 9.862 9.138 8.158 7.001 5.785 -Z3 4.698 3.776 3.110 2.593 2.215 1.894 1.545 1.221 0.955 -A 25LAT 8M -T1 295.8 288.0 273.8 259.3 244.9 230.9 218.2 208.5 204.1 205.6 210.1 -T2 214.7 218.5 221.9 224.9 228.1 231.8 236.4 241.8 247.3 253.0 258.1 -T3 261.8 264.0 264.3 262.7 259.3 254.0 249.9 246.0 242.1 235.9 232.7 -T4 225.4 219.1 214.7 210.7 206.8 202.9 199.2 196.6 -Z1 0.016 0.029 0.044 0.050 0.050 0.050 0.056 0.077 0.173 0.504 1.258 -Z2 2.495 4.180 6.077 7.829 8.981 9.427 9.300 8.855 8.145 7.150 5.935 -Z3 4.823 3.948 3.305 2.738 2.314 1.950 1.583 1.254 0.986 -A 35LAT 8M -T1 294.3 286.4 272.0 257.4 243.1 230.1 219.5 212.3 209.1 209.8 212.9 -T2 216.6 220.0 223.1 226.0 229.0 232.6 237.0 242.1 247.2 252.3 256.9 -T3 260.6 262.9 263.5 262.2 258.9 253.3 248.3 243.5 238.6 233.3 227.1 -T4 220.0 213.6 209.1 204.9 200.9 196.9 193.1 190.4 -Z1 0.048 0.056 0.060 0.067 0.071 0.075 0.099 0.149 0.318 0.771 1.595 -Z2 2.708 4.184 5.883 7.389 8.354 8.759 8.800 8.539 7.957 7.007 5.812 -Z3 4.726 3.942 3.368 2.863 2.458 2.062 1.667 1.308 1.001 -A 45LAT 8M -T1 289.6 281.9 267.9 253.4 239.3 227.9 220.9 217.2 215.5 215.6 217.1 -T2 219.3 221.8 224.5 227.3 230.3 233.8 238.3 243.3 248.3 253.2 257.6 -T3 261.3 263.7 264.6 263.4 260.2 254.4 248.7 243.1 237.4 230.3 224.2 -T4 216.7 209.9 204.7 199.9 195.1 190.2 185.6 182.6 -Z1 0.025 0.054 0.064 0.072 0.080 0.103 0.179 0.270 0.511 0.983 1.791 -Z2 2.772 4.032 5.468 6.690 7.448 7.912 8.100 7.977 7.535 6.658 5.527 -Z3 4.512 3.778 3.207 2.741 2.380 2.030 1.682 1.355 1.071 -A 55LAT 8M -T1 283.5 276.3 262.9 248.7 235.2 225.9 222.3 221.5 221.0 220.8 221.2 -T2 222.1 223.7 225.9 228.6 231.6 235.1 239.7 244.9 250.0 254.9 259.4 -T3 263.1 265.7 266.7 265.9 263.0 257.4 251.9 246.3 240.8 234.1 227.6 -T4 220.0 212.7 206.3 200.0 193.8 187.5 181.8 177.4 -Z1 0.032 0.048 0.059 0.069 0.076 0.132 0.254 0.373 0.657 1.206 1.989 -Z2 2.873 3.876 4.999 5.884 6.514 7.014 7.256 7.241 6.918 6.158 5.079 -Z3 4.110 3.394 2.902 2.524 2.176 1.849 1.537 1.244 0.992 -A 65LAT 8M -T1 278.2 271.6 258.8 245.0 232.6 225.4 224.1 224.7 224.7 224.6 224.7 -T2 225.0 226.0 227.8 230.2 232.9 236.2 240.6 245.7 250.8 255.8 260.4 -T3 264.3 267.1 268.6 268.3 266.0 261.3 256.2 251.1 246.0 240.2 233.7 -T4 226.2 218.7 211.3 204.1 196.7 189.4 182.5 177.5 -Z1 0.021 0.044 0.055 0.065 0.079 0.181 0.325 0.456 0.818 1.418 2.169 -Z2 2.815 3.300 4.117 4.849 5.446 5.969 6.320 6.435 6.262 5.696 4.771 -Z3 3.847 3.165 2.689 2.329 2.020 1.721 1.424 1.146 0.918 -A 75LAT 8M -T1 272.8 267.0 255.2 242.3 231.7 226.6 226.6 227.6 227.8 227.6 227.6 -T2 227.8 228.5 229.9 231.8 233.9 236.7 240.6 245.2 250.1 255.2 260.1 -T3 264.4 267.8 269.8 270.0 268.5 264.6 259.8 255.0 250.1 245.8 238.4 -T4 230.8 223.3 215.6 207.9 200.3 192.6 184.9 180.3 -Z1 0.025 0.042 0.056 0.069 0.108 0.277 0.405 0.587 0.992 1.666 2.343 -Z2 2.801 3.113 3.391 3.706 4.267 4.796 5.203 5.395 5.378 5.162 4.502 -Z3 3.785 3.080 2.460 2.009 1.639 1.335 1.082 0.857 0.680 -A 85LAT 8M -T1 269.3 263.8 252.5 240.5 231.5 227.9 228.2 229.2 229.2 228.6 228.4 -T2 228.7 229.5 230.8 232.3 234.0 236.4 239.9 244.2 249.1 254.4 259.5 -T3 264.0 267.8 270.3 271.2 270.4 267.4 262.6 257.5 252.4 247.6 240.2 -T4 232.7 225.1 217.4 209.6 201.8 194.1 186.3 181.7 -Z1 0.023 0.039 0.050 0.058 0.095 0.296 0.395 0.597 1.041 1.712 2.349 -Z2 2.864 3.158 3.073 3.370 3.922 4.429 4.850 5.090 5.162 5.084 4.537 -Z3 3.846 3.094 2.374 1.877 1.518 1.251 1.021 0.812 0.643 -A-85LAT 9M -T1 244.9 240.8 232.8 223.4 213.7 205.8 200.3 196.9 194.1 191.7 190.7 -T2 191.7 194.6 199.5 205.7 212.1 218.1 223.6 229.7 238.6 249.6 260.3 -T3 268.8 274.7 278.5 280.3 280.7 279.3 269.2 257.8 246.5 227.5 221.9 -T4 215.7 211.3 210.1 210.0 210.0 210.0 209.8 209.1 -Z1 0.027 0.027 0.033 0.036 0.041 0.080 0.220 0.359 0.483 0.716 1.119 -Z2 1.379 1.698 2.444 3.336 3.892 3.900 3.910 4.069 4.247 4.247 3.970 -Z3 3.558 3.067 2.562 2.123 1.736 1.438 1.284 0.979 0.748 -A-75LAT 9M -T1 250.1 245.9 236.8 226.0 215.2 206.7 201.7 199.1 196.9 194.9 194.2 -T2 195.2 198.2 203.0 209.0 215.3 221.3 227.2 233.7 241.8 251.3 260.4 -T3 267.4 272.0 274.6 275.6 274.7 271.0 262.6 253.5 244.4 229.7 224.7 -T4 219.2 214.7 213.3 212.6 211.9 211.1 210.2 208.9 -Z1 0.029 0.032 0.035 0.040 0.051 0.106 0.259 0.407 0.553 0.790 1.104 -Z2 1.377 1.723 2.620 3.424 4.002 4.096 4.259 4.511 4.720 4.691 4.359 -Z3 3.902 3.362 2.786 2.285 1.855 1.518 1.304 1.060 0.890 -A-65LAT 9M -T1 260.0 254.3 242.9 230.3 219.0 211.2 207.6 206.2 205.0 203.9 203.8 -T2 204.8 207.1 210.7 215.2 219.9 224.8 230.1 236.0 242.5 249.7 256.3 -T3 261.4 264.8 266.6 267.1 265.7 261.2 255.4 249.5 243.6 234.8 230.5 -T4 226.2 222.3 219.8 217.8 215.6 213.6 211.4 209.2 -Z1 0.030 0.033 0.038 0.042 0.052 0.103 0.258 0.421 0.561 0.805 1.193 -Z2 1.623 2.045 3.031 3.921 4.677 5.178 5.498 5.755 5.879 5.757 5.245 -Z3 4.590 3.856 3.117 2.523 2.043 1.676 1.422 1.184 1.019 -A-55LAT 9M -T1 268.6 261.6 248.4 235.2 224.0 217.0 214.7 214.3 214.2 214.1 214.4 -T2 215.3 216.7 218.7 221.1 223.8 226.9 230.9 235.6 240.4 245.3 249.9 -T3 253.7 256.5 258.2 258.6 257.3 253.0 249.3 245.7 242.2 236.6 233.9 -T4 229.7 225.6 222.3 219.2 216.1 213.0 209.9 207.1 -Z1 0.027 0.036 0.041 0.048 0.074 0.183 0.360 0.574 1.022 1.792 2.899 -Z2 3.939 4.736 5.106 5.435 6.010 6.582 6.892 7.018 7.001 6.692 6.058 -Z3 5.190 4.285 3.509 2.870 2.389 1.961 1.580 1.250 0.997 -A-45LAT 9M -T1 275.0 267.6 254.0 240.4 228.9 221.4 218.6 217.9 217.7 218.0 218.7 -T2 219.8 221.1 222.6 224.2 226.0 228.4 231.7 235.7 239.8 243.9 247.7 -T3 251.2 254.0 255.6 255.8 254.3 250.0 246.7 243.7 240.6 235.7 233.1 -T4 228.6 224.2 220.3 216.7 213.2 209.6 206.0 203.2 -Z1 0.030 0.036 0.043 0.049 0.062 0.155 0.313 0.488 0.844 1.605 2.656 -Z2 3.840 4.881 5.630 6.336 7.001 7.435 7.630 7.757 7.687 7.279 6.415 -Z3 5.360 4.377 3.587 2.954 2.468 2.029 1.625 1.276 1.002 -A-35LAT 9M -T1 281.0 273.8 260.3 246.4 234.0 224.7 219.0 215.8 214.4 214.9 216.5 -T2 218.5 220.6 222.7 224.7 226.9 229.7 233.3 237.6 242.2 246.8 251.3 -T3 255.0 257.7 259.0 258.4 255.8 250.9 247.0 243.3 239.6 235.5 231.0 -T4 225.8 221.3 217.5 214.2 210.8 207.3 204.0 201.2 -Z1 0.024 0.041 0.050 0.058 0.072 0.145 0.256 0.359 0.684 1.333 2.495 -Z2 3.845 4.968 5.851 6.675 7.352 7.830 8.098 8.257 8.106 7.422 6.220 -Z3 5.017 4.063 3.362 2.811 2.384 1.976 1.602 1.275 1.018 -A-25LAT 9M -T1 287.1 280.2 267.1 253.1 239.6 227.6 217.9 210.8 207.6 208.7 211.9 -T2 215.3 218.4 221.4 224.2 227.2 230.7 235.0 240.1 245.5 251.2 256.5 -T3 260.6 263.0 263.6 262.0 258.4 252.8 247.9 243.2 238.4 232.9 227.4 -T4 221.5 216.6 213.2 210.4 207.7 204.9 202.1 199.8 -Z1 0.056 0.056 0.062 0.070 0.076 0.081 0.095 0.136 0.249 0.603 1.602 -Z2 3.081 4.502 5.743 7.013 8.009 8.545 8.716 8.612 8.119 7.082 5.766 -Z3 4.640 3.827 3.190 2.653 2.270 1.899 1.545 1.235 0.999 -A-15LAT 9M -T1 291.3 284.6 271.8 257.8 243.4 229.6 217.1 207.0 202.4 204.1 208.5 -T2 212.8 216.7 220.3 223.7 227.2 231.3 236.3 242.2 248.3 254.6 260.3 -T3 264.3 266.4 266.4 264.2 260.2 254.6 248.9 243.2 237.5 231.0 224.3 -T4 217.4 211.9 208.6 206.2 203.8 201.3 199.0 197.3 -Z1 0.023 0.035 0.047 0.049 0.051 0.046 0.050 0.067 0.135 0.429 1.208 -Z2 2.374 4.025 5.830 7.673 9.131 9.724 9.488 8.829 7.981 6.839 5.494 -Z3 4.444 3.665 3.096 2.551 2.182 1.822 1.479 1.188 0.970 -A -5LAT 9M -T1 292.4 285.8 273.1 259.1 244.5 230.2 217.0 206.0 200.8 202.7 207.5 -T2 212.3 216.4 220.1 223.6 227.2 231.6 237.2 243.6 250.1 256.5 262.2 -T3 265.9 267.5 267.1 264.7 260.8 255.8 250.3 244.6 239.0 233.2 225.7 -T4 218.1 211.9 208.3 205.6 202.9 200.2 197.8 196.2 -Z1 0.032 0.045 0.052 0.059 0.059 0.060 0.061 0.071 0.118 0.384 1.054 -Z2 2.167 3.820 5.964 8.107 9.702 10.383 9.974 8.965 7.928 6.678 5.426 -Z3 4.352 3.578 3.000 2.511 2.127 1.779 1.449 1.167 0.956 -A 5LAT 9M -T1 293.3 286.4 273.4 259.3 244.7 230.3 216.8 205.8 200.7 202.7 207.9 -T2 213.0 217.1 220.7 224.0 227.4 231.7 237.3 243.7 250.3 256.7 262.4 -T3 266.1 267.7 267.2 264.9 261.0 255.9 251.3 246.7 242.2 234.9 231.3 -T4 223.8 217.6 213.6 210.1 206.7 203.3 200.2 198.4 -Z1 0.026 0.033 0.040 0.062 0.070 0.073 0.084 0.110 0.160 0.523 1.223 -Z2 2.362 3.980 6.100 8.230 9.780 10.487 10.154 9.200 7.943 6.628 5.416 -Z3 4.382 3.599 3.019 2.523 2.131 1.780 1.448 1.169 0.955 -A 15LAT 9M -T1 295.2 287.5 273.7 259.4 244.7 230.1 216.8 206.1 201.2 203.2 208.5 -T2 213.6 217.7 221.2 224.3 227.6 231.5 236.7 242.6 248.9 255.2 260.9 -T3 264.9 266.9 266.9 264.6 260.6 255.1 251.4 248.0 244.6 239.0 236.4 -T4 229.3 223.3 218.9 214.8 210.8 206.8 202.9 200.7 -Z1 0.016 0.031 0.040 0.039 0.034 0.036 0.044 0.071 0.176 0.479 1.191 -Z2 2.435 4.134 6.107 8.049 9.442 10.014 9.677 8.921 7.925 6.765 5.534 -Z3 4.429 3.638 3.032 2.510 2.133 1.798 1.471 1.182 0.961 -A 25LAT 9M -T1 295.0 287.1 272.9 258.4 243.8 229.7 217.2 207.9 203.8 205.3 209.7 -T2 214.3 218.2 221.5 224.5 227.5 231.2 235.8 241.2 246.9 252.8 258.3 -T3 262.3 264.7 265.1 263.3 259.4 253.8 250.1 246.6 243.1 237.1 234.4 -T4 227.7 222.0 217.5 213.4 209.5 205.6 201.9 199.3 -Z1 0.026 0.036 0.043 0.048 0.046 0.048 0.055 0.073 0.149 0.446 1.226 -Z2 2.476 4.145 5.981 7.669 8.840 9.293 9.133 8.656 7.995 6.998 5.737 -Z3 4.589 3.710 3.080 2.558 2.155 1.813 1.493 1.211 0.986 -A 35LAT 9M -T1 292.2 284.3 270.0 255.4 241.0 228.2 218.2 211.7 208.9 209.6 212.5 -T2 215.9 219.1 222.0 224.6 227.4 230.7 235.0 240.0 245.2 250.5 255.4 -T3 259.4 262.1 262.9 261.6 258.3 252.7 247.7 242.9 238.0 232.8 226.5 -T4 219.8 214.2 209.9 206.3 202.7 199.1 195.6 193.8 -Z1 0.044 0.053 0.055 0.058 0.058 0.066 0.085 0.130 0.291 0.723 1.533 -Z2 2.620 4.090 5.762 7.145 7.996 8.375 8.419 8.217 7.756 6.916 5.738 -Z3 4.640 3.788 3.141 2.605 2.217 1.863 1.518 1.208 0.962 -A 45LAT 9M -T1 285.9 278.4 264.5 250.2 236.5 225.7 219.4 216.4 215.0 214.9 216.0 -T2 217.8 219.8 222.1 224.6 227.2 230.3 234.4 239.1 243.9 248.7 253.3 -T3 257.1 260.0 261.3 260.6 257.8 252.4 246.6 240.8 235.0 228.2 221.5 -T4 214.6 208.6 203.9 199.8 195.8 191.8 187.7 186.4 -Z1 0.025 0.048 0.057 0.064 0.075 0.107 0.176 0.268 0.526 1.046 1.840 -Z2 2.737 3.876 5.258 6.319 7.031 7.464 7.703 7.713 7.457 6.802 5.734 -Z3 4.662 3.797 3.166 2.656 2.255 1.886 1.541 1.235 0.994 -A 55LAT 9M -T1 278.7 271.7 258.7 244.8 232.1 223.7 220.7 220.1 219.6 219.1 219.0 -T2 219.4 220.4 222.0 224.1 226.4 229.3 233.2 237.8 242.4 247.0 251.3 -T3 255.2 258.3 260.1 260.0 257.9 253.0 247.8 242.5 237.3 232.0 224.8 -T4 217.5 210.8 205.0 199.6 194.1 188.8 183.4 181.2 -Z1 0.025 0.044 0.055 0.061 0.074 0.122 0.215 0.344 0.637 1.194 1.972 -Z2 2.741 3.696 4.698 5.430 5.989 6.505 6.878 7.072 7.049 6.620 5.746 -Z3 4.691 3.769 3.110 2.604 2.211 1.861 1.526 1.224 0.961 -A 65LAT 9M -T1 273.1 266.6 254.1 240.8 229.3 223.0 222.0 222.4 222.2 221.6 221.0 -T2 220.7 220.9 222.0 223.5 225.3 227.7 231.0 235.0 239.4 243.8 248.3 -T3 252.4 256.0 258.4 259.3 258.2 254.3 250.1 246.0 241.8 238.1 231.7 -T4 224.2 217.1 210.5 204.1 197.6 191.3 184.7 181.8 -Z1 0.024 0.042 0.053 0.063 0.075 0.172 0.282 0.439 0.785 1.435 2.155 -Z2 2.785 3.419 3.929 4.424 4.947 5.456 5.895 6.250 6.426 6.236 5.581 -Z3 4.612 3.697 3.018 2.508 2.121 1.788 1.463 1.169 0.920 -A 75LAT 9M -T1 267.5 261.8 250.4 238.0 228.1 223.6 223.6 224.3 224.0 223.1 222.3 -T2 221.7 221.6 222.1 222.9 224.0 225.6 228.1 231.3 235.2 239.6 244.0 -T3 248.5 252.7 256.0 258.0 258.3 256.1 252.6 249.0 245.4 243.3 236.4 -T4 228.8 221.6 214.9 208.4 201.9 195.5 188.8 185.4 -Z1 0.028 0.041 0.049 0.060 0.092 0.234 0.358 0.563 1.011 1.682 2.347 -Z2 2.788 3.290 3.506 3.625 3.836 4.043 4.347 4.665 4.949 5.130 5.060 -Z3 4.698 4.110 3.388 2.705 2.120 1.639 1.268 0.981 0.773 -A 85LAT 9M -T1 264.0 258.6 247.7 236.1 227.7 224.4 224.6 225.1 224.5 223.1 222.1 -T2 221.7 221.6 221.9 222.3 222.8 223.8 225.7 228.5 232.0 236.2 240.6 -T3 245.3 249.8 253.9 256.9 258.7 258.1 254.7 251.0 247.3 245.4 238.0 -T4 230.4 223.1 216.5 210.1 203.6 197.3 190.8 187.2 -Z1 0.026 0.038 0.048 0.059 0.098 0.273 0.363 0.581 1.017 1.696 2.310 -Z2 2.774 3.223 3.400 3.402 3.456 3.497 3.641 3.837 4.048 4.221 4.364 -Z3 4.252 3.916 3.407 2.755 2.130 1.570 1.119 0.801 0.595 -A-85LAT10M -T1 246.0 241.9 233.8 224.2 214.8 207.7 204.0 202.5 202.0 202.2 204.1 -T2 207.8 213.1 219.7 227.2 234.7 241.4 246.8 252.0 258.5 266.3 273.5 -T3 278.6 281.3 282.4 282.2 279.8 273.3 265.0 256.6 248.3 235.9 229.5 -T4 222.9 217.2 213.2 209.7 206.2 202.6 199.2 196.0 -Z1 0.027 0.027 0.030 0.034 0.043 0.088 0.213 0.254 0.159 0.138 0.291 -Z2 0.566 1.432 3.079 4.051 4.794 5.482 5.553 5.460 5.256 4.976 4.470 -Z3 3.853 3.171 2.483 1.973 1.583 1.289 1.061 0.844 0.665 -A-75LAT10M -T1 252.0 247.4 238.0 227.1 216.7 209.5 206.5 205.9 205.9 206.4 208.2 -T2 211.5 216.0 221.8 228.3 235.0 240.9 246.0 251.0 256.8 263.3 269.4 -T3 273.6 275.8 276.6 276.3 274.1 267.8 260.7 253.7 246.6 236.7 230.7 -T4 224.5 218.8 214.6 210.8 206.9 203.1 199.3 196.0 -Z1 0.026 0.029 0.034 0.038 0.051 0.114 0.246 0.264 0.229 0.351 0.681 -Z2 1.245 2.312 3.734 4.588 5.247 5.803 5.906 5.814 5.576 5.242 4.667 -Z3 3.993 3.282 2.607 2.103 1.696 1.369 1.109 0.883 0.705 -A-65LAT10M -T1 261.6 255.7 244.1 231.8 221.3 214.9 213.1 213.4 213.8 214.5 215.8 -T2 218.1 221.1 225.0 229.3 233.7 238.0 242.3 246.7 251.6 256.7 261.5 -T3 265.1 267.4 268.4 268.3 266.4 261.3 255.9 250.6 245.3 237.7 233.2 -T4 227.5 222.2 217.6 213.2 208.7 204.3 200.0 196.2 -Z1 0.025 0.029 0.034 0.041 0.053 0.112 0.249 0.284 0.320 0.551 0.987 -Z2 1.553 2.522 4.195 5.356 6.126 6.499 6.655 6.600 6.357 5.954 5.208 -Z3 4.375 3.542 2.812 2.290 1.871 1.534 1.264 1.040 0.876 -A-55LAT10M -T1 269.9 262.9 249.9 237.0 226.4 220.2 218.7 219.1 219.6 220.2 221.1 -T2 222.4 224.1 226.2 228.5 231.0 233.9 237.6 241.7 246.1 250.5 254.6 -T3 258.1 260.7 262.1 262.2 260.6 256.4 252.2 247.9 243.7 237.4 233.8 -T4 228.1 222.7 217.8 213.2 208.4 203.7 199.1 195.1 -Z1 0.024 0.035 0.043 0.052 0.069 0.185 0.338 0.495 1.047 1.926 3.020 -Z2 4.055 4.951 5.733 6.286 6.832 7.143 7.276 7.276 7.103 6.590 5.705 -Z3 4.670 3.761 3.079 2.538 2.150 1.796 1.472 1.176 0.931 -A-45LAT10M -T1 276.2 269.0 255.7 242.3 230.7 223.2 220.1 219.3 219.2 219.7 220.6 -T2 221.8 223.3 224.9 226.7 228.7 231.4 235.1 239.5 244.1 248.7 253.0 -T3 256.7 259.6 261.1 260.8 258.8 254.6 250.3 246.1 242.0 235.4 231.9 -T4 226.0 220.5 215.7 211.2 206.6 202.1 197.7 193.9 -Z1 0.027 0.034 0.043 0.051 0.075 0.176 0.297 0.442 0.849 1.667 2.742 -Z2 3.852 4.828 5.758 6.633 7.348 7.656 7.798 7.822 7.630 6.976 5.891 -Z3 4.697 3.786 3.127 2.605 2.207 1.836 1.490 1.185 0.940 -A-35LAT10M -T1 282.3 275.3 261.9 247.9 235.1 225.2 218.9 215.4 213.9 214.5 216.2 -T2 218.3 220.5 222.9 225.3 227.9 231.0 235.3 240.2 245.4 250.7 255.7 -T3 259.7 262.4 263.4 262.4 259.4 254.2 249.6 245.1 240.7 235.0 230.0 -T4 224.0 218.5 214.2 210.3 206.4 202.4 198.6 195.4 -Z1 0.028 0.039 0.050 0.059 0.069 0.142 0.240 0.312 0.588 1.290 2.443 -Z2 3.706 4.805 5.834 6.822 7.587 8.108 8.310 8.328 7.987 7.083 5.739 -Z3 4.536 3.656 3.050 2.592 2.201 1.843 1.506 1.197 0.950 -A-25LAT10M -T1 288.1 281.3 268.1 253.8 240.0 227.7 217.6 210.1 206.7 207.7 210.9 -T2 214.5 218.0 221.3 224.5 227.9 231.8 236.6 242.1 248.0 253.9 259.4 -T3 263.4 265.8 266.1 264.2 260.2 254.2 249.1 244.2 239.4 233.2 227.8 -T4 221.2 215.6 211.8 208.7 205.6 202.5 199.5 196.9 -Z1 0.053 0.053 0.067 0.074 0.086 0.095 0.110 0.134 0.243 0.639 1.680 -Z2 3.019 4.461 5.768 7.111 8.173 8.802 8.952 8.749 8.046 6.836 5.475 -Z3 4.405 3.610 3.035 2.572 2.195 1.842 1.498 1.188 0.955 -A-15LAT10M -T1 292.0 285.2 272.2 258.0 243.6 229.6 216.8 206.3 201.3 202.8 207.3 -T2 212.0 216.3 220.3 224.1 228.0 232.5 237.9 244.0 250.2 256.5 262.1 -T3 266.0 267.8 267.5 265.1 260.8 254.7 249.3 243.9 238.6 231.9 225.9 -T4 218.3 212.3 208.7 206.0 203.4 200.7 198.2 196.2 -Z1 0.019 0.036 0.055 0.057 0.054 0.053 0.059 0.072 0.141 0.433 1.250 -Z2 2.394 4.013 5.850 7.724 9.254 9.958 9.568 8.839 7.902 6.697 5.378 -Z3 4.367 3.602 3.025 2.543 2.162 1.804 1.468 1.170 0.946 -A -5LAT10M -T1 292.7 286.1 273.4 259.4 244.8 230.3 216.7 205.1 199.5 201.1 206.2 -T2 211.3 215.9 220.1 224.0 228.1 232.9 238.7 245.3 251.8 258.1 263.5 -T3 267.0 268.3 267.7 265.2 261.1 255.7 250.2 244.8 239.4 233.1 226.5 -T4 218.2 211.6 208.1 205.6 203.1 200.7 198.3 196.7 -Z1 0.028 0.040 0.056 0.062 0.060 0.061 0.064 0.068 0.095 0.338 1.010 -Z2 2.118 3.845 5.920 8.167 9.857 10.483 9.826 8.630 7.709 6.593 5.373 -Z3 4.306 3.561 2.977 2.500 2.111 1.777 1.455 1.169 0.944 -A 5LAT10M -T1 293.4 286.6 273.6 259.5 244.9 230.3 216.5 205.0 199.4 201.2 206.6 -T2 212.1 216.6 220.6 224.3 228.2 232.7 238.6 245.2 251.7 258.0 263.5 -T3 267.0 268.3 267.7 265.2 261.2 255.8 250.9 246.2 241.4 234.0 230.0 -T4 221.5 214.8 211.3 208.5 205.8 203.1 200.6 198.8 -Z1 0.028 0.040 0.046 0.056 0.060 0.062 0.073 0.087 0.130 0.397 1.121 -Z2 2.232 3.923 6.028 8.208 9.741 10.295 9.691 8.648 7.714 6.576 5.403 -Z3 4.348 3.587 3.022 2.520 2.117 1.779 1.456 1.178 0.965 -A 15LAT10M -T1 294.5 287.0 273.3 259.0 244.2 229.7 216.2 205.3 200.1 201.9 207.3 -T2 212.7 217.1 220.9 224.3 227.8 232.0 237.3 243.4 249.6 255.9 261.5 -T3 265.4 267.3 267.2 264.9 260.9 255.3 251.1 247.1 243.2 237.0 233.5 -T4 225.6 219.1 215.2 211.8 208.5 205.2 202.1 199.8 -Z1 0.016 0.034 0.044 0.044 0.042 0.041 0.050 0.072 0.146 0.448 1.129 -Z2 2.324 4.002 5.974 7.986 9.327 9.756 9.394 8.662 7.784 6.682 5.491 -Z3 4.465 3.677 3.048 2.540 2.178 1.834 1.494 1.200 0.983 -A 25LAT10M -T1 293.0 285.3 271.3 256.7 242.1 228.3 216.4 207.4 203.3 204.5 208.8 -T2 213.4 217.3 220.6 223.7 226.8 230.4 235.1 240.5 246.3 252.3 257.9 -T3 262.1 264.6 265.1 263.4 259.7 254.3 250.2 246.3 242.4 235.8 235.6 -T4 231.6 223.7 217.8 213.9 209.9 206.0 201.8 198.8 -Z1 0.027 0.040 0.045 0.051 0.052 0.053 0.060 0.074 0.130 0.409 1.182 -Z2 2.381 4.022 5.836 7.532 8.658 9.035 8.897 8.540 7.971 7.024 5.823 -Z3 4.685 3.801 3.146 2.599 2.214 1.864 1.516 1.217 0.987 -A 35LAT10M -T1 288.4 280.8 266.8 252.2 238.1 226.0 217.0 211.5 208.9 209.2 211.5 -T2 214.4 217.3 220.0 222.5 225.2 228.3 232.4 237.2 242.5 247.9 253.1 -T3 257.3 260.4 261.6 260.8 258.0 253.3 248.6 243.9 239.2 233.0 228.0 -T4 221.6 216.0 211.7 208.2 204.8 201.3 197.7 196.3 -Z1 0.035 0.048 0.052 0.054 0.056 0.070 0.109 0.171 0.341 0.778 1.559 -Z2 2.598 3.990 5.561 6.775 7.598 7.996 8.096 8.038 7.814 7.205 6.142 -Z3 4.960 4.001 3.262 2.687 2.277 1.899 1.531 1.213 0.974 -A 45LAT10M -T1 280.8 273.6 260.4 246.4 233.3 223.5 218.1 215.7 214.4 213.9 214.4 -T2 215.5 217.0 218.9 220.9 223.1 225.8 229.4 233.7 238.3 243.1 247.7 -T3 251.8 255.2 257.2 257.5 255.9 252.3 247.3 242.0 236.8 230.0 225.0 -T4 219.7 214.0 209.8 206.1 202.3 198.5 194.9 193.4 -Z1 0.023 0.045 0.051 0.055 0.062 0.092 0.169 0.284 0.567 1.109 1.869 -Z2 2.758 3.906 5.129 5.972 6.500 6.860 7.139 7.300 7.381 7.147 6.435 -Z3 5.363 4.295 3.459 2.824 2.360 1.945 1.557 1.220 0.964 -A 55LAT10M -T1 272.8 266.4 254.1 240.9 229.3 221.8 219.2 218.5 217.8 216.9 216.3 -T2 216.1 216.4 217.3 218.7 220.2 222.3 225.4 229.1 233.2 237.6 242.0 -T3 246.2 250.0 252.8 254.1 253.9 251.4 247.0 242.4 237.8 232.4 227.2 -T4 222.0 217.0 212.2 207.5 202.8 198.2 193.9 191.3 -Z1 0.021 0.045 0.052 0.056 0.066 0.118 0.208 0.350 0.663 1.239 1.985 -Z2 2.822 3.859 4.760 5.321 5.698 6.014 6.349 6.658 6.894 6.861 6.380 -Z3 5.497 4.486 3.617 2.915 2.413 1.973 1.573 1.226 0.958 -A 65LAT10M -T1 266.4 260.7 249.2 236.7 226.3 220.8 219.8 219.8 219.0 217.8 216.6 -T2 215.6 215.1 215.2 215.8 216.6 218.0 220.2 223.3 227.1 231.4 235.8 -T3 240.5 245.0 248.8 251.4 252.5 251.5 248.0 244.1 240.2 235.9 231.0 -T4 225.8 220.6 215.3 210.2 205.1 199.9 195.1 192.1 -Z1 0.027 0.041 0.050 0.056 0.075 0.167 0.276 0.493 0.902 1.512 2.177 -Z2 2.937 3.660 4.249 4.591 4.942 5.241 5.621 5.967 6.220 6.303 6.036 -Z3 5.466 4.684 3.805 3.029 2.380 1.855 1.452 1.187 1.003 -A 75LAT10M -T1 260.7 255.7 245.3 233.8 224.6 220.3 220.1 220.2 219.1 217.5 215.7 -T2 214.2 213.2 212.6 212.5 212.6 213.2 214.8 217.3 220.8 225.1 229.8 -T3 234.8 240.0 244.9 248.9 251.9 253.0 250.0 246.4 242.8 239.3 234.0 -T4 227.7 221.6 216.4 211.6 206.9 202.1 197.3 195.1 -Z1 0.032 0.041 0.049 0.060 0.088 0.207 0.344 0.582 1.064 1.767 2.361 -Z2 2.900 3.422 3.598 3.746 3.906 4.087 4.299 4.546 4.785 4.952 4.984 -Z3 4.781 4.367 3.781 3.093 2.432 1.851 1.417 1.130 0.937 -A 85LAT10M -T1 256.8 252.2 242.6 232.1 224.1 220.4 220.1 220.0 218.5 216.2 214.1 -T2 212.5 211.3 210.5 209.9 209.5 209.7 210.8 213.0 216.3 220.5 225.2 -T3 230.5 236.1 241.8 247.1 251.8 255.0 252.0 248.1 244.3 241.8 234.8 -T4 228.0 221.5 216.5 212.1 207.6 203.1 198.7 196.2 -Z1 0.029 0.039 0.046 0.055 0.092 0.232 0.341 0.629 1.155 1.836 2.416 -Z2 2.828 3.117 3.298 3.406 3.495 3.580 3.672 3.844 4.053 4.237 4.379 -Z3 4.335 4.102 3.679 3.078 2.436 1.837 1.394 1.113 0.928 -A-85LAT11M -T1 251.5 246.9 238.1 228.3 219.7 214.7 213.8 215.4 218.4 222.3 226.5 -T2 230.8 235.2 239.9 244.8 249.7 253.6 256.3 259.0 263.5 269.6 275.6 -T3 280.0 282.7 283.6 282.8 279.7 272.7 265.9 259.2 252.5 244.2 237.2 -T4 230.2 223.2 216.2 209.2 202.2 195.2 188.2 183.3 -Z1 0.031 0.031 0.025 0.031 0.048 0.130 0.242 0.266 0.345 0.628 1.248 -Z2 2.273 3.430 4.327 5.150 5.604 5.660 5.598 5.476 5.321 5.165 4.578 -Z3 3.812 2.990 2.272 1.832 1.495 1.225 0.985 0.781 0.619 -A-75LAT11M -T1 256.6 251.5 241.6 230.8 221.5 216.2 215.7 217.7 220.4 223.4 226.7 -T2 230.4 234.2 238.3 242.6 246.9 250.6 253.6 256.6 261.1 266.8 272.2 -T3 276.3 278.7 279.4 278.4 275.3 268.8 262.7 256.7 250.7 243.6 236.8 -T4 229.8 222.9 215.9 209.0 202.0 195.1 188.1 183.3 -Z1 0.023 0.024 0.030 0.035 0.063 0.165 0.294 0.400 0.634 1.078 1.736 -Z2 2.798 4.012 4.912 5.459 5.807 5.878 5.846 5.737 5.550 5.284 4.620 -Z3 3.856 3.082 2.398 1.932 1.567 1.275 1.024 0.810 0.638 -A-65LAT11M -T1 264.7 258.5 246.7 234.7 225.2 220.3 220.0 221.7 223.4 225.1 227.0 -T2 229.1 231.7 234.7 237.9 241.3 244.7 248.3 252.3 256.9 262.0 266.9 -T3 270.6 272.9 273.7 272.9 270.1 264.5 259.0 253.6 248.2 240.3 235.5 -T4 228.9 222.1 215.4 208.6 201.9 195.2 188.3 183.4 -Z1 0.020 0.022 0.028 0.035 0.053 0.141 0.263 0.308 0.425 0.795 1.446 -Z2 2.489 3.774 4.881 5.610 5.948 6.092 6.161 6.095 5.783 5.129 4.251 -Z3 3.451 2.843 2.421 2.120 1.849 1.576 1.296 1.034 0.830 -A-55LAT11M -T1 271.3 264.5 251.8 239.2 229.0 223.2 221.8 222.3 223.0 223.8 224.8 -T2 226.1 227.8 230.1 232.7 235.6 238.9 243.2 248.0 253.0 257.9 262.4 -T3 265.9 268.2 269.1 268.4 266.0 261.0 255.9 250.8 245.7 237.6 233.5 -T4 226.6 219.8 213.3 207.1 200.8 194.5 188.2 183.2 -Z1 0.020 0.029 0.037 0.045 0.072 0.185 0.280 0.396 0.903 1.722 2.765 -Z2 3.754 4.644 5.468 6.204 6.654 6.883 6.989 6.923 6.550 5.734 4.710 -Z3 3.788 3.106 2.618 2.251 1.949 1.647 1.367 1.118 0.904 -A-45LAT11M -T1 277.6 270.7 257.7 244.3 232.4 224.1 220.3 218.9 218.6 219.0 220.1 -T2 221.6 223.6 226.0 228.7 231.6 235.2 240.0 245.5 250.9 256.1 260.9 -T3 264.6 267.0 267.8 266.8 264.0 258.9 253.7 248.4 243.2 234.9 231.0 -T4 223.6 216.7 211.1 205.6 200.2 194.7 189.4 184.8 -Z1 0.024 0.030 0.040 0.048 0.068 0.138 0.244 0.365 0.685 1.441 2.455 -Z2 3.542 4.528 5.520 6.450 7.178 7.597 7.813 7.747 7.364 6.371 5.116 -Z3 4.079 3.339 2.806 2.394 2.071 1.751 1.446 1.185 0.978 -A-35LAT11M -T1 283.9 277.0 263.8 249.7 236.3 225.5 218.3 214.0 212.1 212.5 214.5 -T2 217.0 219.9 222.9 226.2 229.6 233.6 238.7 244.6 250.4 256.1 261.3 -T3 265.2 267.5 268.0 266.5 263.1 257.5 252.1 246.9 241.6 234.3 229.3 -T4 222.1 215.7 210.8 206.4 202.0 197.5 193.3 189.7 -Z1 0.025 0.035 0.046 0.054 0.062 0.105 0.205 0.302 0.572 1.179 2.174 -Z2 3.374 4.523 5.709 6.869 7.814 8.478 8.740 8.561 7.810 6.594 5.259 -Z3 4.210 3.462 2.912 2.450 2.095 1.767 1.460 1.190 0.971 -A-25LAT11M -T1 289.4 282.5 269.2 254.9 240.7 227.8 217.0 209.0 205.1 206.0 209.4 -T2 213.5 217.4 221.2 224.9 228.8 233.2 238.5 244.5 250.6 256.6 262.1 -T3 266.0 268.1 268.2 266.2 262.2 256.2 250.9 245.8 240.6 233.4 228.4 -T4 221.0 214.8 210.5 207.0 203.5 200.0 196.6 193.9 -Z1 0.050 0.050 0.060 0.066 0.073 0.088 0.105 0.132 0.185 0.532 1.464 -Z2 2.820 4.328 5.825 7.330 8.579 9.272 9.329 8.910 7.976 6.720 5.396 -Z3 4.362 3.579 2.976 2.531 2.145 1.801 1.490 1.231 1.006 -A-15LAT11M -T1 292.6 285.7 272.6 258.3 243.8 229.6 216.5 205.4 199.9 201.3 206.0 -T2 211.2 215.9 220.2 224.3 228.4 233.1 238.6 244.7 251.0 257.3 262.8 -T3 266.6 268.4 268.1 265.8 261.7 256.1 250.8 245.5 240.2 232.8 227.5 -T4 219.3 212.7 208.8 205.8 202.9 200.0 197.3 195.3 -Z1 0.016 0.030 0.050 0.053 0.054 0.053 0.062 0.084 0.137 0.423 1.171 -Z2 2.395 4.042 5.945 7.859 9.435 10.136 9.935 9.095 8.002 6.806 5.500 -Z3 4.407 3.589 3.022 2.509 2.101 1.773 1.493 1.251 1.039 -A -5LAT11M -T1 293.0 286.3 273.5 259.5 244.8 230.3 216.3 204.3 198.1 199.7 205.0 -T2 210.6 215.5 219.9 224.0 228.2 233.0 238.8 245.3 251.6 257.8 263.2 -T3 266.7 268.0 267.5 265.2 261.5 256.8 251.4 246.0 240.5 232.8 227.2 -T4 218.4 211.5 207.8 205.4 203.2 201.0 198.8 197.1 -Z1 0.024 0.034 0.048 0.055 0.055 0.057 0.061 0.069 0.092 0.295 0.959 -Z2 2.108 3.770 5.859 8.198 9.815 10.162 9.465 8.797 7.775 6.685 5.433 -Z3 4.393 3.617 2.982 2.533 2.120 1.788 1.490 1.249 1.061 -A 5LAT11M -T1 293.4 286.5 273.6 259.5 244.8 230.2 216.2 204.2 198.1 199.7 205.4 -T2 211.3 216.2 220.4 224.1 228.1 232.6 238.4 244.9 251.3 257.5 262.9 -T3 266.4 267.8 267.3 265.0 261.5 256.9 251.7 246.4 241.2 233.3 228.3 -T4 219.3 212.4 209.1 207.0 205.0 202.9 201.0 199.3 -Z1 0.022 0.029 0.032 0.052 0.068 0.079 0.077 0.090 0.108 0.298 1.038 -Z2 2.143 3.794 5.943 8.115 9.625 10.075 9.418 8.506 7.462 6.442 5.335 -Z3 4.318 3.609 2.986 2.515 2.116 1.773 1.455 1.200 1.003 -A 15LAT11M -T1 293.5 286.2 272.8 258.5 243.7 229.2 215.8 204.7 199.0 200.5 206.1 -T2 211.8 216.5 220.5 224.0 227.5 231.7 237.0 243.0 249.3 255.5 261.1 -T3 265.0 266.9 266.9 264.8 261.0 256.0 251.2 246.6 241.9 234.8 230.3 -T4 221.9 215.2 211.5 208.8 206.2 203.7 201.2 199.1 -Z1 0.020 0.035 0.042 0.043 0.043 0.045 0.053 0.074 0.134 0.391 1.114 -Z2 2.203 3.835 5.774 7.714 8.928 9.278 8.970 8.337 7.546 6.609 5.528 -Z3 4.495 3.667 3.078 2.565 2.196 1.847 1.492 1.198 0.971 -A 25LAT11M -T1 290.2 283.0 269.5 255.1 240.7 227.3 215.8 207.1 202.7 203.6 207.7 -T2 212.3 216.4 219.8 222.9 226.1 229.8 234.3 239.6 245.4 251.4 256.9 -T3 261.1 263.7 264.3 262.7 259.3 254.3 250.0 245.8 241.5 234.2 230.7 -T4 223.5 217.1 212.9 209.6 206.4 203.2 200.1 198.0 -Z1 0.027 0.039 0.045 0.048 0.049 0.053 0.059 0.075 0.137 0.377 1.182 -Z2 2.375 3.979 5.650 7.099 8.053 8.361 8.299 8.018 7.603 6.918 5.913 -Z3 4.862 3.926 3.234 2.677 2.285 1.914 1.533 1.204 0.955 -A 35LAT11M -T1 284.1 276.9 263.3 249.1 235.5 224.3 216.5 211.6 209.1 209.0 210.8 -T2 213.4 216.1 218.6 221.0 223.4 226.4 230.1 234.5 239.5 244.8 249.9 -T3 254.3 257.5 259.1 258.7 256.4 252.6 248.4 244.2 240.0 233.4 229.6 -T4 223.5 217.8 213.7 210.3 206.9 203.5 200.0 198.6 -Z1 0.029 0.043 0.049 0.050 0.057 0.084 0.134 0.212 0.388 0.901 1.685 -Z2 2.757 4.026 5.406 6.345 6.956 7.294 7.408 7.467 7.469 7.241 6.476 -Z3 5.365 4.264 3.421 2.807 2.353 1.929 1.514 1.161 0.894 -A 45LAT11M -T1 275.3 268.7 255.9 242.4 230.1 221.5 217.3 215.7 214.5 213.7 213.6 -T2 214.2 215.2 216.5 218.0 219.6 221.7 224.7 228.5 232.7 237.3 241.9 -T3 246.4 250.2 252.9 254.1 253.8 251.9 247.6 243.1 238.5 231.7 228.3 -T4 224.6 219.6 215.8 212.3 208.8 205.4 201.9 200.6 -Z1 0.021 0.041 0.047 0.051 0.059 0.106 0.209 0.353 0.665 1.220 1.971 -Z2 2.927 4.103 5.211 5.820 6.078 6.267 6.475 6.719 6.954 7.003 6.668 -Z3 5.855 4.789 3.770 2.951 2.398 1.925 1.493 1.135 0.870 -A 55LAT11M -T1 267.0 261.3 249.7 237.0 226.1 219.6 217.6 217.2 216.4 215.2 214.2 -T2 213.5 213.2 213.4 214.0 214.8 216.3 218.8 222.3 226.4 230.9 235.5 -T3 240.3 244.8 248.6 251.1 252.4 252.3 248.3 243.8 239.4 232.6 229.4 -T4 226.5 223.4 219.3 215.3 211.4 207.5 203.9 202.1 -Z1 0.020 0.043 0.049 0.053 0.067 0.125 0.241 0.417 0.760 1.380 2.123 -Z2 3.018 4.084 4.952 5.324 5.530 5.666 5.909 6.158 6.369 6.480 6.330 -Z3 5.863 5.122 4.165 3.248 2.489 1.897 1.479 1.246 1.099 -A 65LAT11M -T1 260.7 255.7 245.1 233.1 223.3 218.0 217.0 216.8 215.7 214.1 212.5 -T2 211.1 210.1 209.8 209.8 210.0 211.0 213.2 216.5 220.7 225.5 230.6 -T3 236.1 241.4 246.2 249.9 252.6 254.1 250.2 245.5 240.8 233.2 230.5 -T4 227.4 224.1 220.2 216.4 212.6 208.7 205.2 203.1 -Z1 0.031 0.040 0.048 0.055 0.079 0.173 0.323 0.568 1.026 1.665 2.355 -Z2 3.118 3.869 4.473 4.734 4.897 4.987 5.236 5.490 5.691 5.764 5.671 -Z3 5.301 4.697 3.923 3.139 2.459 1.900 1.487 1.246 1.105 -A 75LAT11M -T1 255.4 251.0 241.3 230.1 221.3 217.0 216.3 215.9 214.3 212.1 210.0 -T2 208.2 207.0 206.3 206.0 206.0 206.6 208.5 211.5 215.7 220.7 226.2 -T3 232.2 238.2 244.0 248.8 253.0 256.2 252.4 247.5 242.7 235.6 231.6 -T4 226.6 221.3 217.9 214.9 211.9 209.0 205.9 204.7 -Z1 0.034 0.041 0.047 0.055 0.084 0.201 0.357 0.703 1.258 1.930 2.483 -Z2 3.096 3.578 3.798 3.993 4.091 4.250 4.541 4.866 5.140 5.247 5.125 -Z3 4.779 4.237 3.534 2.834 2.240 1.772 1.452 1.294 1.245 -A 85LAT11M -T1 252.5 248.1 238.6 228.0 219.8 216.0 215.3 214.8 212.8 209.8 207.3 -T2 205.6 204.6 203.9 203.5 203.3 203.7 205.3 207.9 212.0 217.1 222.7 -T3 228.9 235.3 241.7 247.7 253.2 257.7 253.8 248.7 243.5 238.2 231.5 -T4 225.3 219.5 216.6 213.9 211.4 209.0 206.5 205.2 -Z1 0.032 0.040 0.045 0.051 0.071 0.196 0.367 0.671 1.280 1.919 2.500 -Z2 3.085 3.439 3.604 3.649 3.668 3.858 4.148 4.506 4.847 5.055 4.927 -Z3 4.585 4.064 3.394 2.721 2.162 1.728 1.428 1.273 1.243 -A-85LAT12M -T1 252.7 248.7 240.4 231.5 225.5 224.8 227.3 230.4 233.2 235.3 236.6 -T2 237.7 239.2 241.6 244.8 248.2 251.2 253.9 257.3 263.2 271.2 279.1 -T3 285.2 289.1 290.4 288.9 284.5 276.4 270.2 264.4 258.6 252.5 244.8 -T4 237.3 229.2 219.2 208.7 198.3 187.9 177.6 160.0 -Z1 0.028 0.028 0.021 0.030 0.068 0.202 0.291 0.368 0.638 1.367 2.346 -Z2 3.249 4.008 4.310 4.581 4.864 5.190 5.561 5.797 5.782 5.355 4.397 -Z3 3.506 2.741 2.151 1.785 1.497 1.263 1.062 0.860 0.685 -A-75LAT12M -T1 259.4 254.4 244.4 234.1 226.5 224.2 226.1 229.0 231.4 233.2 234.5 -T2 235.8 237.6 240.1 243.1 246.3 249.5 252.6 256.4 262.2 269.5 276.6 -T3 282.1 285.5 286.5 284.8 280.4 272.8 267.0 261.5 256.0 250.7 242.7 -T4 235.1 226.9 217.2 207.2 197.2 187.2 177.7 159.0 -Z1 0.020 0.023 0.030 0.038 0.059 0.188 0.290 0.388 0.687 1.341 2.235 -Z2 3.257 3.968 4.586 4.806 5.056 5.383 5.713 5.894 5.829 5.380 4.458 -Z3 3.589 2.830 2.230 1.846 1.538 1.283 1.067 0.870 0.703 -A-65LAT12M -T1 266.8 260.7 248.9 237.1 228.4 225.0 225.9 227.9 229.3 230.3 231.3 -T2 232.6 234.4 236.9 239.8 242.9 246.3 250.3 254.9 260.5 266.7 272.5 -T3 276.9 279.6 280.2 278.7 274.9 268.6 262.8 257.2 251.6 243.4 238.1 -T4 230.2 222.0 213.1 204.1 195.0 185.8 177.0 170.2 -Z1 0.016 0.018 0.024 0.033 0.059 0.169 0.282 0.383 0.679 1.303 2.127 -Z2 3.148 4.036 4.897 5.441 5.763 5.984 6.154 6.133 5.773 5.007 4.094 -Z3 3.347 2.816 2.447 2.143 1.875 1.594 1.312 1.054 0.860 -A-55LAT12M -T1 272.3 265.7 253.2 240.6 230.5 224.9 223.8 224.4 224.9 225.5 226.6 -T2 228.1 230.1 232.7 235.6 238.8 242.5 247.2 252.6 258.0 263.3 268.1 -T3 271.7 273.8 274.2 272.9 269.9 264.6 258.8 253.0 247.2 238.5 233.0 -T4 225.1 216.9 208.9 201.0 193.0 185.3 177.3 171.3 -Z1 0.013 0.024 0.031 0.038 0.099 0.197 0.283 0.419 0.780 1.491 2.406 -Z2 3.386 4.346 5.124 5.929 6.478 6.830 6.980 6.851 6.346 5.421 4.401 -Z3 3.585 2.999 2.571 2.246 1.935 1.634 1.353 1.094 0.876 -A-45LAT12M -T1 278.8 272.0 259.3 245.8 233.4 224.6 220.2 218.6 218.1 218.7 220.3 -T2 222.4 225.1 228.1 231.4 234.8 238.9 244.1 249.9 255.4 260.6 265.3 -T3 268.6 270.6 270.9 269.5 266.5 261.4 255.6 249.6 243.7 234.3 229.5 -T4 221.2 213.2 206.4 200.0 193.6 187.2 181.0 175.6 -Z1 0.021 0.027 0.039 0.047 0.057 0.101 0.198 0.286 0.535 1.108 2.009 -Z2 3.052 4.129 5.288 6.484 7.468 7.955 7.997 7.698 7.002 5.948 4.826 -Z3 3.920 3.260 2.803 2.465 2.111 1.784 1.477 1.192 0.954 -A-35LAT12M -T1 285.8 278.9 265.7 251.4 237.5 225.9 217.8 212.9 210.6 211.1 213.6 -T2 216.8 220.3 224.0 227.7 231.5 235.9 241.2 247.0 252.8 258.4 263.3 -T3 266.9 268.9 269.2 267.6 264.3 259.1 253.5 247.7 242.0 233.4 228.6 -T4 220.2 212.8 207.5 202.5 197.5 192.5 187.8 183.9 -Z1 0.023 0.034 0.045 0.055 0.064 0.100 0.181 0.237 0.420 0.885 1.729 -Z2 2.903 4.170 5.491 6.982 8.173 8.776 8.765 8.264 7.453 6.284 5.049 -Z3 4.083 3.391 2.890 2.538 2.161 1.834 1.522 1.227 0.974 -A-25LAT12M -T1 291.0 283.9 270.5 256.1 241.6 228.2 216.9 208.2 203.8 204.5 208.2 -T2 212.7 217.0 221.1 224.9 228.9 233.3 238.6 244.4 250.5 256.5 262.0 -T3 265.9 268.0 268.2 266.4 263.0 258.1 252.7 247.3 241.9 233.6 228.9 -T4 220.6 213.8 209.1 205.2 201.3 197.4 193.8 191.1 -Z1 0.046 0.046 0.054 0.060 0.068 0.078 0.091 0.117 0.184 0.459 1.245 -Z2 2.483 3.998 5.711 7.398 8.764 9.411 9.342 8.775 7.883 6.656 5.373 -Z3 4.326 3.577 3.004 2.554 2.200 1.882 1.552 1.236 0.968 -A-15LAT12M -T1 293.4 286.3 273.1 258.8 244.1 229.9 216.5 205.0 199.0 200.0 204.7 -T2 210.1 214.9 219.2 223.1 227.0 231.4 236.8 242.8 249.1 255.5 261.2 -T3 265.3 267.4 267.5 265.6 262.4 258.5 253.3 247.8 242.4 233.7 228.9 -T4 220.3 213.2 208.9 205.7 202.6 199.5 196.4 194.3 -Z1 0.013 0.026 0.040 0.048 0.046 0.043 0.051 0.075 0.123 0.356 1.026 -Z2 2.173 3.811 5.785 7.752 9.217 9.926 9.891 9.268 8.323 7.061 5.734 -Z3 4.609 3.735 3.104 2.575 2.213 1.883 1.526 1.194 0.920 -A -5LAT12M -T1 293.3 286.5 273.7 259.6 244.9 230.3 216.3 203.9 197.2 198.3 203.6 -T2 209.3 214.2 218.5 222.2 226.1 230.6 236.2 242.5 248.9 255.3 260.9 -T3 264.7 266.5 266.5 264.8 262.1 259.4 254.0 248.1 242.2 232.7 227.7 -T4 218.5 211.3 207.5 205.4 203.4 201.3 199.4 197.6 -Z1 0.021 0.031 0.047 0.050 0.051 0.050 0.056 0.065 0.091 0.243 0.889 -Z2 1.987 3.623 5.730 7.858 9.469 10.113 9.793 9.085 8.346 7.283 5.976 -Z3 4.768 3.833 3.126 2.544 2.110 1.747 1.390 1.093 0.866 -A 5LAT12M -T1 293.1 286.4 273.6 259.5 244.8 230.1 216.1 203.9 197.2 198.3 203.9 -T2 209.8 214.8 218.7 222.2 225.7 230.0 235.6 242.0 248.5 254.9 260.6 -T3 264.4 266.3 266.3 264.6 262.0 259.3 253.7 247.6 241.6 232.5 226.7 -T4 217.2 210.0 206.8 205.4 204.1 202.8 201.5 199.8 -Z1 0.023 0.028 0.035 0.045 0.055 0.063 0.077 0.067 0.086 0.240 0.917 -Z2 2.010 3.560 5.588 7.700 9.323 9.849 9.330 8.661 8.087 7.254 6.023 -Z3 4.789 3.838 3.105 2.519 2.080 1.715 1.371 1.083 0.867 -A 15LAT12M -T1 292.1 285.3 272.3 258.1 243.3 229.0 215.8 204.6 198.5 199.4 204.6 -T2 210.4 215.1 218.8 222.1 225.4 229.4 234.7 240.8 247.2 253.7 259.6 -T3 263.8 266.1 266.5 264.7 261.5 257.7 252.3 246.8 241.2 232.6 227.3 -T4 218.3 211.2 207.6 205.8 204.0 202.1 200.3 198.4 -Z1 0.021 0.038 0.047 0.047 0.047 0.049 0.059 0.073 0.117 0.359 1.078 -Z2 2.119 3.614 5.450 7.295 8.449 8.960 8.743 8.269 7.741 6.981 5.845 -Z3 4.644 3.730 3.045 2.537 2.130 1.786 1.440 1.132 0.893 -A 25LAT12M -T1 287.5 280.8 267.9 253.7 239.7 226.9 216.0 207.7 203.0 203.2 206.8 -T2 211.2 215.1 218.4 221.4 224.6 228.3 233.1 238.7 244.8 251.1 256.9 -T3 261.4 264.2 264.9 263.2 259.6 254.6 249.9 245.3 240.7 232.8 228.9 -T4 221.4 214.7 210.6 207.8 204.9 202.1 199.1 197.5 -Z1 0.027 0.040 0.047 0.049 0.052 0.055 0.060 0.076 0.141 0.392 1.212 -Z2 2.493 4.026 5.474 6.717 7.378 7.735 7.788 7.669 7.378 6.772 5.776 -Z3 4.695 3.791 3.123 2.595 2.231 1.892 1.537 1.213 0.963 -A 35LAT12M -T1 280.4 273.6 260.6 246.8 233.9 223.6 216.9 212.7 210.1 209.4 210.6 -T2 212.9 215.3 217.7 220.0 222.4 225.5 229.6 234.6 240.0 245.5 250.9 -T3 255.4 258.7 260.1 259.2 256.2 251.1 247.3 243.8 240.2 233.9 231.2 -T4 225.3 219.6 215.6 212.4 209.0 205.7 202.3 200.9 -Z1 0.023 0.043 0.048 0.050 0.058 0.095 0.167 0.261 0.487 0.990 1.857 -Z2 3.030 4.418 5.551 6.246 6.575 6.814 6.926 7.029 6.971 6.635 5.903 -Z3 4.953 4.047 3.319 2.737 2.310 1.928 1.575 1.262 1.018 -A 45LAT12M -T1 271.6 265.4 253.1 240.0 228.4 220.7 217.5 216.3 215.1 214.0 213.6 -T2 213.9 214.7 215.9 217.2 218.8 221.1 224.5 228.8 233.4 238.1 242.8 -T3 247.3 251.0 253.5 254.2 252.9 249.5 246.0 242.6 239.1 233.6 231.7 -T4 229.6 225.1 221.8 218.5 215.3 212.1 208.8 207.7 -Z1 0.016 0.039 0.045 0.049 0.064 0.131 0.264 0.457 0.797 1.427 2.293 -Z2 3.369 4.474 5.422 5.936 6.066 6.105 6.209 6.396 6.593 6.587 6.263 -Z3 5.592 4.652 3.749 2.963 2.407 1.944 1.556 1.243 1.007 -A 55LAT12M -T1 263.5 258.3 247.3 234.9 224.5 218.4 216.8 216.5 215.6 214.2 213.0 -T2 212.2 211.9 212.2 212.9 213.9 215.7 218.8 222.9 227.4 232.1 236.7 -T3 241.5 245.9 249.4 251.6 252.3 251.2 247.7 243.8 240.0 232.8 231.7 -T4 231.1 229.5 226.3 223.3 220.1 217.0 213.9 212.8 -Z1 0.019 0.042 0.048 0.053 0.072 0.134 0.284 0.506 0.887 1.487 2.348 -Z2 3.428 4.437 5.239 5.579 5.728 5.729 5.848 5.978 6.064 6.028 5.842 -Z3 5.397 4.738 3.928 3.144 2.476 1.938 1.542 1.307 1.155 -A 65LAT12M -T1 257.5 253.0 242.8 231.1 221.4 216.1 214.8 214.4 212.9 210.9 209.2 -T2 207.8 207.1 207.2 207.8 208.7 210.5 213.8 218.1 223.0 228.2 233.5 -T3 238.9 244.1 248.7 252.0 254.1 255.0 250.7 245.6 240.5 230.6 229.8 -T4 228.9 227.6 225.0 222.5 220.0 217.6 215.2 214.1 -Z1 0.030 0.040 0.046 0.051 0.074 0.196 0.407 0.668 1.202 1.870 2.604 -Z2 3.424 4.241 4.814 4.970 5.052 5.129 5.356 5.519 5.569 5.450 5.280 -Z3 4.893 4.319 3.607 2.938 2.356 1.876 1.518 1.313 1.201 -A 75LAT12M -T1 253.0 249.0 239.6 228.4 219.3 214.3 212.8 211.7 209.6 207.0 204.7 -T2 203.2 202.4 202.5 203.1 204.1 205.9 209.2 213.7 219.0 224.8 230.8 -T3 237.0 242.9 248.3 252.5 255.8 258.0 253.3 247.6 241.8 231.7 229.3 -T4 225.5 220.9 219.3 218.1 217.0 215.8 214.5 214.3 -Z1 0.032 0.040 0.044 0.051 0.086 0.210 0.414 0.795 1.399 2.053 2.732 -Z2 3.388 3.833 4.073 4.104 4.227 4.485 4.818 5.036 5.112 5.019 4.837 -Z3 4.487 3.978 3.322 2.676 2.138 1.722 1.451 1.323 1.301 -A 85LAT12M -T1 251.2 247.2 237.8 226.9 218.0 212.9 211.0 209.6 207.0 203.7 201.2 -T2 199.7 199.2 199.3 199.8 200.7 202.4 205.6 210.1 215.5 221.6 227.9 -T3 234.5 241.0 247.0 252.1 256.3 259.4 254.4 248.3 242.2 234.2 228.4 -T4 222.6 218.1 216.5 216.0 215.4 214.8 214.3 214.2 -Z1 0.030 0.039 0.044 0.053 0.087 0.210 0.395 0.826 1.484 2.128 2.779 -Z2 3.268 3.576 3.703 3.826 4.030 4.342 4.670 4.864 4.918 4.828 4.665 -Z3 4.331 3.841 3.220 2.617 2.101 1.695 1.430 1.316 1.320 -US-std geom-alt density O3-dens T P - 0 0.00E+00 2.521E+19 7.564E+11 287.40 1000.0000 - 2 2.36E+05 1.996E+19 6.588E+11 272.20 749.8942 - 4 4.59E+05 1.581E+19 5.693E+11 257.70 562.3413 - 6 6.70E+05 1.252E+19 6.011E+11 244.00 421.6965 - 8 8.70E+05 9.920E+18 8.531E+11 231.00 316.2278 - 10 1.06E+06 7.779E+18 1.455E+12 220.90 237.1374 - 12 1.24E+06 5.947E+18 2.105E+12 216.70 177.8279 - 14 1.43E+06 4.459E+18 2.475E+12 216.70 133.3521 - 16 1.61E+06 3.344E+18 3.073E+12 216.70 100.0000 - 18 1.79E+06 2.508E+18 4.067E+12 216.70 74.9894 - 20 1.97E+06 1.874E+18 4.718E+12 217.40 56.2341 - 22 2.16E+06 1.399E+18 4.840E+12 218.40 42.1697 - 24 2.34E+06 1.041E+18 4.632E+12 220.20 31.6228 - 26 2.53E+06 7.740E+17 4.174E+12 222.00 23.7137 - 28 2.72E+06 5.755E+17 3.460E+12 223.90 17.7828 - 30 2.91E+06 4.280E+17 2.760E+12 225.80 13.3352 - 32 3.10E+06 3.182E+17 2.214E+12 227.70 10.0000 - 34 3.29E+06 2.346E+17 1.757E+12 231.60 7.4989 - 36 3.49E+06 1.719E+17 1.366E+12 237.00 5.6234 - 38 3.69E+06 1.259E+17 1.009E+12 242.70 4.2170 - 40 3.90E+06 9.221E+16 6.979E+11 248.50 3.1623 - 42 4.11E+06 6.755E+16 4.543E+11 254.40 2.3714 - 44 4.33E+06 4.949E+16 2.955E+11 260.40 1.7783 - 46 4.55E+06 3.623E+16 1.733E+11 266.70 1.3335 - 48 4.77E+06 2.677E+16 9.915E+10 270.70 1.0000 - 50 5.00E+06 2.011E+16 5.911E+10 270.20 0.7499 - 52 5.23E+06 1.527E+16 3.310E+10 266.80 0.5623 - 54 5.45E+06 1.173E+16 2.056E+10 260.60 0.4217 - 56 5.67E+06 9.004E+15 1.302E+10 254.50 0.3162 - 58 5.88E+06 6.915E+15 8.381E+09 248.50 0.2371 - 60 6.09E+06 5.307E+15 5.360E+09 242.80 0.1778 - 62 6.29E+06 4.077E+15 3.432E+09 237.00 0.1334 - 64 6.48E+06 3.129E+15 2.198E+09 231.60 0.1000 - 66 6.68E+06 2.404E+15 1.407E+09 226.00 0.0750 - 68 6.87E+06 1.852E+15 9.009E+08 220.00 0.0562 - 70 7.05E+06 1.421E+15 5.769E+08 215.00 0.0422 - 72 7.23E+06 1.091E+15 3.694E+08 210.00 0.0316 - 74 7.40E+06 8.382E+14 2.365E+08 205.00 0.0237 - 76 7.57E+06 6.411E+14 1.514E+08 201.00 0.0178 - 78 7.74E+06 4.880E+14 9.696E+07 198.00 0.0133 - 80 7.91E+06 3.735E+14 6.209E+07 194.00 0.0100 - - - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/fastJX53c.code b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/fastJX53c.code deleted file mode 100644 index f1447187..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/fastJX53c.code +++ /dev/null @@ -1,2248 +0,0 @@ -! ---------------------------------------------------------------------- - subroutine SET_ATM2(GMTAU) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -! - real*8 MASFAC,SCALEH,GMTAU !, PJ(L1_+1) - integer I,J,L,N -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) -! - do J = 1,J_ - do I = 1,I_ - P(I,J) = PMEAN(I,J) -! do L = 1,L1_ -! PJ(L) = ETAA(L) + ETAB(L)*P(I,J) -! enddo -! PJ(L1_+1) = 0.d0 - do L = 1,L1_ - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = DO3(I,J,L)*DM(I,J,L) - enddo - do L = 1,L_ - TJ(I,J,L) = T(I,J,L) - enddo -!-------calculate effective altitude of each CTM level edge - ZH(I,J,1) = 16d5*log10(1000.d0/P(I,J)) - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -(log(PJ(L+1)/PJ(L))*SCALEH) - enddo - enddo - enddo -! -!---load O3 from CTM is being calculated: -! do N = 1,NTR_ -! if (TCNAME(N) .eq. 'O3') then -! do J = 1,J_ -! do I = 1,I_ -! do L = 1,L_ ! unit of DO3: # molecules/cm^2 -! DO3(I,J,L) = 6.023d26*STT(I,J,L,N)/48.d0 & -! & *1.d-4 /AREAXY(I,J) -! enddo -! enddo -! enddo -! endif -! enddo -! - return - end subroutine SET_ATM2 -! -! -!----------------------------------------------------------------------- - subroutine INPHOT (CrossSection_InfileName, & - & ScatteringData_InfileName, & - & PhotRateLabels_InfileName, & - & T_O3_Climatology_InfileName) -!----------------------------------------------------------------------- -! Routine to initialise photolysis rate data, called directly from the -! cinit routine in ASAD. Currently use it to read the JPL spectral data -! and standard O3 and T profiles and to set the appropriate reaction index. -!----------------------------------------------------------------------- -! -! IPH Channel number for reading all data files -! RAD Radius of Earth (cm) -! ZZHT Effective scale height above top of atmosphere (cm) -! DATUMX Maximum opt.depth above which sub layers should be inserted -! SZAMAX Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -# include "fastJX53c_cmn_JVdat.h" -! -! -! !INPUT PARAMETERS: - character (len=128), intent (in) :: CrossSection_InfileName - ! fast-J X-sections (spectral data) input file name - character (len=128), intent (in) :: ScatteringData_InfileName - ! Aerosol/cloud scattering data input file name - character (len=128), intent (in) :: PhotRateLabels_InfileName - ! Labels of photolysis rates required input file name - ! keyed to chem code - character (len=128), intent (in) :: T_O3_Climatology_InfileName - ! Read in T & O3 climatology input file name - ! general backup clim. - integer IPH, I, J, K - real*8 PI -! - PI = 3.141592653589793d0 -! Use channel 8 to read files at the moment - IPH = 8 -! -! Defaults & constants - RAD = 6375.d5 - ZZHT = 5.d5 - STT(:,:,:,:) = 1.d6 - TCNAME(:) = 'CO2' -! -! Read in annual mean pressure field -! open (IPH,file='ECT42_grid.dat',form='formatted',status='old') -! read (IPH,*) -! read (IPH,'(16F8.2)') (XDGRD(I),I=1,I_) -! read (IPH,*) -! read (IPH,'(16F8.2)') (YDGRD(J),J=1,J_) -! read (IPH,*) -! read (IPH,'(16F8.2)') (AREAXY(1,J),J=1,J_) -! read (IPH,*) -! read (IPH,'(16F8.1)') ((PMEAN(I,J),I=1,I_),J=1,J_) -! close(IPH) - -! do J=1,J_ -! AREAXY(1,J) = AREAXY(1,J)*1.d9 -! do I=2,I_ -! AREAXY(I,J) = AREAXY(1,J) -! enddo -! enddo -! -! do I = 1,I_ -! XGRD(I) = XDGRD(I) *PI/180.d0 -! enddo -! do J = 1,J_ -! YGRD(J) = YDGRD(J) *PI/180.d0 -! enddo -! -! Read in fast-J X-sections (spectral data) <<<<<<<<<<<<<< new fast-JX -! call RD_XXX(IPH,'FJX_spec.dat') - call RD_XXX(IPH, CrossSection_InfileName) - -! Read in aerosol/cloud scattering data <<<<<<<<<<<<<<<<<< new fast-JX -! call RD_MIE(IPH,'FJX_scat.dat') - call RD_MIE(IPH, ScatteringData_InfileName) - -! Read in labels of photolysis rates required >>>>> keyed to chem code -! call RD_JS(IPH,'ratj.dat') - call RD_JS(IPH, PhotRateLabels_InfileName) -! -! Read in T & O3 climatology >>>> general backup clim. -! call RD_PROF(IPH,'atmos_std.dat') - call RD_PROF(IPH, T_O3_Climatology_InfileName) -! - return - end subroutine INPHOT -! -! - subroutine RD_JS(NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield 'jfacta' and fastj2 label 'jlabel' -!----------------------------------------------------------------------- -! -! jfacta Quantum yield (or multiplication factor) for photolysis -! jlabel Reference label identifying appropriate J-value to use -! ipr Photolysis reaction counter - should total 'JVN_' -! -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -# include "fastJX53c_cmn_JVdat.h" -! - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL -! - integer IPR, I, J, K - character*120 CLINE -! -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield jfacta and fastj2 label jlabel - IPR = 0 - open (NJ1,file=NAMFIL,status='old',form='formatted') - 10 read (NJ1,'(A)',err=20) CLINE - if (IPR .eq. JVN_) goto 20 -! - if (CLINE(2:5).eq.'9999') then - go to 20 - elseif (CLINE(1:1).eq.'#') then - go to 10 - elseif (CLINE(5:5).eq.'$') then - go to 10 - else - IPR = IPR+1 - read (CLINE(79:83),'(F5.1)') JFACTA(IPR) - read (CLINE(86:92),'(A7)') JLABEL(IPR) - JFACTA(IPR) = JFACTA(IPR)/100.d0 - if(JLABEL(IPR) == "C3H6O" ) JLABEL(IPR) = "Acet-a" ! Added for GMI {KNJR, 2/07} - go to 10 - endif - 20 close(NJ1) -! - NRATJ = IPR -! -!----------------------------------------------------------------------- -! compare Xsections titles with J-values listed in chem code (jratd.dat) -! map the J-values needed for chemistry (ratj.dat) onto the fast-JX rates -! >>>>>>>>>>>>>>>>current code revised to JPL-02 ver 8.5 (5/05)<<<<<<<<< -! >>>this must now follow the read in of Xsects, etc<<< -!----------------------------------------------------------------------- -! -!---Zero / Set index arrays that map Jvalue(j) onto rates - do J = 1,JVN_ - JIND(J) = 0 - enddo - do J = 1,NJVAL - do K = 1,NRATJ - if (JLABEL(K) .eq. TITLEJ(J)) JIND(K)=J - enddo - enddo -! -! write(6,'(a,i4,a)') ' Photochemistry Scheme with ',IPR,' J-values' - do K=1,NRATJ - J = JIND(K) - if (J.eq.0) then - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & - & ' has no mapping onto onto fast-JX' - else -! write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & -! & ' mapped onto fast-JX:',J,TITLEJ(J) - endif - enddo -! - return - end subroutine RD_JS -! -! -!----------------------------------------------------------------------- - subroutine RD_PROF(NJ2,NAMFIL) -!----------------------------------------------------------------------- -! Routine to input T and O3 reference profiles -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -! - integer, intent(in) :: NJ2 - character(*), intent(in) :: NAMFIL -! - integer IA, I, M, L, LAT, MON, NTLATS, NTMONS, N216 - real*8 OFAC, OFAK - character*72 TITLE0 -! - open (NJ2,file=NAMFIL,status='old',form='formatted') - read (NJ2,'(A)') TITLE0 - read (NJ2,'(2I5)') NTLATS,NTMONS -! write(6,'(1X,A)') TITLE0 -! write(6,1000) NTLATS,NTMONS - N216 = min(216, NTLATS*NTMONS) - do IA = 1,N216 - read (NJ2,'(1X,I3,3X,I2)') LAT, MON - M = min(12, max(1, MON)) - L = min(18, max(1, (LAT+95)/10)) - read (NJ2,'(3X,11F7.1)') (TREF(I,L,M), I=1,41) - read (NJ2,'(3X,11F7.4)') (OREF(I,L,M), I=1,31) - enddo - close (NJ2) -! -! Extend climatology to 100 km - OFAC = exp(-2.d5/5.d5) - do I = 32,51 - OFAK = OFAC**(I-31) - do M = 1,NTMONS - do L = 1,NTLATS - OREF(I,L,M) = OREF(31,L,M)*OFAK - enddo - enddo - enddo - do L = 1,NTLATS - do M = 1,NTMONS - do I = 42,51 - TREF(I,L,M) = TREF(41,L,M) - enddo - enddo - enddo -! - return - 1000 format(1x,'std atmos profiles: ',i3,' lat x ',i2,' mon') - end subroutine RD_PROF -! - -! -!----------------------------------------------------------------------- -! bian (11/15/06) start - subroutine SET_CLD -!----------------------------------------------------------------------- -! Routine to set cloud and surface properties: now loads the input prof's -! -! >>>>>> this subroutine will need to be customized -! >>>>>> it is separate from aerosols since it comes from met fields -!----------------------------------------------------------------------- - implicit none -! bian ? check whether need include these, only need one contains ODCLD, ODCOL -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -# include "fastJX53c_cmn_JVdat.h" -! - real*8 odsum, odmax - integer I, J, L -! - odmax = 200.0d0 - odsum = 0.0d0 - DO L = 1,L_ - DO J = 1,J_ - DO I = 1,I_ - ODCOL(L) = dble(ODCLD(I,J,L)) - odsum = odsum + ODCOL(L) - ENDDO - ENDDO - ENDDO - - IF ( odsum .gt. odmax) then - odsum = odmax/odsum - DO L = 1,L_ - ODCOL(L) = ODCOL(L)*odsum - ENDDO - odsum = odmax - ENDIF -! - return - end subroutine SET_CLD -! bian (11/15/06) end -! -! -!----------------------------------------------------------------------- -! bian (11/15/06) start - subroutine SET_PROF -!----------------------------------------------------------------------- -! Updata profile of aerosol and cloud OD -!----------------------------------------------------------------------- - implicit none -! bian ? need change include file, need include file contains T, AER, ADX, ODCOL, NSADdust, NSADaer, NRH_b, OPTDUST, OPTAER, NAA, NCTA.... - -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -# include "fastJX53c_cmn_JVdat.h" -! - integer :: I, J, L, N, NRH, NT -! -! ! total number of cloud + aerosols + Rayleigh -! NCTA = 2+NSADdust+NSADaer - - AER(:,:) = 0.0d0 - - DO L = 1,L1_ - IF (L < L1_) THEN - ! add cloud (water and ice) - AER(1,L) = ODCOL(L) - DO J = 1,J_ - DO I = 1,I_ - IF (T(I,J,L) .GT. 233.d0) THEN - ADX(1,L) = 10 - ELSE - ADX(1,L) = 14 - ENDIF - ENDDO - ENDDO - ELSE - ADX(1,L) = 14 - ENDIF - - ! add dust - DO N = 1, NSADdust - IF (L < L1_) THEN - AER(1+N,L) = OPTDUST(L,N) - ENDIF - ADX(1+N,L) = 14+N - ENDDO - - ! add other aerosols - DO N = 1, NSADaer - DO NRH = 1, NRH_b - NT = NRH + (N-1)*NRH_b - IF (L < L1_) THEN - AER(1+N+NSADdust,L) = AER(1+N+NSADdust,L) + OPTAER(L,NT) - ENDIF - ADX(1+N+NSADdust,L) = 21+NT+(7-NRH_b)*(N-1) -! ADX(1+N+NSADdust,L) = 21+NT+(7-NRH_b)*INT((NT-1)/NRH_b) - ENDDO - ENDDO - - ! save space for Rayleigh phase - AER(NCTA,L) = 0.D0 - ADX(NCTA,L) = 1 - - ENDDO - - DO L = 1,L1_ - DO N = 1, NCTA - IF (ADX(N,L) .lt. 0 .or. ADX(N,L) .gt. NAA) THEN -! bian ? change output format - PRINT *, '******* ERROR in setup ADX ******* ' - stop - ENDIF - ! ADX(N,L) = min(NAA, max(0, ADX(N,L))) - ENDDO - ENDDO - - end subroutine SET_PROF -! bian end -! -! -!----------------------------------------------------------------------- - subroutine SET_ATM1 -!----------------------------------------------------------------------- -! Routine to set up atmospheric profiles required by Fast-J2 using a -! doubled version of the level scheme used in the CTM. First pressure -! and z* altitude are defined, then O3 and T are taken from the supplied -! climatology and integrated to the CTM levels (may be overwritten with -! values directly from the CTM, if desired). -! Oliver (04/07/99) & MJP (7/05) -!----------------------------------------------------------------------- -! -! -! PJ Pressure at boundaries of model levels (hPa) -! MASFAC Conversion factor for pressure to column density -! -! TJ Temperature profile on model grid -! DM Air column for each model level (molecules.cm-2) -! DO3 Ozone column for each model level (molecules.cm-2) -! ZH Altitude of boundaries of model levels (cm) -! PSTD Approximate pressures of levels for supplied climatology -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_metdat.h" -! - integer I, J, K, L, M, N - real*8 PSTD(52),OREF2(51),TREF2(51) !,PJ(L1_+1) - real*8 DLOGP,F0,T0,PB,PC,XC,MASFAC,SCALEH -! -! Select appropriate month - M = max(1,min(12,MONTH)) -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) -! -!----------------------------------------------------------------------- - do J = 1,J_ -! -! Select appropriate latitudinal profiles - N = max(1, min(18, (int(YDGRD(J))+99)/10 )) -! Temporary zonal arrays for climatology data - do K = 1,51 - OREF2(K) = OREF(K,N,M) - TREF2(K) = TREF(K,N,M) - enddo -! - do I = 1,I_ -! -! Apportion O3 and T on supplied climatology z* levels onto CTM levels -! with mass (pressure) weighting, assuming constant mixing ratio and -! temperature half a layer on either side of the point supplied. -! L1_ = L_+1: -! PJ(L=1:L1_) = pressure at CTM layer edge, PJ(L1_+1)=0 (top-of-atmos) -! -! PJ(L1_+1) = 0.d0 -! do K = 1,L1_ -! PJ(K) = ETAA(K) + ETAB(K)*PMEAN(I,J) -! enddo -! -! Set up pressure levels for O3/T climatology - assume that value -! given for each 2 km z* level applies from 1 km below to 1 km above, -! so select pressures at these boundaries. Surface level values at -! 1000 mb are assumed to extend down to the actual P(ILNG,JLAT). -! - PSTD(1) = max(PJ(1),1000.d0) - PSTD(2) = 1000.d0 * 10.d0**(-1.d0/16.d0) - DLOGP = 10.d0**(-2.d0/16.d0) - do K = 3,51 - PSTD(K) = PSTD(K-1)*DLOGP - enddo - PSTD(52) = 0.d0 -! - do L = 1,L1_ - F0 = 0.d0 - T0 = 0.d0 - do K = 1,51 - PC = min(PJ(L),PSTD(K)) - PB = max(PJ(L+1),PSTD(K+1)) - if (PC .gt. PB) then - XC = (PC-PB)/(PJ(L)-PJ(L+1)) - F0 = F0 + OREF2(K)*XC - T0 = T0 + TREF2(K)*XC - endif - enddo - TJ(I,J,L) = T0 - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = F0*1.d-6*DM(I,J,L) - enddo -! -! Calculate effective altitudes using scale height at each level - ZH(I,J,1) = 0.d0 - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -( LOG(PJ(L+1)/PJ(L)) * SCALEH ) - enddo -! - enddo - enddo -! - return - end subroutine SET_ATM1 -! -!<<<<<<<<<<<<<<<<<<<<<<< 98.0 deg => tan ht = 63 km -! or 99. 80 km - if (SZA .gt. SZAMAX) goto 99 -! -!---load the amtospheric column data - PPJ(1:L1_+1) = PJ(1:L1_+1) - do L = 1,L1_ -! PPJ(L) = ETAA(L) + ETAB(L)*P(ILNG,JLAT) - TTJ(L) = TJ(ILNG,JLAT,L) - DDJ(L) = DM(ILNG,JLAT,L) - ZZJ(L) = DO3(ILNG,JLAT,L) - enddo -! PPJ(L1_+1) = 0.d0 -! -!---calculate spherical weighting functions (AMF: Air Mass Factor) - do L = 1,L1_ - ZHL(L) = ZH(ILNG,JLAT,L) - enddo -! -!----------------------------------------------------------------------- - call SPHERE(U0,RAD,ZHL,ZZHT,AMF,L1_) -!----------------------------------------------------------------------- -! -! bian 11/13/06 start -!!---load the profiles of aerosols & clouds: treated as the same from here -! do L = 1,L1_ -! AER(1,L) = DAER1(ILNG,JLAT,L) ! Opt. Depth aerosol 1 in layer L -! AER(2,L) = DAER2(ILNG,JLAT,L) ! Opt. Depth aerosol 2 in layer L -! AER(3,L) = DAER3(ILNG,JLAT,L) ! Opt. Depth aerosol 3 in layer L -! AER(4,L) = ODCLD(ILNG,JLAT,L) ! cloud Opt. Depth in L -! AER(5,L) = 0.d0 ! save space for Rayleigh -! ADX(1,L) = NAER1(ILNG,JLAT,L) ! index for aerosol 1 at layer L -! ADX(2,L) = NAER2(ILNG,JLAT,L) ! index for aerosol 2 at layer L -! ADX(3,L) = NAER3(ILNG,JLAT,L) ! index for aerosol 3 at layer L -! ADX(4,L) = NCLDX(ILNG,JLAT,L) ! index for cloud at layer L -! ADX(5,L) = 1 ! index for Rayleigh phase in L -! enddo -! -! do L = 1,L1_ -! do I=1,4 -! ADX(I,L) = min(NAA, max(0, ADX(I,L))) -! enddo -! enddo -! bian end -! -!---Now given the aerosol+cloud OD/layer in visible (600 nm) can calculate -! how to add additonal levels at top of clouds (now uses log spacing) -!----------------------------------------------------------------------- -! bian (11/16/06) start -! call EXTRAL(AER,ADX,L1_,L2_,N_,JTAUMX,ATAU,ATAU0, JXTRA) - call EXTRAL(NCTA, AER,ADX,L1_,L2_,N_,JTAUMX,ATAU,ATAU0, JXTRA) -! bian end -!----------------------------------------------------------------------- -! -!---set surface reflectance - RFLECT = SA(ILNG,JLAT) - RFLECT = max(0.d0,min(1.d0,RFLECT)) -! -!---Loop over all wavelength bins to calc mean actinic flux AVGF(L) - do K = NW1,NW2 - WAVE = WL(K) -!---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 ! use 300 nm aerosol properties for <355 nm - if( WAVE .gt. 355.d0 ) KM=2 ! use 400 nm prop for 355-500 nm - if( WAVE .gt. 500.d0 ) KM=3 - if( WAVE .gt. 800.d0 ) KM=4 -! -!---Loop over CTM layers L=1:L1_ = 1:L_+1, -! values at L1_=L_+1 are a pseudo layer above the top CTM layer (L_) - do L = 1,L1_ - TTT = TTJ(L) - XQO3 = FLINT(TTT,TQQ(1,2),TQQ(2,2),TQQ(3,2) & - & ,QO3(K,1),QO3(K,2),QO3(K,3)) - XQO2 = FLINT(TTT,TQQ(1,1),TQQ(2,1),TQQ(3,1) & - & ,QO2(K,1),QO2(K,2),QO2(K,3)) -! - ABX(L) = XQO3*ZZJ(L) + XQO2*DDJ(L)*0.20948d0 -! -! bian (11/15/06) start - AER(NCTA,L) = DDJ(L)*QRAYL(K) -! bian end - enddo -! -!----------------------------------------------------------------------- - call OPMIE & - & (K,KM, WAVE, ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,AVGF,FTOP,FBOT) -!----------------------------------------------------------------------- -! - do L = 1,JVL_ - FFF(K,L) = FFF(K,L) + SOLF*FL(K)*AVGF(L) - enddo - FREFL = FREFL + SOLF*FL(K)*FTOP/WAVE - FREFS = FREFS + SOLF*FL(K)/WAVE -! - enddo ! loop over wavelength K -! - FREFL = FREFL/FREFS !calculate reflected flux (energy weighted) -! -!----------------------------------------------------------------------- - call JRATET(PPJ,TTJ,FFF, VALJL) -!----------------------------------------------------------------------- -! -!---map the J-values from fast-JX onto ASAD ones (use JIND & JFACTA) - do L = 1,JVL_ - do J = 1,NRATJ - if (JIND(J).gt.0) then - ZPJ(L,J) = VALJL(L,JIND(J))*JFACTA(J) - else - ZPJ(L,J) = 0.d0 - endif - enddo - enddo -! -!---diagnostics that are NOT returned to the CTM code -! -!----------------------------------------------------------------------- -! write(6,*) 'fast-JX(5.3b)--------------internal print------------' -! - call JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) -! -!---Print solar flux terms -! write(6,'(a,5f10.4)') ' fast-JX: SZA/u0/Frefl/albedo/SOL*fact/', & -! & SZA,U0,FREFL,RFLECT,SOLF -! write(6,'(a5,18i9)') ' bin:',(K, K=NW1,NW2) -! write(6,'(a5,18f9.2)') ' wvl:',(WL(K), K=NW1,NW2) -! do L = JVL_,1,-1 -! write(6,'(i3,2x,18f9.6)') L,(FFF(K,L)/FL(K),K=NW1,NW2) -! enddo -! write(6,*) 'fast-JX(5.3b)--------------internal print------------' -!----------------------------------------------------------------------- - - 99 continue - return - end subroutine PHOTOJ -! -!<<<<<<<<<<<<<<<<<<<<<< O(3P)+O2 will be close to from previous fastj versions -! - do J = 4,NJVAL -! - if (TQQ(2,J) .gt. TQQ(1,J)) then - TFACT = max(0.d0,min(1.d0,(TT-TQQ(1,J))/(TQQ(2,J)-TQQ(1,J)))) - else - TFACT = 0.d0 - endif -! - do K = NW1,NW2 - QQQT = QQQ(K,1,J) + (QQQ(K,2,J) - QQQ(K,1,J))*TFACT - VALJ(J) = VALJ(J) + QQQT*FFF(K,L) - enddo -! -! #52 Methylvinyl ketone 'MeVK ' q(M) = 1/(1 + 1.67e-19*[M]) - if (TITLEJ(J).eq.'MeVK ') then - VALJ(J) = VALJ(J)/(1.0 + 1.67e-19*DD) - endif -! #55 Methylethyl ketone MEKeto q(M) = 1/(1 + 2.0*[M/2.5e19]) - if (TITLEJ(J).eq.'MEKeto') then - VALJ(J) = VALJ(J)/(1.0 + 0.80E-19*DD) - endif -! #57 Methyl glyoxal MGlyxl q(M) = 1/(1 + 4.15*[M/2.5E19]) - if (TITLEJ(J).eq.'MGlyxl') then - VALJ(J) = VALJ(J)/(1.0 + 1.66e-19*DD) - endif -! - enddo -! - if (TITLEJ(NJVAL-1).eq.'Acet-a') then -!--------------J-ref v8.3 includes Blitz ACETONE q-yields-------------- -!---Acetone is a special case: (as per Blitz et al GRL, 2004) -!--- 61 = NJVAL-1 = J1(acetone-a) ==> CH3CO + CH3 -!--- 62 = NJVAL = J2(acetone-b) ==> CH3 + CO + CH3 - VALJ(NJVAL-1) = 0.d0 - VALJ(NJVAL) = 0.d0 -!---IV=NJVAL-1 = Xsect (total abs) for Acetone - pre-calc Temp interp factors - IV = NJVAL-1 - TFACA = (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - TFACA = max(0.d0, min(1.d0, TFACA)) -!---IV=NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. -!--- but force to Q2=0 by 210K - IV = NJVAL - TFAC0 = ( (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) )**2 - if (TT .lt. TQQ(1,IV)) then - TFAC0 = (TT - 210.d0)/(TQQ(1,IV)-210.d0) - endif - TFAC0 = max(0.d0, min(1.d0, TFAC0)) -!---IV=NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - TT200 = min(300.d0, max(200.d0, TT)) - TFAC1 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) -!---IV=NJVAL+2 = Q1B for Acetone => (1) - IV = NJVAL+2 - TFAC2 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) -! -!---now integrate over wavelengths - do K = NW1,NW2 -!---NJVAL-1 = Xsect (total abs) for Acetone - IV = NJVAL-1 - QQQA = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFACA -!---NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. - IV = NJVAL - QQ2 = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC0 - if (TT .lt. TQQ(1,IV)) then - QQ2 = QQQ(K,1,IV)*TFAC0 - endif -!---NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - QQ1A = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC1 -!---NJVAL+2 = Q1B for Acetone => (1) ! scaled to [M]=2.5e19 - IV = NJVAL+2 - QQ1B = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC2 - QQ1B = QQ1B*4.d-20 -!---J(61) - VALJ(NJVAL-1) = VALJ(NJVAL-1) & - & + FFF(K,L)*QQQA*(1.d0-QQ2)/(QQ1A + QQ1B*DD) -!---J(62) - VALJ(NJVAL) = VALJ(NJVAL) + FFF(K,L)*QQQA*QQ2 -! - enddo !K -!-----------end v-8.3 includes Blitz ACETONE q-yields-------------- - endif -! -!----Load array of J-values in native order, need to be indexed/scaled -! by ASAD-related code later: ZPJ(L,JJ) = VALJL(L,JIND(JJ))*JFACTA(JJ) - do J=1,NJVAL - VALJL(L,J) = VALJ(J) - enddo -! - enddo ! master loop over L=1,JVL_ - return - end subroutine JRATET -! -! -!----------------------------------------------------------------------- - subroutine JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -!----------------------------------------------------------------------- -!--------key amtospheric data needed to solve plane-parallel J--------- -! bian (11/16/06) start - real*8, dimension(NCTA,L1_) :: AER - integer,dimension(NCTA,L1_) :: ADX -! bian end - real*8, dimension(L1_) :: ABX, TTJ,DDJ,ZZJ,ZHL - real*8, dimension(L1_+1) :: PPJ - integer,dimension(L2_+1) :: JXTRA - real*8 :: ZZHT -!----------------------------------------------------------------------- - integer I,J,K,L - real*8 COL(NCTA-1),COLO2,COLO3,ZKM,DELZ,ZTOP -! -! write(6,100) -! 100 format(' L z(km) p T ',' d(air) d(O3)', & -! & ' col(O2) col(O3) ndx col(aer/cld)') -! - COLO2 = 0.d0 - COLO3 = 0.d0 - do I=1,NCTA-1 - COL(I) = 0.d0 - enddo - ZTOP = ZHL(L1_) + ZZHT -! - do L = L1_,1,-1 -! - do I=1,NCTA-1 - COL(I) = COL(I) + AER(I,L) - enddo - COLO2 = COLO2 + DDJ(L)*0.20948d0 - COLO3 = COLO3 + ZZJ(L) - DELZ = ZTOP-ZHL(L) - ZTOP = ZHL(L) - ZKM = ZHL(L)*1.d-5 -! -! write(6,110) L,ZKM,PPJ(L),TTJ(L),DDJ(L)/DELZ,ZZJ(L)/DELZ, & -! & COLO2,COLO3, & -! & (ADX(I,L),COL(I), I=1,4), JXTRA(L+L),JXTRA(L+L-1) -! 110 format(1x,i3,0p,f6.2,f10.3,f7.2,1p,4e9.2,4(i3,e9.2),2i3) -! - enddo -! - return - end subroutine JP_ATM -! -! -!----------------------------------------------------------------------- - subroutine RD_XXX(NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Read in wavelength bins, solar fluxes, Rayleigh parameters, -! T-dependent X-sections. -! -! >>>current code revised to JPL-02 ver 8.5 (5/05)<<<<< -! -!----------------------------------------------------------------------- -! NAMFIL Name of spectral data file (j2_spec.dat) >> j2 for fast-J2 -! NJ1 Channel number for reading data file -! -! NJVAL Number of species to calculate J-values for -! NWWW Number of wavelength bins, from 1:NWWW -! WBIN Boundaries of wavelength bins -! WL Centres of wavelength bins - 'effective wavelength' -! FL Solar flux incident on top of atmosphere (cm-2.s-1) -! QRAYL Rayleigh parameters (effective cross-section) (cm2) -! QO2 O2 cross-sections -! QO3 O3 cross-sections -! Q1D O3 => O(1D) quantum yield -! TQQ Temperature for supplied cross sections -! QQQ Supplied cross sections in each wavelength bin (cm2) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_JVdat.h" -! - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL -! - integer I, J, K, IW, NQQQ, NWWW -! - TQQ(:,:) = 0.d0 -! -!----------spectral data----set for new format data J-ver8.3------------------ -! note that NJVAL = # J-values, but NQQQ (>NJVAL) = # Xsects read in -! for 2005a data, NJVAL = 62 (including a spare XXXX) and -! NQQQ = 64 so that 4 wavelength datasets read in for acetone -! note NQQQ is not used outside this subroutine! -! - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - read (NJ1,100) TITLE0 - read (NJ1,101) NJVAL,NQQQ, NWWW,NW1,NW2 - if (NJVAL.gt.X_ .or. NQQQ.gt.X_) then - write(6,201) NJVAL,X_ - stop - endif -! write(6,'(1X,A)') TITLE0 -!----J-values: 1=O2, 2=O3P,3=O3D 4=readin Xsects - read (NJ1,102) (WL(IW),IW=1,NWWW) - read (NJ1,102) (FL(IW),IW=1,NWWW) - read (NJ1,102) (QRAYL(IW),IW=1,NWWW) -! -!---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - read (NJ1,103) TITLEJ(1),TQQ(1,1), (QO2(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,1), (QO2(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,1), (QO2(IW,3),IW=1,NWWW) -! - read (NJ1,103) TITLEJ(2),TQQ(1,2), (QO3(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,2), (QO3(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,2), (QO3(IW,3),IW=1,NWWW) -! - read (NJ1,103) TITLEJ(3),TQQ(1,3), (Q1D(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,3), (Q1D(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,3), (Q1D(IW,3),IW=1,NWWW) -! -! do J = 1,3 -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,3) -! enddo -! -!---Read remaining species: X-sections at 2 T_s - do J = 4,NQQQ - read (NJ1,103) TITLEJ(J),TQQ(1,J),(QQQ(IW,1,J),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,J),(QQQ(IW,2,J),IW=1,NWWW) -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,2) - enddo -! -! Reset the titles for NJVAL-1 & NJVAL to be the two acetone J_s -! 61: C3H6O = Acet-a (CH3CO + CH3) -! 62: Q2-Ac = Acet-b (CH3 + CO + CH3) -! - TITLEJ(NJVAL-1) = 'Acet-a' - TITLEJ(NJVAL) = 'Acet-b' - - close(NJ1) - - 100 format(a) - 101 format(10x,5i5) - 102 format(10x, 6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 103 format(a7,f3.0,6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 200 format(1x,' x-sect:',a10,3(3x,f6.2)) - 201 format(' Number of x-sections supplied to Fast-J2: ',i3,/, & - & ' Maximum number allowed (X_) only set to: ',i3, & - & ' - increase in fastJX53c_cmn_jv.h') -! - return - end subroutine RD_XXX - - -!----------------------------------------------------------------------- - subroutine RD_MIE(NJ1,NAMFIL) -!----------------------------------------------------------------------- -!-------aerosols/cloud scattering data set for fast-JX (ver 5.3) -! >>>>>>>>>>>>>>>>spectral data rev to J-ref ver8.5 (5/05)<<<<<<<<<<<< -!----------------------------------------------------------------------- -! NAMFIL Name of scattering data file (e.g., FJX_scat.dat) -! NJ1 Channel number for reading data file -! NAA Number of categories for scattering phase functions -! QAA Aerosol scattering phase functions -! NK Number of wavelengths at which functions supplied (set as 4) -! WAA Wavelengths for the NK supplied phase functions -! PAA Phase function: first 8 terms of expansion -! RAA Effective radius associated with aerosol type -! SSA Single scattering albedo -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_cmn_JVdat.h" -! - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - integer I, J, K -! - open (NJ1,FILE=NAMFIL,status='old',form='formatted') -! - read (NJ1,'(i2,a78)') NAA,TITLE0 - read (NJ1,'(5x,i5,2f10.5)') JTAUMX,ATAU,ATAU0 -! write(6,'(a,2f9.5,i5)') ' ATAU/ATAU0/JMX',ATAU,ATAU0,JTAUMX - read (NJ1,*) - - do J = 1,NAA - read (NJ1,'(3x,a20)') TITLEA(J) - do K = 1,4 ! Fix number of aerosol wavelengths at 4 - read (NJ1,'(f5.0,f8.1,f7.3,f8.4,f7.3,7f6.3)') & - & WAA(K,J),QAA(K,J),RAA(K,J),SSA(K,J),(PAA(I,K,J),I=1,8) - enddo - enddo -! - close(NJ1) -! -! write(6,*) 'Aerosol phase functions & wavelengths' -! write(6,*) TITLE0 -! do J=1,NAA -! write(6,'(1x,A8,I2,A,9F8.1)') & -! & TITLEA(J),J,' wavel=',(WAA(K,J),K=1,4) -! write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,4) -! enddo -! - return - end subroutine RD_MIE -! -! -!----------------------------------------------------------------------- - real*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -!----------------------------------------------------------------------- -! Three-point linear interpolation function -!----------------------------------------------------------------------- - real*8 TINT,T1,T2,T3,F1,F2,F3 - if (TINT .le. T2) then - if (TINT .le. T1) then - FLINT = F1 - else - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - endif - else - if (TINT .ge. T3) then - FLINT = F3 - else - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - endif - endif - return - end function FLINT -! -! -!----------------------------------------------------------------------- - subroutine SOLARZ(GMTIME,NDAY,YGRDJ,XGRDI, SZA,COSSZA,SOLFX) -!----------------------------------------------------------------------- -! GMTIME = UT for when J-values are wanted -! (for implicit solver this is at the end of the time step) -! NDAY = integer day of the year (used for solar lat and declin) -! YGRDJ = laitude (radians) for grid (I,J) -! XGDRI = longitude (radians) for grid (I,J) -! -! SZA = solar zenith angle in degrees -! COSSZA = U0 = cos(SZA) -!----------------------------------------------------------------------- - implicit none - real*8, intent(in) :: GMTIME,YGRDJ,XGRDI, SZA - integer, intent(in) :: NDAY - real*8, intent(out) :: COSSZA,SOLFX -! - real*8 PI, PI180, LOCT - real*8 SINDEC, SOLDEK, COSDEC, SINLAT, SOLLAT, COSLAT, COSZ -! - PI = 3.141592653589793d0 - PI180 = PI/180.d0 - !SINDEC = 0.3978d0*sin(0.9863d0*(dble(NDAY)-80.d0)*PI180) - !SOLDEK = asin(SINDEC) - !COSDEC = cos(SOLDEK) - !SINLAT = sin(YGRDJ) - !SOLLAT = asin(SINLAT) - !COSLAT = cos(SOLLAT) -!! - !LOCT = (((GMTIME)*15.d0)-180.d0)*PI180 + XGRDI - !COSSZA = COSDEC*COSLAT*cos(LOCT) + SINDEC*SINLAT - !SZA = acos(COSSZA)/PI180 -! - COSSZA = COS(SZA*PI180) - - SOLFX = 1.d0-(0.034d0*cos(dble(NDAY-186)*2.d0*PI/365.d0)) -! - return - end subroutine SOLARZ -! -! -!----------------------------------------------------------------------- - subroutine SPHERE(GMU,RAD,ZHL,ZZHT,AMF,L1_) -!----------------------------------------------------------------------- -! Calculation of spherical geometry; derive tangent heights, slant path -! lengths and air mass factor for each layer. Not called when -! SZA > 98 degrees. Beyond 90 degrees, include treatment of emergent -! beam (where tangent height is below altitude J-value desired at). -!----------------------------------------------------------------------- -! in: -! GMU = MU0 = cos(solar zenith angle) -! RAD radius of Earth mean sea level (cm) -! ZHL(L) height (cm) of the bottome edge of CTM level L -! ZZHT scale height (cm) used above top of CTM (ZHL(L_+1) -! L1_ dimension of CTM = levels +1 -! out: -! AMF(I,J) = air mass factor for CTM level I for sunlight reaching J -!----------------------------------------------------------------------- - implicit none - integer, intent(in) :: L1_ - real*8, intent(in) :: GMU,RAD,ZHL(L1_),ZZHT - real*8, intent(out) :: AMF(L1_,L1_) -! -! RZ Distance from centre of Earth to each point (cm) -! RQ Square of radius ratios -! TANHT Tangent height for the current SZA -! XL Slant path between points -! - integer I, J, K, II - real*8 AIRMAS, XMU1, XMU2, XL, DIFF, TANHT & - & ,Ux,H,RZ(L1_),RQ(L1_),ZBYR -! -! Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- & - & 0.6817d0*EXP(-57.3d0*abs(Ux)/SQRT(1.0d0+5500.d0*H))/ & - & (1.0d0+0.625d0*H))) -! - RZ(1) = RAD + ZHL(1) - ZBYR = ZZHT/RAD - do II = 2,L1_ - RZ(II) = RAD + ZHL(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - enddo - if (GMU .lt. 0.0d0) then - TANHT = RZ(1)/dsqrt(1.0d0-GMU**2) - else - TANHT = RZ(1) - endif -! -! Go up from the surface calculating the slant paths between each level -! and the level above, and deriving the appropriate Air Mass Factor - do 16 J = 1,L1_ - do I = 1,L1_ - AMF(I,J) = 0.d0 - enddo -! -! Air Mass Factors all zero if below the tangent height - if (RZ(J) .lt. TANHT) goto 16 -! Ascend from layer J calculating AMFs - XMU1 = abs(GMU) - do I = J,L1_-1 - XMU2 = dsqrt(1.0d0 - RQ(I)*(1.0d0-XMU1**2)) - XL = RZ(I+1)*XMU2 - RZ(I)*XMU1 - AMF(I,J) = XL / (RZ(I+1)-RZ(I)) - XMU1 = XMU2 - enddo -! Use function and scale height to provide AMF above top of model - AMF(L1_,J) = AIRMAS(XMU1,ZBYR) -! -! Twilight case - Emergent Beam - if (GMU .ge. 0.0d0) goto 16 - XMU1 = abs(GMU) -! Descend from layer J - do II = J-1,1,-1 - DIFF = RZ(II+1)*sqrt(1.0d0-XMU1**2)-RZ(II) - if (II.eq.1) DIFF = max(DIFF,0.d0) ! filter -! Tangent height below current level - beam passes through twice - if (DIFF .lt. 0.0d0) then - XMU2 = sqrt(1.0d0 - (1.0d0-XMU1**2)/RQ(II)) - XL = abs(RZ(II+1)*XMU1-RZ(II)*XMU2) - AMF(II,J) = 2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1 = XMU2 -! Lowest level intersected by emergent beam - else - XL = RZ(II+1)*XMU1*2.0d0 - AMF(II,J) = XL/(RZ(II+1)-RZ(II)) - goto 16 - endif - enddo -! - 16 continue - return - end subroutine SPHERE - -! -!----------------------------------------------------------------------- -! bian (11/16/06) start -! subroutine EXTRAL(AER,ADX,L1X,L2X,NX,JTAUMX,ATAU,ATAU0, JXTRA) - subroutine EXTRAL(NCTA,AER,ADX,L1X,L2X,NX,JTAUMX,ATAU,ATAU0, JXTRA) -! bian end -!----------------------------------------------------------------------- -! -! new version 5.3, add sub-layers (JXTRA) to thick cloud/aerosol layers -! this version sets up log-spaced sub-layers of increasing thickness ATAU -! -! AER(NCTA,L=1:L1X) = Optical Depth in layer L (general visible OD) -! This is not used in the calculation of J's but in calculating -! the number in levels to insert in each layer L -! Set for log-spacing of tau levels, increasing top-down. -! AER(1:NCTA-1,L) = aerosol+cloud OD (up to NCTA-1 types, -! index type = ADX(1:NCTA-1,L) -! AER(NCTA,L) = Rayleigh-not used here -! -! N.B. the TTAU, etc caluclate here are not really used elsewhere -! -!---The log-spacing parameters have been tested for convergence and chosen -!--- to be within 0.5% for ranges OD=1-500, rflect=0-100%, mu0=0.1-1.0 -!--- use of ATAU = 1.18 and min = 0.01, gives at most +135 pts for OD=100 -!----------------------------------------------------------------------- -! - implicit none - integer, intent(in) :: JTAUMX,L1X,L2X !index of cloud/aerosol - integer, intent(in) :: NX !Mie scattering array size -! bian (11/16/06) start - integer, intent(in) :: NCTA - real*8, intent(in) :: AER(NCTA,L1X) !cloud+3aerosol OD in each layer - integer, intent(in) :: ADX(NCTA,L1X) !index of cloud/aerosol -! bian end - real*8, intent(in) :: ATAU,ATAU0 - integer, intent(out) :: JXTRA(L2X+1) !number of sub-layers to be added -! - integer JTOTL,I,L,L2 - real*8 DTAUX(L1X),TTAU(L2X+1),DTAUJ, ATAU1,ATAULN,ATAUM,ATAUN1 -! -!---Reinitialize arrays - TTAU(:) = 0.d0 - JXTRA(:) = 0 -! -!---Set up total optical depth over each CTM level (L=1:L1X) -!--- DTAUX(L) = bulk properties (OD) of each CTM layer -! - do L = 1,L1X -! Total optical depth from all elements I=1:NCTA-1 = clouds + aerosol types -! Assume here that AER(1:NCTA-1, 1:L1X) is 'visible' Optical Depth = 600 nm -! do NOT count if ADX = 0 - DTAUX(L) = 0.d0 - do I = 1,NCTA-1 - if (ADX(I,L) .gt. 0) DTAUX(L) = DTAUX(L) + AER(I,L) - enddo - enddo -! -!---combine these edge- and mid-layer points into grid of size: -!--- L2X+1 = 2*L1X+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2X+1) -!--- note that TTAU(L2X+1)=0 and TTAU(1)=total OD -! -!---Divide thick layers to achieve better accuracy in the scattering code -!---In the original fast-J, equal sub-layers were chosen, this is wasteful -!---and this new code (ver 5.3) uses log-scale: -!--- Each succesive layer (down) increase thickness by ATAU > 1 -!--- e.g., if ATAU = 2, a layer with OD = 15 could be divided into -!--- 4 sub-layers with ODs = 1 - 2 - 4 - 8 -!---The key parameters are: -!--- ATAU = factor increase from one layer to the next -!--- ATAUMN = the smallest OD layer desired -!--- JTAUMX = maximum number of divisions (i.e., may not get to ATAUMN) -!---These are hardwired below, can be changed, but have been tested/optimized -! - ATAU1 = ATAU - 1.d0 - ATAULN = log(ATAU) - TTAU(L2X+1) = 0.0d0 - do L2 = L2X,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ -!---Now compute the number of log-spaced sub-layers to be added in -!--- the interval TTAU(L2) > TTAU(L2+1) -!---The objective is to have successive TAU-layers increasing by factor ATAU >1 -!---the number of sub-layers + 1 - if (TTAU(L2) .lt. ATAU0) then - JXTRA(L2) = 0 - else - ATAUM = max(ATAU0, TTAU(L2+1)) - ATAUN1 = log(TTAU(L2)/ATAUM) / ATAULN - JXTRA(L2) = min(JTAUMX, max(0, int(ATAUN1 - 0.5d0))) - endif - enddo -! -!---check on overflow of arrays, cut off JXTRA at lower L if too many levels - JTOTL = L2X + 2 - do L2 = L2X,1,-1 - JTOTL = JTOTL + JXTRA(L2) - if (JTOTL .gt. NX/2) then - write(6,'(A,2I5,F9.2)') 'N_/L2_/L2-cutoff JXTRA:',NX,L2X,L2 - do L = L2,1,-1 - JXTRA(L) = 0 - enddo - go to 10 - endif - enddo - 10 continue -! - return - end subroutine EXTRAL -! -! -!----------------------------------------------------------------------- - subroutine OPMIE & - & (KW,KM,WAVEL,ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,FMEAN,FJTOP,FJBOT) -!----------------------------------------------------------------------- -! bian (11/15/06) : expand number of profiles from 5 to NCTA -! (1 cloud, 2:NCTA-1 aerosol, NCTA Rayleigh scattering) -! in: -! KW = wavelength bin # (1:18) -! KM = wavelength index for Mie properties (1:4 = 300-400-600-999 nm) -! WAVEL = wavelength of bin (in nm) - not now used -! ABX(L1_) = vertical profiles of ABSORPTION Optical Depth in each layer -! includes O2 and O3 for now (BC under aerosols) -! AER(1:NCTA,1:L1_) = NCTA vertical profiles of Optical Depth in each layer -! ADX(1:NCTA,1:L1_) = integer index of the scattering properties of each AER -! 1:NCTA-1 are reserved for aerosols and clouds -! NCTA is meant only for Rayleigh scattering! -! JXTRA(1:L1_) = number 0:J = no. of additional levels to be inserted -! U0 = cos (SZA) -! RFLECT = Lambertian albedo of surface -! out: -! FMEAN(1:L_) = mean actinic flux at standard CTM levels (mid-layer) -!----------------------------------------------------------------------- -! -! DTAUX Local optical depth of each CTM level -! TTAU Optical depth of air vertically above each point (to top of atm) -! FTAU Attenuation of solar beam -! POMEGA Scattering phase function -! -!---new Ver 5.3 code adds sub-layers (# = JXTRA(L2)) using ATAU as the -! factor increase from sub-layer to sub-layer -! -! fast-J Mie code for J_s, only uses 8-term expansion, 4-Gauss pts -! Currently allow up to A_ aerosol phase functions (at all altitudes) to -! be associated with optical depth AER(1:L2_) = aerosol opt.depth @ 1000 nm -! -! Pick Mie-wavelength with phase function and Qext: e.g., -! 01 RAYLE = Rayleigh phase -! 02 ISOTR = isotropic -! 03 ABSRB = fully absorbing 'soot', wavelength indep. -! 04 X_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -! 05 X_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -!. . . -! 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -!. . . -! 13 Ice-H = hexagonal ice cloud (Mishchenko) -! 14 Ice-I = irregular ice cloud (Mishchenko) -! -! Choice of the NCTA-1 aerosol/cloud indices ADX is made earlier -! Optical depths for the NCTA-1 (aerosol+clouds) = AER -! -!----------------------------------------------------------------------- - implicit none -# include "fastJX53c_parm_CTM.h" -# include "fastJX53c_parm_MIE.h" -# include "fastJX53c_cmn_JVdat.h" - - real*8, intent(in) :: WAVEL,AER(NCTA,L1_),ABX(L1_),AMF(L1_,L1_) - real*8, intent(in) :: U0,RFLECT - integer, intent(in) :: KW,KM,ADX(NCTA,L1_) - integer, intent(in) :: JXTRA(L2_+1) - real*8, intent(out) :: FMEAN(L_),FJTOP,FJBOT -! - integer JNDLEV(L_),JADDLV(L2_+1),JADDTO(L2_+1),L2LEV(L2_+1) & - & ,JTOTL,I,II,J,K,L,IX,JK, L2,L2L,L22,LZ,LZZ,NDZ -! - real*8 QXMIE(NCTA),XLAER(NCTA),SSALB(NCTA),DTAUX(L1_),PIAER(NCTA,L1_) & - & ,POMEGAJ(2*M_,L2_+1),TTAU(L2_+1),FTAU(L1_) & - & ,FTAU2(L2_+1),DTTAU,DFTAU,dPOMEGA(2*M_) & - & ,XLO2,XLO3,XLRAY,XLTAU,ZK,TAUDN,TAUUP,ZK2 & - & ,DTAUJ,DTAUAD,TAUBTM,TAUTOP,FBTM,FTOP,POMEGAB(2*M_) & - & ,ATAUA,ATAUZ -!--- variables used in mie code----------------------------------------- - real*8 FJ(N_),POMEGA(2*M_,N_),FZ(N_),ZTAU(N_),ZREFL,ZU0,ZFLUX - real*8 FJT,FJB - integer MFIT, ND -! -!---Reinitialize arrays - ZTAU(:) = 0.d0 - FZ(:) = 0.d0 - POMEGA(:,:) = 0.d0 -! -! -!---Set up optical depth DTAUX(L), and scattering fraction PIAER(1:NCTA,L) -!--- where L = 1:L1_ = bulk properties of each CTM layer. - do L = 1,L1_ -! - do I = 1,NCTA-1 - if (ADX(I,L) .eq. 0) then - QXMIE(I) = 0.d0 - SSALB(I) = 0.d0 - else -!---for Mie code scale extinction at 600 nm to wavelength WAVEL (QXMIE) - - QXMIE(I) = QAA(KM,ADX(I,L))/QAA(3,ADX(I,L)) - SSALB(I) = SSA(KM,ADX(I,L)) - endif - enddo -!---special case for Rayleigh scattering - QXMIE(NCTA) = 1.d0 - SSALB(NCTA) = 1.d0 - do I = 1,NCTA - XLAER(I) = AER(I,L)*QXMIE(I) - enddo - -! - DTAUX(L) = ABX(L) - do I = 1,NCTA - DTAUX(L) = DTAUX(L) + XLAER(I) - enddo -!---fractional extinction for Rayleigh scattering and each aerosol type - do I = 1,NCTA - PIAER(I,L) = SSALB(I)*XLAER(I)/DTAUX(L) - enddo -! - enddo -! -!---Calculate attenuated incident beam exp(-TTAU/U0 = DTAUX * AirMassFactor) -!--- at the edges of the CTM layers L=1:L1_ - do L = 1,L1_ - if (AMF(L,L) .gt. 0.0d0) then - XLTAU = 0.0d0 - do I = 1,L1_ - XLTAU = XLTAU + DTAUX(I)*AMF(I,L) - enddo - if (XLTAU .gt. 76.d0) then ! zero out flux at 1e-33 - FTAU(L) = 0.d0 - else - FTAU(L) = exp(-XLTAU) - endif - else - FTAU(L) = 0.0d0 - endif - enddo -! -!---Define the total scattering phase fn for each CTM layer L=1:L_+1 -!--- from a DTAUX-wt_d mix of aerosols, cloud & Rayleigh -!---No. of quadrature pts fixed at 4(M_), expansion of phase fn @ 8 - MFIT = 2*M_ - do L = 1,L1_ - do I = 1,MFIT - POMEGAJ(I,L) = 0.d0 - do K = 1,NCTA - POMEGAJ(I,L)=POMEGAJ(I,L) + PIAER(K,L)*PAA(I,KM,ADX(K,L)) - enddo - enddo - enddo -! -!--printout diagnositcs of different aerosol+cld contrib to OD -! if(KW.eq.18) then -! do L=1,L1_ -! write(6,'(3i5,1p,20e12.5)') L,JXTRA(L+L),JXTRA(L+L-1), -! & DTAUX(L),(AER(I,L),I=1,NCTA) -! enddo -! endif -! -! -!------------------------------------------------------------------------ -! Take optical properties on CTM layers and convert to a photolysis -! level grid corresponding to layer centres and boundaries. This is -! required so that J-values can be calculated for the centre of CTM -! layers; the index of these layers is kept in the JNDLEV array. -!------------------------------------------------------------------------ -! -!---Now combine the CTM layer edges (1:L_+2) with the CTM mid-layer -!--- points (1:L_) plus 1 for the mid point of added top layer. -! -!---combine these edge- and mid-layer points into grid of size: -!--- L2_+1 = 2*L1_+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2_+1) -!--- note that TTAU(L2_+1)=0 and TTAU(1)=total OD - TTAU(L2_+1) = 0.0d0 - do L2 = L2_,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ - enddo -! -!---reflected flux from surface - if (U0 .gt. 0.d0) then - ZFLUX = U0*FTAU(1)*RFLECT/(1.d0+RFLECT) - else - ZFLUX = 0.d0 - endif -! -!---calculate attenuated beam FTAU2 on the new doubled-levels L2=1:L2_+1 -!--- calculate FTAU2 at CTM mid-layers from sqrt -!--- L2_ = 2*L1_ = 2*L_+2 -! - FTAU2(L2_+1) = 1.0d0 - FTAU2(L2_) = sqrt(1.0d0*FTAU(L1_)) - FTAU2(L2_-1) = FTAU(L1_) - do L2 = L2_-3,1,-2 - L = (L2+1)/2 - FTAU2(L2) = FTAU(L) - FTAU2(L2+1) = sqrt(FTAU(L+1)*FTAU(L)) - enddo -! -! Calculate scattering properties, level centres then level boundaries -! ***be careful of order, we are shifting the 'POMEGAJ' upward in index*** - do L2 = L2_,2,-2 - L = L2/2 - do I = 1,MFIT - POMEGAJ(I,L2) = POMEGAJ(I,L) - enddo - enddo -!---lower boundary value is set (POMEGAJ(I,1), but set upper: - do I = 1,MFIT - POMEGAJ(I,L2_+1) = POMEGAJ(I,L2_) - enddo -!---now have POMEGAJ filled at even points from L2=3:L2_-1 -!---use inverse interpolation for correct tau-weighted values at edges - do L2 = 3,L2_-1,2 - TAUDN = TTAU(L2-1)-TTAU(L2) - TAUUP = TTAU(L2)-TTAU(L2+1) - do I = 1,MFIT - POMEGAJ(I,L2) = (POMEGAJ(I,L2-1)*TAUDN + & - & POMEGAJ(I,L2+1)*TAUUP) / (TAUDN+TAUUP) - enddo - enddo -!---at this point FTAU2(1:L2_+1) and POMEAGJ(1:8, 1:L2_+1) -!--- where FTAU2(L2_+1) = 1.0 = top-of-atmos, FTAU2(1) = surface -! -!------------------------------------------------------------------------ -! Calculate cumulative total and define levels we want J-values at. -! Sum upwards for levels, and then downwards for Mie code readjustments. -! -! JXTRA(L2) Number of new levels to add between (L2) and (L2+1) -! ***JXTRA(1:L2_+1) is calculated based on the aerosol+cloud OD_s -! JADDLV(L2) Number of new levels actually added at each wavelength -! where JADDLV = 0 when there is effectively no FTAU2 -! JADDTO(L2) Total number of new levels to add to and above level (L2) -! JNDLEV(L) = L2 index that maps on CTM mid-layer L -! -!------------------------------------------------------------------------ -! -!---JADDLV(L2=1:L2_) = number of levels to add between TTAU2(L2) and TTAU(L2+1) -!--- JADDLV is taken from JXTRA, which is based on visible OD. -!--- JADDTO(L2=1:L2_+1) is the cumulative number of levels to be added -!---note that JADDLV and JADDTO will change with wavelength and solar zenith -! -!--now try to insert additional levels for thick clouds, ONLY IF FTAU2 > 1.e-8 -!-- this will cut off additional levels where the solar beam is negligible. -! - do L2 = 1,L2_ - if (FTAU2(L2+1) .lt. 1.d-30) then - JADDLV(L2) = 0 - else - JADDLV(L2) = JXTRA(L2) - endif - enddo - JADDTO(L2_+1) = 0 - do L2 = L2_,1,-1 - JADDTO(L2) = JADDTO(L2+1) + JADDLV(L2) - enddo -! -!---expanded grid now included CTM edge and mid layers plus expanded -!--- grid to allow for finer delta-tau at tops of clouds. -!--- DIM of new grid = L2_ + JADDTO(1) + 1 -! -!---L2LEV(L2) = L2-index for old level L2 in expanded J-grid (w/JADDLV) -! in absence of JADDLV, L2LEV(L2) = L2 - L2LEV(1) = 1 - do L2 = 2,L2_+1 - L2LEV(L2) = L2LEV(L2-1) + 1 + JADDLV(L2-1) - enddo -! -!---JNDLEV(L=1:L_) = L2-index in expanded grid for CTM mid-layer L - do L = 1,L_ - JNDLEV(L) = L2LEV(2*L) - enddo -! -!---------------------SET UP FOR MIE CODE------------------------------- -! -! Transpose the ascending TTAU grid to a descending ZTAU grid. -! Double the resolution - TTAU points become the odd points on the -! ZTAU grid, even points needed for asymm phase fn soln, contain 'h'. -! Odd point added at top of grid for unattenuated beam (Z='inf') -! -! The following mapping holds for JADDLV=0 -! Surface: TTAU(1) ==> ZTAU(2*L2_+1) -! Top: TTAU(L2_) ==> ZTAU(3) -! Infinity: 0.0 ==> ZTAU(1) -! index: 2*(L2_+1-L2)+1 ==> LZ -! -! Mie scattering code only used from surface to level L2_ -!------------------------------------------------------------------------ -! -!------------------------------------------------------------------------ -! Insert new levels, working downwards from the top of the atmosphere -! to the surface (down in 'LZ', up in 'L2'). This allows ztau and pomega -! to be incremented linearly (in a +ve sense), and the flux fz to be -! attenuated top-down (avoiding problems where lower level fluxes are -! zero). -! -! zk fractional increment in level -! dTTAU change in ttau per increment (linear, positive) -! dPOMEGA change in pomega per increment (linear) -! ftaulog change in ftau per increment (exponential, normally < 1) -! -!------------------------------------------------------------------------ -! -! Ascend through atmosphere transposing grid and adding extra points -! remember L2=1 is surface of CTM, but last layer (LZ) in scattering code. -! there are twice the number of layers in the LZ arrays (2*L2_ + 2*JADDTO + 1) -! because we need to insert the intermediate layers (even LZ) for the -! asymmetric scattering code. -! -! -! Transfer the L2=1:L2_+1 values (TTAU,FTAU2,POMEGAJ) onto the reverse -! order, expanded, doubled-level scatter grid. -! Note that we need to deal with the expansion by JADD levels (L2L). -! These JADDLV levels are skipped and need to be interpolated later. -! Note that only odd LZ levels are filled, -! - NDZ = 2*L2_ + 2*JADDTO(1) + 1 -! -! Note that the successive sub-layers have the ratio in OD of ATAU -! ATAUA = (ATAU - 1.d0)/ATAU ! this is the limit for L22=>inf -! - do L2 = 1,L2_+1 ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - ZTAU(LZ) = TTAU(L2) - FZ(LZ) = FTAU2(L2) - do I=1,MFIT - POMEGA(I,LZ) = POMEGAJ(I,L2) - enddo - enddo -! -! Now go thru the pairs of L2 levels to see if we need JADD levels - do L2 = 1,L2_ ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - L22 = L2LEV(L2+1) - L2LEV(L2) - 1 ! L22 = 0 if no added levels - if (L22 .gt. 0) then - TAUBTM = TTAU(L2) - TAUTOP = TTAU(L2+1) - FBTM = FTAU2(L2) - FTOP = FTAU2(L2+1) - do I = 1,MFIT - POMEGAB(I) = POMEGAJ(I,L2) - enddo -! -!---to fit L22 new layers between TAUBOT > TAUTOP, calculate new 1/ATAU factor -!--- such that TAU(just above TAU-btm) = ATUAZ * TAUBTM < TAUBTM -! - ATAUZ = exp(-log(TAUBTM/max(TAUTOP,ATAU0))/float(L22+1)) -! - do L = 1,L22 ! add odd levels between L2LEV(L2) & L2LEV(L2+1) - LZZ = LZ - 2*L ! LZZ = index(odd) of added level in scatt arrays - ZTAU(LZZ) = TAUBTM * ATAUZ - ATAUA=(TAUBTM-ZTAU(LZZ))/(TAUBTM-TAUTOP) !fraction from TAUBTM=>TAUTOP - if (FBTM .lt. 1.d-32) then - FZ(LZZ) = 0.d0 - else - FZ(LZZ) = FBTM * (FTOP/FBTM)**ATAUA - endif - do I = 1,MFIT - POMEGA(I,LZZ) = POMEGAB(I) + & - & ATAUA*(POMEGAJ(I,L2+1)-POMEGAB(I)) - enddo - TAUBTM = ZTAU(LZZ) - FBTM = FZ(LZZ) - do I = 1,MFIT - POMEGAB(I) = POMEGA(I,LZZ) - enddo - enddo - endif - enddo -! -! Now fill in the even points with simple interpolation in scatter arrays: - do LZ = 2,NDZ-1,2 - ZTAU(LZ) = 0.5d0*(ZTAU(LZ-1)+ZTAU(LZ+1)) - FZ(LZ) = sqrt(FZ(LZ-1)*FZ(LZ+1)) - do I=1,MFIT - POMEGA(I,LZ) = 0.5d0*(POMEGA(I,LZ-1)+POMEGA(I,LZ+1)) - enddo - enddo - - ND = NDZ - ZU0 = U0 - ZREFL = RFLECT -! -!---PRINT diagnostics -! write(6,'(A,2I6)') 'Total levels of photolysis in OPMIE',ND - if(ND .gt. N_) then - write(6,'(a,2i9)') ' overflow of scatter arrays:',ND,N_ - stop - endif -! -!----------------------------------------------------------------------- - call MIESCT(FJ,FJT,FJB,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,ZU0,MFIT,ND) -!----------------------------------------------------------------------- -! -!---Move mean intensity from scatter array FJ(LZ=1:ND) -!--- to CTM mid-level array FMEAN(L=1:L_) - do L = 1,L_ - L2L = JNDLEV(L) - LZ = ND+2 - 2*L2L - FMEAN(L) = FJ(LZ) - enddo -!---fluxes reflected at top, incident at bottom (1/2 layer flux) - FJTOP = FJT - FJBOT = FJB -! - return - end subroutine OPMIE -! -!<<<<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>current code revised to JX ver 5.3c (7/05)<<<<<<<<<<<< -! version 5.3c changes include: -! new data files for specral Xsection and mie-scattering. -! add sub-layers (JXTRA) to thick cloud/aerosol layers, -! sets up log-spaced sub-layers of increasing thickness ATAU -! correction 'b' does massive clean up of the linking code, -! now the only subroutine that has access to CTM arrays is PHOTOJ -! Also, the access to the cmn_JVdat.h is 'read-only' after init. -! This should enable safe openMP/MPI coding. -! -! common files and what they mean: -! parm_CTM.h dimensions & params for code (CTM and fast-JX) -! parm_MIE.h dimensions for mie code variables. -! cmn_metdat.h CTM 3-D arrays, time of day, grid, etc. -! cmn_JVdat.h Xsects, Mie, etc., (initialized and then read-only) -! -!<<<<<<<<<<<<<<<<<<<<>>>>overall program revised to run with FAST-JX J-code ver 5.3 (6/05) -! >>>>> now designed to use log spacing in TAU to get <0.5% accuracy -! much better accuracy and fewer added levels vs. old linear adds. -! -!----------------------------------------------------------------------- -! -!<<<<<<<<<<<<<<<<<<<< sub-b code has vastly cleaned up the interfaces and is - now ready for parallel implementation. Also the - standalone version is simpler! - > vastly simplified calling sequences, reduced use of commons - > simplified input datasets - > updated cross-sections AND code for generating new X-sections. - >>> new, improved method for adding layers for thick clouds: - uses log-spacing factor of 1.18 (error in tests <0.3%) - reduces the number of layers (linear with comp costs) - log-spacing eliminates need for upper bound on cloud OD - eliminated some unnecessary bits of previous fast-J - -The common blocks (all local) needed for Mie scattering have been -replaced with local internal arrays passed through calls. - -The new code has been implemented in UCI's CTM with openMP. - ------------------------------------------------------------------ -The new standalone version of fast-JX (fast-JX53.f) requires: - parm_CTM.f parameters for CTM dimensions - parm_MIE.f parameters for Mie scattering arrays - cmn_metdat.f common blocks w/ general CTM data for fast-JX - cmn_JVdat.f common blocks w. specific data for J-values - -The needed data sets standalone runs are included: - FJX_spec.dat spectral data (X-sections+) ver 2005e - FJX-scat.dat scattering data for clouds+aerosols - this data set has been separated from the X-sections - - these are for the standalone run and will not be needed in CTM run - FJX_test.dat set up for p, T, grid etc - atmos_std.dat UCI's old std atmospheres - ECT42_grid.dat used for sample run - ratj.dat UCI's old chemistry set of J's, - shows mapping from fast-JX - - std.out output from this test of fast-JX53 standalone - ------------------------------------------------------------------ - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/std53c.out b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/std53c.out deleted file mode 100644 index d226a57a..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/std53c.out +++ /dev/null @@ -1,295 +0,0 @@ - fast-JX ver-5.3 standalone CTM code - (fort10_06b) UCI J-v8.4 (4/06) JPL02+irHNO4+IUPAC/NO2/VOC+Blitz +flux2006 - x-sect: O2 180.00 260.00 300.00 - x-sect: O3 180.00 260.00 300.00 - x-sect: O3(1D) 180.00 260.00 300.00 - x-sect: NO 300.00 300.00 - x-sect: H2COa 223.00 293.00 - x-sect: H2COb 223.00 293.00 - x-sect: H2O2 200.00 300.00 - x-sect: CH3OOH 297.00 298.00 - x-sect: NO2 220.00 298.00 - x-sect: NO3 297.00 298.00 - x-sect: N2O5 225.00 300.00 - x-sect: HNO2 297.00 298.00 - x-sect: HNO3 200.00 300.00 - x-sect: HNO4 297.00 298.00 - x-sect: ClNO3a 210.00 296.00 - x-sect: ClNO3b 210.00 296.00 - x-sect: Cl2 200.00 300.00 - x-sect: HOCl 297.00 298.00 - x-sect: OClO 204.00 298.00 - x-sect: Cl2O2 229.00 230.00 - x-sect: ClO 297.00 298.00 - x-sect: BrO 297.00 298.00 - x-sect: BrNO3 230.00 298.00 - x-sect: HOBr 297.00 298.00 - x-sect: BrCl 295.00 298.00 - x-sect: N2O 200.00 300.00 - x-sect: CFCl3 210.00 298.00 - x-sect: CF2Cl2 210.00 298.00 - x-sect: F113 210.00 295.00 - x-sect: F114 210.00 298.00 - x-sect: F115 210.00 298.00 - x-sect: CCl4 210.00 298.00 - x-sect: CH3Cl 210.00 298.00 - x-sect: CH3CCl3 210.00 298.00 - x-sect: CH2Cl2 295.00 298.00 - x-sect: CHF2Cl 210.00 298.00 - x-sect: F123 210.00 295.00 - x-sect: F141b 210.00 298.00 - x-sect: F142b 210.00 298.00 - x-sect: CH3Br 210.00 296.00 - x-sect: H1211 210.00 298.00 - x-sect: H1301 210.00 298.00 - x-sect: H2402 210.00 298.00 - x-sect: CH2Br2 210.00 298.00 - x-sect: CHBr3 210.00 296.00 - x-sect: CH3I 210.00 298.00 - x-sect: CF3I 210.00 300.00 - x-sect: OCS 225.00 295.00 - x-sect: PAN 250.00 298.00 - x-sect: CH3NO3 240.00 298.00 - x-sect: ActAld 297.00 298.00 - x-sect: MeVK 297.00 298.00 - x-sect: MeAcr 297.00 298.00 - x-sect: GlyAld 297.00 298.00 - x-sect: MEKeto 297.00 298.00 - x-sect: EAld 297.00 298.00 - x-sect: MGlyxl 297.00 298.00 - x-sect: Glyxla 297.00 298.00 - x-sect: Glyxlb 297.00 298.00 - x-sect: XXXX 299.00 300.00 - x-sect: C3H6O 220.00 300.00 - x-sect: Q2-Acet 240.00 300.00 - x-sect: Q1A-Ace 240.00 300.00 - x-sect: Q1B-Ace 240.00 300.00 - ATAU/ATAU0/JMX 1.18000 0.01000 250 - Aerosol phase functions & wavelengths - (JX_spec.dat) Scattering phase fns, scale extinct @ 999 nm (mjp 5/05) - RAYLE = 1 wavel= 300.0 400.0 600.0 999.0 - 1 Qext =123.5000 39.1000 7.7000 1.0000 - ISOTR = 2 wavel= 300.0 400.0 600.0 999.0 - 2 Qext = 1.0000 1.0000 1.0000 1.0000 - ABSRB = 3 wavel= 300.0 400.0 600.0 999.0 - 3 Qext = 10.0000 9.0000 6.5000 6.5000 - S_Bkg = 4 wavel= 300.0 400.0 600.0 999.0 - 4 Qext = 2.7541 2.4017 1.6454 0.7449 - S_Vol = 5 wavel= 300.0 400.0 600.0 999.0 - 5 Qext = 2.6437 2.5603 2.2221 1.5319 - W_H01 = 6 wavel= 300.0 400.0 600.0 999.0 - 6 Qext = 2.8438 2.3497 1.4037 0.5034 - W_H04 = 7 wavel= 300.0 400.0 600.0 999.0 - 7 Qext = 2.2995 2.4743 2.6719 2.9565 - W_C02 = 8 wavel= 300.0 400.0 600.0 999.0 - 8 Qext = 2.1410 2.1778 2.2287 2.3071 - W_C04 = 9 wavel= 300.0 400.0 600.0 999.0 - 9 Qext = 2.0835 2.1064 2.1345 2.1922 - W_C08 = 10 wavel= 300.0 400.0 600.0 999.0 - 10 Qext = 2.0539 2.0643 2.0883 2.1236 - W_C13 = 11 wavel= 300.0 400.0 600.0 999.0 - 11 Qext = 2.0440 2.0529 2.0716 2.0978 - W_L06 = 12 wavel= 300.0 400.0 600.0 999.0 - 12 Qext = 2.0616 2.0747 2.1005 2.1423 - Ice-H = 13 wavel= 300.0 400.0 600.0 999.0 - 13 Qext = 2.0000 2.0000 2.0000 2.0000 - Ice-I = 14 wavel= 300.0 400.0 600.0 999.0 - 14 Qext = 2.0000 2.0000 2.0000 2.0000 - Mdust 0.15 wavel= 300.0 400.0 600.0 999.0 - 15 Qext = 3.0039 2.4763 1.2768 0.3595 - Mdust 0.16 wavel= 300.0 400.0 600.0 999.0 - 16 Qext = 2.9406 3.1046 2.6144 1.2426 - Mdust 0.17 wavel= 300.0 400.0 600.0 999.0 - 17 Qext = 2.6069 2.8244 3.1156 2.4773 - Mdust 0.18 wavel= 300.0 400.0 600.0 999.0 - 18 Qext = 2.3457 2.4344 2.6416 3.0396 - Mdust 1.19 wavel= 300.0 400.0 600.0 999.0 - 19 Qext = 2.2228 2.2732 2.3707 2.5751 - Mdust 2.20 wavel= 300.0 400.0 600.0 999.0 - 20 Qext = 2.1579 2.1923 2.2560 2.3716 - Mdust 4.21 wavel= 300.0 400.0 600.0 999.0 - 21 Qext = 2.1154 2.1402 2.1852 2.2637 - Photochemistry Scheme with 62 J-values - 1 O2 1.00 mapped onto fast-JX: 1 O2 - 2 O3 1.00 mapped onto fast-JX: 2 O3 - 3 O3(1D) 1.00 mapped onto fast-JX: 3 O3(1D) - 4 NO 1.00 mapped onto fast-JX: 4 NO - 5 H2COa 1.00 mapped onto fast-JX: 5 H2COa - 6 H2COb 1.00 mapped onto fast-JX: 6 H2COb - 7 H2O2 1.00 mapped onto fast-JX: 7 H2O2 - 8 CH3OOH 1.00 mapped onto fast-JX: 8 CH3OOH - 9 NO2 1.00 mapped onto fast-JX: 9 NO2 - 10 NO3 1.00 mapped onto fast-JX: 10 NO3 - 11 N2O5 1.00 mapped onto fast-JX: 11 N2O5 - 12 HNO2 1.00 mapped onto fast-JX: 12 HNO2 - 13 HNO3 1.00 mapped onto fast-JX: 13 HNO3 - 14 HNO4 1.00 mapped onto fast-JX: 14 HNO4 - 15 ClNO3a 1.00 mapped onto fast-JX: 15 ClNO3a - 16 ClNO3b 1.00 mapped onto fast-JX: 16 ClNO3b - 17 Cl2 1.00 mapped onto fast-JX: 17 Cl2 - 18 HOCl 1.00 mapped onto fast-JX: 18 HOCl - 19 OClO 1.00 mapped onto fast-JX: 19 OClO - 20 Cl2O2 1.00 mapped onto fast-JX: 20 Cl2O2 - 21 ClO 1.00 mapped onto fast-JX: 21 ClO - 22 BrO 1.00 mapped onto fast-JX: 22 BrO - 23 BrNO3 1.00 mapped onto fast-JX: 23 BrNO3 - 24 HOBr 1.00 mapped onto fast-JX: 24 HOBr - 25 BrCl 1.00 mapped onto fast-JX: 25 BrCl - 26 N2O 1.00 mapped onto fast-JX: 26 N2O - 27 CFCl3 1.00 mapped onto fast-JX: 27 CFCl3 - 28 CF2Cl2 1.00 mapped onto fast-JX: 28 CF2Cl2 - 29 F113 1.00 mapped onto fast-JX: 29 F113 - 30 F114 1.00 mapped onto fast-JX: 30 F114 - 31 F115 1.00 mapped onto fast-JX: 31 F115 - 32 CCl4 1.00 mapped onto fast-JX: 32 CCl4 - 33 CH3Cl 1.00 mapped onto fast-JX: 33 CH3Cl - 34 CH3CCl3 1.00 mapped onto fast-JX: 34 CH3CCl3 - 35 CH2Cl2 1.00 mapped onto fast-JX: 35 CH2Cl2 - 36 CHF2Cl 1.00 mapped onto fast-JX: 36 CHF2Cl - 37 F123 1.00 mapped onto fast-JX: 37 F123 - 38 F141b 1.00 mapped onto fast-JX: 38 F141b - 39 F142b 1.00 mapped onto fast-JX: 39 F142b - 40 CH3Br 1.00 mapped onto fast-JX: 40 CH3Br - 41 H1211 1.00 mapped onto fast-JX: 41 H1211 - 42 H1301 1.00 mapped onto fast-JX: 42 H1301 - 43 H2402 1.00 mapped onto fast-JX: 43 H2402 - 44 CH2Br2 1.00 mapped onto fast-JX: 44 CH2Br2 - 45 CHBr3 1.00 mapped onto fast-JX: 45 CHBr3 - 46 CH3I 1.00 mapped onto fast-JX: 46 CH3I - 47 CF3I 1.00 mapped onto fast-JX: 47 CF3I - 48 OCS 1.00 mapped onto fast-JX: 48 OCS - 49 PAN 1.00 mapped onto fast-JX: 49 PAN - 50 CH3NO3 1.00 mapped onto fast-JX: 50 CH3NO3 - 51 ActAld 1.00 mapped onto fast-JX: 51 ActAld - 52 MeVK 1.00 mapped onto fast-JX: 52 MeVK - 53 MeAcr 1.00 mapped onto fast-JX: 53 MeAcr - 54 GlyAld 1.00 mapped onto fast-JX: 54 GlyAld - 55 MEKeto 1.00 mapped onto fast-JX: 55 MEKeto - 56 EAld 1.00 mapped onto fast-JX: 56 EAld - 57 MGlyxl 1.00 mapped onto fast-JX: 57 MGlyxl - 58 Glyxla 1.00 mapped onto fast-JX: 58 Glyxla - 59 Glyxlb 1.00 mapped onto fast-JX: 59 Glyxlb - 60 Acet-a 1.00 mapped onto fast-JX: 61 Acet-a - 61 Acet-b 1.00 mapped onto fast-JX: 62 Acet-b - 62 ZZZZ 1.00 has no mapping onto onto fast-JX - std atmos profiles: 18 lat x 12 mon - fast-JX(5.3b)--------------internal print------------ - L z(km) p T d(air) d(O3) col(O2) col(O3) ndx col(aer/cld) - 38 41.15 2.000 261.38 8.48E+16 2.30E+11 8.89E+21 1.15E+17 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 37 25.98 20.000 224.90 2.52E+17 2.29E+12 8.89E+22 3.59E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 36 21.59 40.000 216.40 9.66E+17 4.12E+12 1.78E+23 5.40E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 35 19.07 60.000 212.20 1.68E+18 2.46E+12 2.67E+23 6.02E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 34 17.31 80.000 209.20 2.41E+18 1.06E+12 3.55E+23 6.21E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 33 15.94 100.086 207.70 3.13E+18 4.93E+11 4.45E+23 6.27E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 32 14.80 120.657 208.40 3.82E+18 3.36E+11 5.36E+23 6.31E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 31 13.79 142.114 210.70 4.51E+18 2.98E+11 6.31E+23 6.34E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 30 12.87 164.774 213.40 5.20E+18 3.27E+11 7.32E+23 6.37E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 29 12.00 188.873 215.90 5.92E+18 3.51E+11 8.39E+23 6.40E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 28 11.19 214.573 218.10 6.69E+18 3.70E+11 9.53E+23 6.43E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 27 10.41 241.967 220.50 7.49E+18 3.62E+11 1.08E+24 6.46E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 26 9.67 271.085 223.30 8.31E+18 4.02E+11 1.20E+24 6.49E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 25 8.96 301.897 226.80 9.14E+18 4.60E+11 1.34E+24 6.52E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 24 8.27 334.321 230.90 9.97E+18 5.04E+11 1.49E+24 6.56E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 23 7.60 368.229 235.20 1.08E+19 5.41E+11 1.64E+24 6.59E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 22 6.96 403.450 239.50 1.17E+19 5.43E+11 1.79E+24 6.63E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 21 6.34 439.776 243.80 1.25E+19 5.84E+11 1.95E+24 6.66E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 20 5.76 476.970 247.80 1.34E+19 6.25E+11 2.12E+24 6.70E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 19 5.19 514.768 251.50 1.43E+19 5.46E+11 2.29E+24 6.73E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 18 4.66 552.887 254.90 1.52E+19 5.54E+11 2.46E+24 6.76E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 17 4.16 591.027 258.00 1.61E+19 5.87E+11 2.63E+24 6.79E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 16 3.68 628.883 260.80 1.69E+19 6.19E+11 2.79E+24 6.82E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 15 3.24 666.142 263.40 1.78E+19 5.96E+11 2.96E+24 6.85E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 14 2.83 702.496 265.80 1.86E+19 5.87E+11 3.12E+24 6.87E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 13 2.44 737.643 268.00 1.95E+19 6.13E+11 3.28E+24 6.89E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 12 2.09 771.292 269.80 2.03E+19 6.38E+11 3.43E+24 6.92E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 11 1.77 803.174 271.20 2.10E+19 6.63E+11 3.57E+24 6.94E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 10 1.48 833.040 272.40 2.18E+19 6.86E+11 3.70E+24 6.96E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 9 1.22 860.671 273.50 2.24E+19 6.80E+11 3.82E+24 6.98E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 8 0.98 885.884 274.50 2.30E+19 5.39E+11 3.94E+24 6.99E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 7 0.78 908.534 275.40 2.36E+19 5.52E+11 4.04E+24 7.00E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 6 0.60 928.522 276.20 2.41E+19 5.63E+11 4.13E+24 7.01E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 5 0.45 945.799 276.90 2.45E+19 5.73E+11 4.20E+24 7.02E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 4 0.33 960.375 277.50 2.49E+19 5.81E+11 4.27E+24 7.03E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 0.00E+00 0 0 - 3 0.23 972.319 278.10 2.52E+19 5.88E+11 4.32E+24 7.03E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 1.00E+01 37 3 - 2 0.09 988.929 278.60 2.55E+19 5.95E+11 4.39E+24 7.04E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 1.00E+01 0 0 - 1 0.00 1000.000 278.70 2.58E+19 6.02E+11 4.44E+24 7.05E+18 0 0.00E+00 0 0.00E+00 0 0.00E+00 10 1.00E+01 0 0 - fast-JX: SZA/u0/Frefl/albedo/SOL*fact/ 1.4000 0.9997 0.4254 0.1000 1.0000 - bin: 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 - wvl: 187.00 191.00 193.00 196.00 202.00 208.00 211.00 214.00 261.00 267.00 277.00 295.00 303.00 310.00 316.00 333.00 380.00 574.00 - 37 0.000000 0.000002 0.054195 0.270421 0.372193 0.301281 0.224123 0.140447 0.000001 0.001417 0.056906 0.233306 0.653339 1.048514 1.424467 1.948915 2.000932 1.861500 - 36 0.000000 0.000000 0.000543 0.034151 0.076589 0.046907 0.023315 0.007560 0.000000 0.000000 0.000952 0.029538 0.380624 0.980336 1.476366 2.011539 2.024651 1.874684 - 35 0.000000 0.000000 0.000009 0.006986 0.024344 0.013670 0.005852 0.001429 0.000000 0.000000 0.000144 0.012296 0.336775 1.016487 1.549635 2.059364 2.047493 1.882966 - 34 0.000000 0.000000 0.000000 0.001927 0.010006 0.005734 0.002441 0.000560 0.000000 0.000000 0.000077 0.010017 0.343058 1.058868 1.600414 2.095365 2.068407 1.888182 - 33 0.000000 0.000000 0.000000 0.000586 0.004445 0.002692 0.001195 0.000277 0.000000 0.000000 0.000063 0.009691 0.351461 1.086124 1.634469 2.124950 2.087639 1.892304 - 32 0.000000 0.000000 0.000000 0.000179 0.001985 0.001284 0.000601 0.000144 0.000000 0.000000 0.000056 0.009593 0.356938 1.105399 1.660851 2.150657 2.105554 1.896118 - 31 0.000000 0.000000 0.000000 0.000052 0.000864 0.000599 0.000298 0.000074 0.000000 0.000000 0.000051 0.009491 0.360648 1.120625 1.682996 2.173702 2.122548 1.899895 - 30 0.000000 0.000000 0.000000 0.000014 0.000359 0.000269 0.000142 0.000037 0.000000 0.000000 0.000047 0.009356 0.363129 1.133105 1.702118 2.194692 2.138878 1.903737 - 29 0.000000 0.000000 0.000000 0.000003 0.000141 0.000115 0.000065 0.000017 0.000000 0.000000 0.000042 0.009195 0.364723 1.143492 1.718819 2.213930 2.154663 1.907692 - 28 0.000000 0.000000 0.000000 0.000001 0.000052 0.000046 0.000028 0.000008 0.000000 0.000000 0.000038 0.009017 0.365595 1.152065 1.733358 2.231536 2.169925 1.911772 - 27 0.000000 0.000000 0.000000 0.000000 0.000018 0.000018 0.000012 0.000003 0.000000 0.000000 0.000033 0.008827 0.365798 1.158923 1.745827 2.247529 2.184618 1.915971 - 26 0.000000 0.000000 0.000000 0.000000 0.000006 0.000006 0.000004 0.000001 0.000000 0.000000 0.000030 0.008612 0.365234 1.164008 1.756210 2.261870 2.198657 1.920276 - 25 0.000000 0.000000 0.000000 0.000000 0.000002 0.000002 0.000002 0.000001 0.000000 0.000000 0.000026 0.008372 0.363987 1.167479 1.764614 2.274524 2.211941 1.924669 - 24 0.000000 0.000000 0.000000 0.000000 0.000000 0.000001 0.000001 0.000000 0.000000 0.000000 0.000022 0.008120 0.362253 1.169573 1.771175 2.285453 2.224364 1.929114 - 23 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000019 0.007866 0.360182 1.170458 1.775984 2.294619 2.235829 1.933566 - 22 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000016 0.007621 0.357875 1.170245 1.779096 2.301994 2.246252 1.937977 - 21 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000014 0.007378 0.355277 1.168882 1.780486 2.307553 2.255568 1.942300 - 20 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000012 0.007146 0.352553 1.166585 1.780298 2.311316 2.263726 1.946493 - 19 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000010 0.006945 0.349919 1.163582 1.778679 2.313319 2.270693 1.950505 - 18 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000009 0.006751 0.347007 1.159456 1.775409 2.313570 2.276448 1.954294 - 17 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000007 0.006559 0.343798 1.154247 1.770569 2.312140 2.280983 1.957836 - 16 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000006 0.006379 0.340483 1.148244 1.764405 2.309143 2.284297 1.961104 - 15 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000005 0.006220 0.337247 1.141733 1.757172 2.304707 2.286404 1.964078 - 14 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000005 0.006077 0.334034 1.134729 1.748968 2.298950 2.287322 1.966745 - 13 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000004 0.005945 0.330810 1.127281 1.739923 2.291997 2.287088 1.969103 - 12 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000004 0.005827 0.327676 1.119599 1.730259 2.283991 2.285753 1.971158 - 11 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000003 0.005727 0.324731 1.111882 1.720185 2.275074 2.283389 1.972920 - 10 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000003 0.005646 0.322047 1.104286 1.709879 2.265386 2.280098 1.974405 - 9 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000003 0.005586 0.319676 1.096929 1.699489 2.255079 2.276012 1.975636 - 8 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.005546 0.317590 1.089838 1.689114 2.244319 2.271294 1.976635 - 7 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.005511 0.315561 1.082799 1.678715 2.233290 2.266141 1.977431 - 6 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.005480 0.313582 1.075867 1.668433 2.222241 2.260774 1.978053 - 5 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.005454 0.311699 1.069191 1.658499 2.211473 2.255426 1.978530 - 4 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.005432 0.309948 1.062929 1.649165 2.201314 2.250328 1.978887 - 3 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000002 0.004916 0.264171 0.885868 1.370062 1.867360 2.076386 2.227457 - 2 ********* 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000001 0.002634 0.141768 0.475556 0.736529 1.010214 1.128726 1.199499 - 1 ********* 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000001 0.002499 0.136093 0.458983 0.713256 0.984253 1.111335 1.195838 - fast-JX(5.3b)--------------internal print------------ -Step= 1 Day= 80 UT(hr)=12.0 SZA= 1.40 LAT x LONG= 1.40 0.00 - L= O2 O3 O3(1D) NO H2COa H2COb H2O2 CH3OOH NO2 NO3 N2O5 HNO2 HNO3 HNO4 ClNO3a ClNO3b Cl2 HOCl OClO Cl2O2 ClO BrO BrNO3 HOBr BrCl N2O CFCl3 CF2Cl2 F113 F114 F115 CCl4 CH3Cl CH3CCl3 CH2Cl2 CHF2Cl F123 F141b F142b CH3Br H1211 H1301 H2402 CH2Br2 CHBr3 CH3I CF3I OCS PAN CH3NO3 ActAld MeVK MeAcr GlyAld MEKeto EAld MGlyxl Glyxla Glyxlb Acet-a Acet-b ZZZZ - 37 7.00E-11 1.05E-03 2.71E-04 7.76E-08 7.39E-05 1.01E-04 1.95E-05 1.44E-05 1.67E-02 3.28E-01 1.05E-04 3.58E-03 2.16E-05 6.75E-05 9.11E-05 3.14E-05 4.58E-03 5.81E-04 1.60E-01 3.19E-03 6.04E-04 7.43E-02 2.77E-03 4.20E-03 1.85E-02 1.14E-07 2.41E-06 2.21E-07 4.00E-07 2.52E-08 1.89E-09 4.39E-06 5.97E-08 3.77E-06 3.80E-07 1.06E-09 3.42E-07 5.33E-07 3.69E-09 6.32E-06 1.16E-05 1.20E-06 1.09E-05 2.66E-05 5.59E-05 1.84E-05 7.65E-05 1.56E-06 2.21E-05 3.03E-06 2.07E-05 4.68E-05 8.22E-06 2.81E-05 4.31E-05 1.26E-04 1.29E-03 4.44E-05 1.06E-04 1.33E-05 2.81E-08 0.00E+00 - 36 8.51E-12 8.70E-04 1.08E-04 1.89E-09 7.15E-05 1.03E-04 1.38E-05 1.18E-05 1.69E-02 3.30E-01 5.06E-05 3.64E-03 4.43E-06 3.53E-05 6.76E-05 1.61E-05 4.63E-03 5.71E-04 1.62E-01 2.95E-03 3.17E-04 7.57E-02 2.71E-03 4.19E-03 1.87E-02 1.79E-08 3.88E-07 3.11E-08 6.10E-08 3.72E-09 2.92E-10 6.17E-07 8.98E-09 6.03E-07 5.86E-08 1.56E-10 5.10E-08 8.30E-08 5.25E-10 8.33E-07 1.45E-06 1.53E-07 1.42E-06 2.84E-06 7.42E-06 1.04E-05 4.44E-05 1.30E-07 4.18E-06 1.92E-06 1.45E-05 4.12E-05 8.30E-06 1.99E-05 3.04E-05 1.10E-04 1.17E-03 4.07E-05 1.06E-04 4.72E-06 4.55E-09 0.00E+00 - 35 2.42E-12 8.60E-04 9.30E-05 2.67E-10 7.31E-05 1.05E-04 1.35E-05 1.19E-05 1.71E-02 3.32E-01 4.55E-05 3.70E-03 2.14E-06 3.19E-05 6.57E-05 1.48E-05 4.71E-03 5.81E-04 1.65E-01 2.98E-03 2.95E-04 7.74E-02 2.74E-03 4.24E-03 1.89E-02 5.26E-09 1.16E-07 8.78E-09 1.78E-08 1.08E-09 8.62E-11 1.80E-07 2.62E-09 1.80E-07 1.73E-08 4.51E-11 1.47E-08 2.44E-08 1.49E-10 2.41E-07 4.18E-07 4.40E-08 4.13E-07 7.90E-07 3.02E-06 9.69E-06 4.11E-05 3.42E-08 2.11E-06 1.85E-06 1.42E-05 3.82E-05 8.46E-06 1.94E-05 2.85E-05 1.11E-04 1.08E-03 4.14E-05 1.07E-04 3.31E-06 1.37E-09 0.00E+00 - 34 9.89E-13 8.65E-04 9.36E-05 1.01E-10 7.50E-05 1.07E-04 1.36E-05 1.21E-05 1.73E-02 3.33E-01 4.52E-05 3.74E-03 1.59E-06 3.15E-05 6.58E-05 1.47E-05 4.78E-03 5.91E-04 1.67E-01 3.04E-03 3.01E-04 7.87E-02 2.78E-03 4.29E-03 1.90E-02 2.09E-09 4.67E-08 3.41E-09 7.05E-09 4.25E-10 3.46E-11 7.36E-08 1.04E-09 7.28E-08 6.93E-09 1.78E-11 5.83E-09 9.71E-09 5.85E-11 9.89E-08 1.75E-07 1.82E-08 1.72E-07 3.27E-07 2.03E-06 9.69E-06 4.11E-05 1.42E-08 1.63E-06 1.90E-06 1.46E-05 3.57E-05 8.59E-06 1.99E-05 2.79E-05 1.14E-04 9.92E-04 4.24E-05 1.07E-04 2.81E-06 0.00E+00 0.00E+00 - 33 4.53E-13 8.70E-04 9.53E-05 5.01E-11 7.64E-05 1.09E-04 1.37E-05 1.23E-05 1.75E-02 3.33E-01 4.55E-05 3.78E-03 1.40E-06 3.15E-05 6.65E-05 1.49E-05 4.84E-03 6.00E-04 1.68E-01 3.08E-03 3.08E-04 7.98E-02 2.81E-03 4.33E-03 1.92E-02 9.18E-10 2.08E-08 1.49E-09 3.09E-09 1.86E-10 1.53E-11 3.35E-08 4.54E-10 3.25E-08 3.06E-09 7.82E-12 2.57E-09 4.28E-09 2.56E-11 4.54E-08 8.32E-08 8.37E-09 8.08E-08 1.54E-07 1.69E-06 9.88E-06 4.20E-05 6.88E-09 1.47E-06 1.94E-06 1.50E-05 3.34E-05 8.71E-06 2.04E-05 2.72E-05 1.16E-04 9.21E-04 4.32E-05 1.08E-04 2.48E-06 0.00E+00 0.00E+00 - 32 2.14E-13 8.75E-04 9.69E-05 2.60E-11 7.75E-05 1.10E-04 1.39E-05 1.25E-05 1.77E-02 3.34E-01 4.59E-05 3.82E-03 1.33E-06 3.16E-05 6.72E-05 1.51E-05 4.89E-03 6.07E-04 1.70E-01 3.12E-03 3.12E-04 8.07E-02 2.83E-03 4.36E-03 1.93E-02 4.13E-10 9.36E-09 6.58E-10 1.38E-09 8.29E-11 6.86E-12 1.55E-08 2.02E-10 1.47E-08 1.37E-09 3.47E-12 1.15E-09 1.91E-09 1.14E-11 2.13E-08 4.17E-08 3.96E-09 3.99E-08 7.55E-08 1.55E-06 1.00E-05 4.26E-05 3.50E-09 1.40E-06 1.97E-06 1.52E-05 3.15E-05 8.80E-06 2.07E-05 2.64E-05 1.18E-04 8.61E-04 4.38E-05 1.08E-04 2.24E-06 0.00E+00 0.00E+00 - 31 1.01E-13 8.79E-04 9.83E-05 1.34E-11 7.84E-05 1.11E-04 1.42E-05 1.26E-05 1.78E-02 3.35E-01 4.63E-05 3.85E-03 1.32E-06 3.17E-05 6.80E-05 1.53E-05 4.93E-03 6.13E-04 1.71E-01 3.15E-03 3.16E-04 8.16E-02 2.85E-03 4.40E-03 1.94E-02 1.84E-10 4.14E-09 2.87E-10 6.05E-10 3.63E-11 3.02E-12 7.11E-09 8.81E-11 6.55E-09 6.03E-10 1.52E-12 5.06E-10 8.38E-10 5.01E-12 9.96E-09 2.21E-08 1.87E-09 2.07E-08 3.82E-08 1.52E-06 1.02E-05 4.34E-05 1.84E-09 1.37E-06 1.99E-06 1.54E-05 2.98E-05 8.89E-06 2.09E-05 2.57E-05 1.19E-04 8.10E-04 4.43E-05 1.08E-04 2.07E-06 4.63E-10 0.00E+00 - 30 4.73E-14 8.84E-04 9.96E-05 6.64E-12 7.92E-05 1.12E-04 1.44E-05 1.28E-05 1.80E-02 3.35E-01 4.67E-05 3.88E-03 1.33E-06 3.18E-05 6.93E-05 1.56E-05 4.98E-03 6.18E-04 1.73E-01 3.18E-03 3.19E-04 8.23E-02 2.88E-03 4.43E-03 1.95E-02 7.91E-11 1.77E-09 1.23E-10 2.58E-10 1.54E-11 1.29E-12 3.20E-09 3.72E-11 2.82E-09 2.56E-10 6.44E-13 2.18E-10 3.56E-10 2.16E-12 4.63E-09 1.32E-08 8.75E-10 1.17E-08 2.04E-08 1.58E-06 1.06E-05 4.49E-05 1.02E-09 1.37E-06 2.01E-06 1.55E-05 2.82E-05 8.97E-06 2.11E-05 2.49E-05 1.21E-04 7.65E-04 4.47E-05 1.09E-04 1.92E-06 2.26E-09 0.00E+00 - 29 2.28E-14 8.88E-04 1.01E-04 3.16E-12 7.99E-05 1.13E-04 1.46E-05 1.29E-05 1.81E-02 3.36E-01 4.71E-05 3.91E-03 1.36E-06 3.19E-05 7.05E-05 1.59E-05 5.02E-03 6.23E-04 1.74E-01 3.21E-03 3.21E-04 8.30E-02 2.89E-03 4.46E-03 1.96E-02 3.25E-11 7.30E-10 5.00E-11 1.05E-10 6.28E-12 5.28E-13 1.43E-09 1.50E-11 1.18E-09 1.05E-10 2.61E-13 8.99E-11 1.45E-10 8.84E-13 2.18E-09 9.23E-09 4.19E-10 7.74E-09 1.20E-08 1.66E-06 1.09E-05 4.63E-05 6.12E-10 1.37E-06 2.02E-06 1.57E-05 2.67E-05 9.05E-06 2.13E-05 2.41E-05 1.22E-04 7.22E-04 4.51E-05 1.09E-04 1.79E-06 3.95E-09 0.00E+00 - 28 1.18E-14 8.91E-04 1.01E-04 1.43E-12 8.05E-05 1.14E-04 1.48E-05 1.30E-05 1.82E-02 3.37E-01 4.74E-05 3.94E-03 1.38E-06 3.21E-05 7.16E-05 1.62E-05 5.05E-03 6.28E-04 1.75E-01 3.23E-03 3.23E-04 8.37E-02 2.91E-03 4.48E-03 1.97E-02 1.29E-11 2.91E-10 1.93E-11 4.10E-11 2.44E-12 2.10E-13 6.54E-10 5.78E-12 4.79E-10 4.13E-11 1.01E-13 3.57E-11 5.66E-11 3.45E-13 1.09E-09 7.63E-09 2.16E-10 6.03E-09 8.15E-09 1.73E-06 1.12E-05 4.75E-05 4.10E-10 1.38E-06 2.04E-06 1.58E-05 2.53E-05 9.12E-06 2.14E-05 2.33E-05 1.22E-04 6.82E-04 4.55E-05 1.09E-04 1.67E-06 5.44E-09 0.00E+00 - 27 6.97E-15 8.95E-04 1.02E-04 6.16E-13 8.10E-05 1.15E-04 1.50E-05 1.30E-05 1.84E-02 3.37E-01 4.77E-05 3.97E-03 1.40E-06 3.22E-05 7.27E-05 1.65E-05 5.09E-03 6.32E-04 1.76E-01 3.25E-03 3.24E-04 8.42E-02 2.93E-03 4.51E-03 1.98E-02 5.01E-12 1.16E-10 7.16E-12 1.58E-11 9.23E-13 8.34E-14 3.29E-10 2.16E-12 1.99E-10 1.62E-11 3.75E-14 1.41E-11 2.17E-11 1.31E-13 6.16E-10 7.14E-09 1.27E-10 5.39E-09 6.41E-09 1.82E-06 1.15E-05 4.87E-05 3.06E-10 1.38E-06 2.05E-06 1.58E-05 2.40E-05 9.18E-06 2.15E-05 2.25E-05 1.23E-04 6.45E-04 4.58E-05 1.10E-04 1.56E-06 7.08E-09 0.00E+00 - 26 4.79E-15 8.98E-04 1.03E-04 2.51E-13 8.15E-05 1.16E-04 1.52E-05 1.31E-05 1.85E-02 3.38E-01 4.79E-05 3.99E-03 1.43E-06 3.22E-05 7.39E-05 1.68E-05 5.12E-03 6.36E-04 1.77E-01 3.27E-03 3.24E-04 8.48E-02 2.95E-03 4.53E-03 1.99E-02 2.05E-12 5.04E-11 2.63E-12 6.31E-12 3.58E-13 3.58E-14 1.95E-10 8.14E-13 9.17E-11 6.81E-12 1.42E-14 5.91E-12 8.61E-12 5.05E-14 4.08E-10 7.17E-09 8.70E-11 5.21E-09 5.59E-09 1.92E-06 1.19E-05 5.01E-05 2.47E-10 1.39E-06 2.05E-06 1.59E-05 2.27E-05 9.24E-06 2.16E-05 2.17E-05 1.24E-04 6.11E-04 4.60E-05 1.10E-04 1.48E-06 9.04E-09 0.00E+00 - 25 3.70E-15 9.01E-04 1.03E-04 9.67E-14 8.16E-05 1.16E-04 1.54E-05 1.32E-05 1.86E-02 3.39E-01 4.99E-05 4.02E-03 1.46E-06 3.23E-05 7.52E-05 1.71E-05 5.14E-03 6.39E-04 1.78E-01 3.29E-03 3.25E-04 8.52E-02 2.96E-03 4.55E-03 2.00E-02 9.89E-13 2.62E-11 1.04E-12 2.93E-12 1.59E-13 1.83E-14 1.37E-10 3.44E-13 5.14E-11 3.38E-12 5.99E-15 2.94E-12 3.95E-12 2.18E-14 3.08E-10 7.48E-09 6.75E-11 5.25E-09 5.20E-09 2.04E-06 1.22E-05 5.17E-05 2.08E-10 1.39E-06 2.06E-06 1.59E-05 2.16E-05 9.29E-06 2.17E-05 2.09E-05 1.24E-04 5.80E-04 4.62E-05 1.10E-04 1.41E-06 1.15E-08 0.00E+00 - 24 3.03E-15 9.04E-04 1.04E-04 3.52E-14 8.16E-05 1.16E-04 1.56E-05 1.32E-05 1.88E-02 3.40E-01 5.41E-05 4.04E-03 1.49E-06 3.24E-05 7.66E-05 1.75E-05 5.17E-03 6.42E-04 1.79E-01 3.30E-03 3.24E-04 8.56E-02 2.97E-03 4.57E-03 2.00E-02 6.09E-13 1.72E-11 5.07E-13 1.73E-12 8.94E-14 1.17E-14 1.09E-10 1.84E-13 3.54E-11 2.10E-12 3.22E-15 1.86E-12 2.29E-12 1.19E-14 2.51E-10 7.96E-09 5.61E-11 5.39E-09 4.99E-09 2.18E-06 1.27E-05 5.35E-05 1.78E-10 1.39E-06 2.06E-06 1.59E-05 2.05E-05 9.33E-06 2.17E-05 2.02E-05 1.25E-04 5.52E-04 4.64E-05 1.11E-04 1.36E-06 1.44E-08 0.00E+00 - 23 2.55E-15 9.07E-04 1.04E-04 1.22E-14 8.15E-05 1.16E-04 1.58E-05 1.33E-05 1.89E-02 3.41E-01 5.84E-05 4.06E-03 1.52E-06 3.24E-05 7.81E-05 1.78E-05 5.19E-03 6.45E-04 1.80E-01 3.31E-03 3.24E-04 8.60E-02 2.98E-03 4.59E-03 2.01E-02 4.61E-13 1.34E-11 3.26E-13 1.27E-12 6.39E-14 8.79E-15 9.11E-11 1.26E-13 2.80E-11 1.55E-12 2.25E-15 1.41E-12 1.65E-12 8.27E-15 2.11E-10 8.48E-09 4.81E-11 5.57E-09 4.88E-09 2.32E-06 1.31E-05 5.54E-05 1.53E-10 1.40E-06 2.06E-06 1.59E-05 1.96E-05 9.37E-06 2.17E-05 1.95E-05 1.25E-04 5.27E-04 4.65E-05 1.11E-04 1.33E-06 1.75E-08 0.00E+00 - 22 2.17E-15 9.10E-04 1.05E-04 4.04E-15 8.14E-05 1.16E-04 1.59E-05 1.33E-05 1.91E-02 3.41E-01 6.28E-05 4.08E-03 1.56E-06 3.25E-05 7.95E-05 1.82E-05 5.21E-03 6.47E-04 1.81E-01 3.32E-03 3.23E-04 8.63E-02 2.99E-03 4.61E-03 2.02E-02 3.87E-13 1.12E-11 2.56E-13 1.04E-12 5.24E-14 7.16E-15 7.81E-11 1.02E-13 2.35E-11 1.26E-12 1.84E-15 1.18E-12 1.33E-12 6.70E-15 1.79E-10 9.02E-09 4.17E-11 5.76E-09 4.82E-09 2.46E-06 1.36E-05 5.72E-05 1.32E-10 1.40E-06 2.05E-06 1.59E-05 1.87E-05 9.40E-06 2.17E-05 1.88E-05 1.25E-04 5.03E-04 4.65E-05 1.11E-04 1.29E-06 2.07E-08 0.00E+00 - 21 1.84E-15 9.12E-04 1.05E-04 1.29E-15 8.11E-05 1.15E-04 1.61E-05 1.33E-05 1.92E-02 3.42E-01 6.71E-05 4.09E-03 1.59E-06 3.25E-05 8.09E-05 1.85E-05 5.22E-03 6.48E-04 1.81E-01 3.32E-03 3.22E-04 8.65E-02 3.00E-03 4.62E-03 2.02E-02 3.38E-13 9.71E-12 2.20E-13 8.90E-13 4.53E-14 6.00E-15 6.72E-11 8.67E-14 2.01E-11 1.05E-12 1.60E-15 1.02E-12 1.13E-12 5.76E-15 1.52E-10 9.55E-09 3.64E-11 5.96E-09 4.79E-09 2.61E-06 1.40E-05 5.89E-05 1.14E-10 1.39E-06 2.12E-06 1.59E-05 1.78E-05 9.43E-06 2.17E-05 1.81E-05 1.25E-04 4.81E-04 4.66E-05 1.12E-04 1.27E-06 2.41E-08 0.00E+00 - 20 1.56E-15 9.14E-04 1.05E-04 3.96E-16 8.08E-05 1.15E-04 1.63E-05 1.33E-05 1.93E-02 3.43E-01 7.11E-05 4.10E-03 1.61E-06 3.25E-05 8.21E-05 1.88E-05 5.23E-03 6.49E-04 1.82E-01 3.33E-03 3.21E-04 8.67E-02 3.00E-03 4.63E-03 2.03E-02 2.96E-13 8.41E-12 1.93E-13 7.69E-13 3.95E-14 5.06E-15 5.78E-11 7.52E-14 1.73E-11 8.86E-13 1.41E-15 8.84E-13 9.67E-13 5.03E-15 1.29E-10 1.00E-08 3.18E-11 6.14E-09 4.78E-09 2.73E-06 1.44E-05 6.05E-05 9.79E-11 1.39E-06 2.18E-06 1.58E-05 1.70E-05 9.45E-06 2.16E-05 1.75E-05 1.25E-04 4.61E-04 4.66E-05 1.12E-04 1.24E-06 3.37E-08 0.00E+00 - 19 1.33E-15 9.16E-04 1.06E-04 1.19E-16 8.05E-05 1.14E-04 1.64E-05 1.33E-05 1.94E-02 3.44E-01 7.47E-05 4.11E-03 1.64E-06 3.25E-05 8.33E-05 1.91E-05 5.24E-03 6.50E-04 1.82E-01 3.33E-03 3.19E-04 8.68E-02 3.00E-03 4.64E-03 2.04E-02 2.61E-13 7.32E-12 1.71E-13 6.69E-13 3.47E-14 4.30E-15 4.98E-11 6.57E-14 1.49E-11 7.53E-13 1.25E-15 7.72E-13 8.34E-13 4.42E-15 1.10E-10 1.05E-08 2.80E-11 6.30E-09 4.78E-09 2.85E-06 1.48E-05 6.20E-05 8.47E-11 1.42E-06 2.24E-06 1.58E-05 1.63E-05 9.46E-06 2.16E-05 1.69E-05 1.25E-04 4.42E-04 4.65E-05 1.12E-04 1.22E-06 4.86E-08 0.00E+00 - 18 1.13E-15 9.18E-04 1.06E-04 3.56E-17 8.02E-05 1.14E-04 1.65E-05 1.33E-05 1.95E-02 3.44E-01 7.80E-05 4.12E-03 1.66E-06 3.25E-05 8.42E-05 1.93E-05 5.25E-03 6.50E-04 1.82E-01 3.33E-03 3.18E-04 8.68E-02 3.01E-03 4.65E-03 2.04E-02 2.30E-13 6.38E-12 1.52E-13 5.83E-13 3.05E-14 3.67E-15 4.30E-11 5.75E-14 1.29E-11 6.42E-13 1.11E-15 6.74E-13 7.21E-13 3.88E-15 9.42E-11 1.09E-08 2.48E-11 6.45E-09 4.78E-09 2.95E-06 1.51E-05 6.32E-05 7.36E-11 1.47E-06 2.30E-06 1.57E-05 1.56E-05 9.47E-06 2.15E-05 1.63E-05 1.25E-04 4.24E-04 4.65E-05 1.12E-04 1.20E-06 6.73E-08 0.00E+00 - 17 9.65E-16 9.19E-04 1.06E-04 1.05E-17 7.98E-05 1.13E-04 1.66E-05 1.33E-05 1.95E-02 3.45E-01 8.09E-05 4.13E-03 1.68E-06 3.25E-05 8.51E-05 1.95E-05 5.25E-03 6.50E-04 1.83E-01 3.33E-03 3.16E-04 8.68E-02 3.01E-03 4.65E-03 2.04E-02 2.01E-13 5.54E-12 1.34E-13 5.06E-13 2.67E-14 3.13E-15 3.71E-11 5.02E-14 1.11E-11 5.47E-13 9.75E-16 5.87E-13 6.23E-13 3.40E-15 8.05E-11 1.12E-08 2.20E-11 6.57E-09 4.79E-09 3.04E-06 1.53E-05 6.43E-05 6.40E-11 1.52E-06 2.34E-06 1.57E-05 1.50E-05 9.47E-06 2.14E-05 1.57E-05 1.24E-04 4.08E-04 4.63E-05 1.13E-04 1.17E-06 8.86E-08 0.00E+00 - 16 8.24E-16 9.20E-04 1.06E-04 3.12E-18 7.93E-05 1.13E-04 1.66E-05 1.32E-05 1.96E-02 3.45E-01 8.35E-05 4.13E-03 1.69E-06 3.24E-05 8.58E-05 1.97E-05 5.25E-03 6.49E-04 1.83E-01 3.32E-03 3.14E-04 8.67E-02 3.01E-03 4.65E-03 2.05E-02 1.76E-13 4.81E-12 1.18E-13 4.39E-13 2.33E-14 2.67E-15 3.20E-11 4.37E-14 9.57E-12 4.67E-13 8.57E-16 5.10E-13 5.37E-13 2.97E-15 6.88E-11 1.15E-08 1.97E-11 6.67E-09 4.79E-09 3.12E-06 1.55E-05 6.51E-05 5.59E-11 1.56E-06 2.38E-06 1.56E-05 1.43E-05 9.47E-06 2.13E-05 1.51E-05 1.24E-04 3.93E-04 4.62E-05 1.13E-04 1.15E-06 1.11E-07 0.00E+00 - 15 7.08E-16 9.22E-04 1.06E-04 9.39E-19 7.89E-05 1.12E-04 1.67E-05 1.32E-05 1.96E-02 3.46E-01 8.58E-05 4.13E-03 1.70E-06 3.24E-05 8.64E-05 1.98E-05 5.24E-03 6.48E-04 1.83E-01 3.32E-03 3.12E-04 8.66E-02 3.00E-03 4.65E-03 2.05E-02 1.55E-13 4.19E-12 1.04E-13 3.83E-13 2.05E-14 2.29E-15 2.77E-11 3.82E-14 8.30E-12 4.01E-13 7.56E-16 4.46E-13 4.66E-13 2.61E-15 5.92E-11 1.18E-08 1.78E-11 6.77E-09 4.80E-09 3.19E-06 1.57E-05 6.59E-05 4.92E-11 1.60E-06 2.41E-06 1.55E-05 1.38E-05 9.45E-06 2.12E-05 1.46E-05 1.23E-04 3.79E-04 4.60E-05 1.13E-04 1.13E-06 1.35E-07 0.00E+00 - 14 6.13E-16 9.24E-04 1.06E-04 2.89E-19 7.84E-05 1.12E-04 1.67E-05 1.31E-05 1.97E-02 3.46E-01 8.79E-05 4.13E-03 1.71E-06 3.23E-05 8.69E-05 1.99E-05 5.23E-03 6.47E-04 1.83E-01 3.31E-03 3.09E-04 8.64E-02 3.00E-03 4.65E-03 2.05E-02 1.37E-13 3.68E-12 9.23E-14 3.36E-13 1.80E-14 1.98E-15 2.42E-11 3.36E-14 7.24E-12 3.47E-13 6.70E-16 3.92E-13 4.07E-13 2.30E-15 5.13E-11 1.20E-08 1.63E-11 6.85E-09 4.81E-09 3.24E-06 1.59E-05 6.65E-05 4.37E-11 1.63E-06 2.44E-06 1.54E-05 1.33E-05 9.44E-06 2.11E-05 1.42E-05 1.23E-04 3.66E-04 4.58E-05 1.13E-04 1.11E-06 1.59E-07 0.00E+00 - 13 5.34E-16 9.25E-04 1.07E-04 9.21E-20 7.79E-05 1.11E-04 1.67E-05 1.31E-05 1.97E-02 3.47E-01 8.97E-05 4.13E-03 1.71E-06 3.23E-05 8.73E-05 1.99E-05 5.22E-03 6.45E-04 1.83E-01 3.30E-03 3.07E-04 8.62E-02 3.00E-03 4.65E-03 2.05E-02 1.21E-13 3.25E-12 8.22E-14 2.97E-13 1.60E-14 1.73E-15 2.12E-11 2.98E-14 6.37E-12 3.03E-13 5.96E-16 3.47E-13 3.58E-13 2.04E-15 4.47E-11 1.22E-08 1.50E-11 6.91E-09 4.82E-09 3.30E-06 1.60E-05 6.71E-05 3.92E-11 1.66E-06 2.46E-06 1.53E-05 1.28E-05 9.42E-06 2.09E-05 1.37E-05 1.22E-04 3.54E-04 4.56E-05 1.13E-04 1.09E-06 1.84E-07 0.00E+00 - 12 4.70E-16 9.25E-04 1.07E-04 3.06E-20 7.74E-05 1.10E-04 1.67E-05 1.30E-05 1.97E-02 3.47E-01 9.10E-05 4.12E-03 1.72E-06 3.22E-05 8.76E-05 2.00E-05 5.21E-03 6.43E-04 1.82E-01 3.29E-03 3.05E-04 8.59E-02 2.99E-03 4.64E-03 2.05E-02 1.08E-13 2.89E-12 7.36E-14 2.64E-13 1.43E-14 1.52E-15 1.88E-11 2.65E-14 5.64E-12 2.66E-13 5.34E-16 3.08E-13 3.17E-13 1.82E-15 3.94E-11 1.24E-08 1.39E-11 6.96E-09 4.82E-09 3.33E-06 1.61E-05 6.74E-05 3.55E-11 1.68E-06 2.48E-06 1.52E-05 1.24E-05 9.39E-06 2.08E-05 1.33E-05 1.22E-04 3.44E-04 4.54E-05 1.13E-04 1.07E-06 2.05E-07 0.00E+00 - 11 4.19E-16 9.25E-04 1.07E-04 1.07E-20 7.69E-05 1.10E-04 1.66E-05 1.30E-05 1.96E-02 3.48E-01 9.20E-05 4.11E-03 1.72E-06 3.22E-05 8.77E-05 2.00E-05 5.20E-03 6.41E-04 1.82E-01 3.27E-03 3.03E-04 8.56E-02 2.98E-03 4.64E-03 2.05E-02 9.75E-14 2.59E-12 6.64E-14 2.37E-13 1.29E-14 1.36E-15 1.68E-11 2.38E-14 5.05E-12 2.37E-13 4.82E-16 2.77E-13 2.84E-13 1.64E-15 3.51E-11 1.24E-08 1.30E-11 6.98E-09 4.82E-09 3.35E-06 1.61E-05 6.76E-05 3.24E-11 1.70E-06 2.48E-06 1.51E-05 1.20E-05 9.37E-06 2.07E-05 1.29E-05 1.21E-04 3.34E-04 4.52E-05 1.13E-04 1.05E-06 2.22E-07 0.00E+00 - 10 3.78E-16 9.25E-04 1.06E-04 3.95E-21 7.64E-05 1.09E-04 1.66E-05 1.29E-05 1.96E-02 3.48E-01 9.27E-05 4.10E-03 1.71E-06 3.21E-05 8.77E-05 2.00E-05 5.18E-03 6.39E-04 1.82E-01 3.26E-03 3.00E-04 8.53E-02 2.98E-03 4.63E-03 2.05E-02 8.90E-14 2.36E-12 6.08E-14 2.16E-13 1.17E-14 1.23E-15 1.53E-11 2.17E-14 4.58E-12 2.14E-13 4.40E-16 2.52E-13 2.58E-13 1.50E-15 3.18E-11 1.25E-08 1.24E-11 6.99E-09 4.81E-09 3.37E-06 1.62E-05 6.76E-05 3.01E-11 1.71E-06 2.49E-06 1.50E-05 1.16E-05 9.33E-06 2.05E-05 1.26E-05 1.20E-04 3.25E-04 4.49E-05 1.13E-04 1.02E-06 2.36E-07 0.00E+00 - 9 3.48E-16 9.25E-04 1.06E-04 1.57E-21 7.59E-05 1.08E-04 1.65E-05 1.28E-05 1.96E-02 3.48E-01 9.33E-05 4.09E-03 1.71E-06 3.20E-05 8.77E-05 1.99E-05 5.17E-03 6.36E-04 1.81E-01 3.25E-03 2.98E-04 8.50E-02 2.97E-03 4.62E-03 2.05E-02 8.27E-14 2.19E-12 5.65E-14 2.00E-13 1.09E-14 1.13E-15 1.41E-11 2.02E-14 4.24E-12 1.97E-13 4.10E-16 2.34E-13 2.39E-13 1.39E-15 2.93E-11 1.26E-08 1.19E-11 7.00E-09 4.81E-09 3.39E-06 1.62E-05 6.77E-05 2.84E-11 1.72E-06 2.49E-06 1.49E-05 1.13E-05 9.30E-06 2.04E-05 1.22E-05 1.20E-04 3.17E-04 4.47E-05 1.13E-04 1.01E-06 2.50E-07 0.00E+00 - 8 3.27E-16 9.25E-04 1.06E-04 6.72E-22 7.54E-05 1.08E-04 1.65E-05 1.28E-05 1.96E-02 3.48E-01 9.38E-05 4.08E-03 1.71E-06 3.20E-05 8.77E-05 1.99E-05 5.15E-03 6.34E-04 1.81E-01 3.23E-03 2.97E-04 8.46E-02 2.96E-03 4.61E-03 2.04E-02 7.83E-14 2.07E-12 5.36E-14 1.89E-13 1.03E-14 1.06E-15 1.33E-11 1.91E-14 4.00E-12 1.86E-13 3.89E-16 2.21E-13 2.25E-13 1.32E-15 2.75E-11 1.26E-08 1.15E-11 7.01E-09 4.81E-09 3.40E-06 1.62E-05 6.77E-05 2.72E-11 1.72E-06 2.49E-06 1.48E-05 1.10E-05 9.26E-06 2.03E-05 1.20E-05 1.19E-04 3.09E-04 4.44E-05 1.13E-04 9.92E-07 2.63E-07 0.00E+00 - 7 3.13E-16 9.24E-04 1.06E-04 3.12E-22 7.49E-05 1.07E-04 1.64E-05 1.27E-05 1.95E-02 3.48E-01 9.42E-05 4.07E-03 1.70E-06 3.19E-05 8.76E-05 1.99E-05 5.13E-03 6.31E-04 1.80E-01 3.22E-03 2.95E-04 8.42E-02 2.95E-03 4.60E-03 2.04E-02 7.54E-14 1.99E-12 5.17E-14 1.81E-13 9.93E-15 1.01E-15 1.28E-11 1.83E-14 3.83E-12 1.78E-13 3.75E-16 2.13E-13 2.16E-13 1.27E-15 2.63E-11 1.27E-08 1.13E-11 7.02E-09 4.82E-09 3.40E-06 1.62E-05 6.77E-05 2.64E-11 1.73E-06 2.49E-06 1.47E-05 1.07E-05 9.23E-06 2.02E-05 1.17E-05 1.18E-04 3.03E-04 4.42E-05 1.13E-04 9.79E-07 2.75E-07 0.00E+00 - 6 3.04E-16 9.24E-04 1.06E-04 1.59E-22 7.44E-05 1.06E-04 1.64E-05 1.26E-05 1.95E-02 3.48E-01 9.45E-05 4.06E-03 1.70E-06 3.19E-05 8.75E-05 1.98E-05 5.11E-03 6.28E-04 1.80E-01 3.20E-03 2.93E-04 8.39E-02 2.94E-03 4.59E-03 2.04E-02 7.37E-14 1.94E-12 5.06E-14 1.77E-13 9.70E-15 9.86E-16 1.24E-11 1.79E-14 3.73E-12 1.72E-13 3.66E-16 2.08E-13 2.10E-13 1.24E-15 2.56E-11 1.27E-08 1.11E-11 7.02E-09 4.82E-09 3.41E-06 1.62E-05 6.76E-05 2.59E-11 1.73E-06 2.49E-06 1.46E-05 1.05E-05 9.19E-06 2.00E-05 1.15E-05 1.18E-04 2.98E-04 4.39E-05 1.13E-04 9.67E-07 2.85E-07 0.00E+00 - 5 3.00E-16 9.23E-04 1.05E-04 9.02E-23 7.40E-05 1.06E-04 1.63E-05 1.26E-05 1.94E-02 3.49E-01 9.47E-05 4.05E-03 1.70E-06 3.18E-05 8.73E-05 1.98E-05 5.09E-03 6.26E-04 1.79E-01 3.19E-03 2.91E-04 8.35E-02 2.93E-03 4.57E-03 2.04E-02 7.31E-14 1.92E-12 5.02E-14 1.75E-13 9.61E-15 9.72E-16 1.23E-11 1.77E-14 3.69E-12 1.70E-13 3.64E-16 2.06E-13 2.08E-13 1.23E-15 2.52E-11 1.27E-08 1.11E-11 7.01E-09 4.83E-09 3.41E-06 1.61E-05 6.75E-05 2.57E-11 1.73E-06 2.49E-06 1.45E-05 1.03E-05 9.15E-06 1.99E-05 1.13E-05 1.17E-04 2.93E-04 4.37E-05 1.13E-04 9.57E-07 2.94E-07 0.00E+00 - 4 3.00E-16 9.22E-04 1.05E-04 6.18E-23 7.36E-05 1.05E-04 1.63E-05 1.25E-05 1.94E-02 3.49E-01 9.48E-05 4.04E-03 1.69E-06 3.17E-05 8.72E-05 1.97E-05 5.08E-03 6.23E-04 1.79E-01 3.18E-03 2.90E-04 8.32E-02 2.93E-03 4.56E-03 2.03E-02 7.34E-14 1.92E-12 5.05E-14 1.76E-13 9.66E-15 9.72E-16 1.23E-11 1.78E-14 3.70E-12 1.70E-13 3.66E-16 2.06E-13 2.09E-13 1.24E-15 2.53E-11 1.27E-08 1.11E-11 7.01E-09 4.83E-09 3.41E-06 1.61E-05 6.74E-05 2.57E-11 1.73E-06 2.49E-06 1.44E-05 1.01E-05 9.12E-06 1.98E-05 1.11E-05 1.16E-04 2.89E-04 4.35E-05 1.13E-04 9.48E-07 3.02E-07 0.00E+00 - 3 3.06E-16 9.71E-04 8.90E-05 4.72E-23 6.18E-05 8.94E-05 1.38E-05 1.07E-05 1.77E-02 3.92E-01 8.15E-05 3.65E-03 1.43E-06 3.24E-05 7.78E-05 1.67E-05 4.54E-03 5.45E-04 1.65E-01 2.77E-03 2.44E-04 7.21E-02 2.74E-03 4.35E-03 2.05E-02 7.51E-14 1.97E-12 5.17E-14 1.80E-13 9.88E-15 9.90E-16 1.26E-11 1.82E-14 3.78E-12 1.73E-13 3.74E-16 2.11E-13 2.13E-13 1.26E-15 2.57E-11 1.08E-08 1.04E-11 5.92E-09 4.21E-09 2.89E-06 1.36E-05 5.70E-05 2.53E-11 1.47E-06 2.10E-06 1.21E-05 8.54E-06 8.00E-06 1.67E-05 9.25E-06 9.78E-05 2.87E-04 3.66E-05 1.23E-04 8.05E-07 2.62E-07 0.00E+00 - 2 1.54E-16 5.23E-04 4.79E-05 1.29E-23 3.33E-05 4.83E-05 7.45E-06 5.76E-06 9.59E-03 2.11E-01 4.43E-05 1.98E-03 7.69E-07 1.75E-05 4.22E-05 9.02E-06 2.46E-03 2.95E-04 8.93E-02 1.50E-03 1.31E-04 3.90E-02 1.48E-03 2.35E-03 1.11E-02 3.80E-14 9.93E-13 2.62E-14 9.08E-14 4.99E-15 4.99E-16 6.34E-12 9.20E-15 1.91E-12 8.73E-14 1.89E-16 1.07E-13 1.07E-13 6.39E-16 1.30E-11 5.81E-09 5.41E-12 3.19E-09 2.26E-09 1.56E-06 7.36E-06 3.08E-05 1.30E-11 7.96E-07 1.13E-06 6.51E-06 4.57E-06 4.33E-06 8.96E-06 4.93E-06 5.27E-05 1.54E-04 1.97E-05 6.65E-05 4.30E-07 1.44E-07 0.00E+00 - 1 1.37E-16 5.18E-04 4.62E-05 7.05E-24 3.23E-05 4.71E-05 7.24E-06 5.60E-06 9.43E-03 2.11E-01 4.31E-05 1.95E-03 7.44E-07 1.72E-05 4.13E-05 8.76E-06 2.41E-03 2.88E-04 8.79E-02 1.46E-03 1.26E-04 3.81E-02 1.46E-03 2.32E-03 1.10E-02 3.38E-14 8.82E-13 2.33E-14 8.07E-14 4.44E-15 4.43E-16 5.63E-12 8.18E-15 1.69E-12 7.75E-14 1.68E-16 9.47E-14 9.55E-14 5.68E-16 1.15E-11 5.60E-09 5.00E-12 3.08E-09 2.16E-09 1.51E-06 7.13E-06 2.98E-05 1.18E-11 7.72E-07 1.09E-06 6.29E-06 4.37E-06 4.24E-06 8.66E-06 4.71E-06 5.11E-05 1.50E-04 1.91E-05 6.62E-05 4.08E-07 1.40E-07 0.00E+00 diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_JVdat.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_JVdat.f deleted file mode 100644 index 48fc6f4e..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_JVdat.f +++ /dev/null @@ -1,32 +0,0 @@ -c----------------------------------------------------------------------- -c include 'cmn_JVdat.f' for fast-JX code v5.3 (prather 6/05) -c -c NB - ALL of these common variables are set paramters, -c They are NOT to be used as variables for a local solution -c Thus this entire set is 'in' only after it is initialized -c----------------------------------------------------------------------- - real*8 RAD,ZZHT,ATAU,ATAU0 - real*8 WBIN(W_+1),WL(W_),FL(W_),QO2(W_,3),QO3(W_,3),Q1D(W_,3) - real*8 QQQ(W_,2,X_),QRAYL(W_+1),TQQ(3,X_) - real*8 WAA(4,A_),QAA(4,A_),PAA(8,4,A_),RAA(4,A_),SSA(4,A_) - real*8 JFACTA(JVN_) - integer JIND(JVN_),NRATJ,NJVAL,NW1,NW2,NAA,JTAUMX - character*20 TITLEA(A_) - character*78 TITLE0 - character*7 TITLEJ(X_),TITLEJ2,TITLEJ3,JLABEL(JVN_) -c - common /jvchem/JFACTA,JIND,NRATJ,JLABEL,TITLEA -c - common /jvdat/WBIN,WL,FL,QO2,QO3,Q1D,QQQ,QRAYL,TQQ, - & WAA,QAA,PAA,RAA,SSA,RAD,ZZHT,ATAU,ATAU0, - & JTAUMX, NJVAL,NW1,NW2,NAA ,TITLE0,TITLEJ -C----------------------------------------------------------------------- - - - - - - - - - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_metdat.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_metdat.f deleted file mode 100644 index e635c0cf..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/cmn_metdat.f +++ /dev/null @@ -1,41 +0,0 @@ -c----------------------------------------------------------------------- -c include 'cmn_metdat.f' for fast-JX code v5.3 (prather 6/05) -c -c needs 'parm_ctm.f' for dimensions -c delivers p, T, Surf Albedo, and Optical Depth from CTM to fastJX -c >>>>this is for standalone fast-JX ver 5.3 (6.05) -c----------------------------------------------------------------------- -c - real*8 P(I_,J_) ! Surface pressure - real*8 T(I_,J_,L_) ! Temperature profile - real*8 OD(I_,J_,LWE_) ! Optical Depth profile -c - real*8 XGRD(I_) ! Longitude (midpoint, radians) - real*8 XDGRD(I_) - real*8 YGRD(J_) ! Latitude (midpoint, radians) - real*8 YDGRD(J_) - real*8 ETAA(L_+1) ! Eta(a) value for level boundaries - real*8 ETAB(L_+1) ! Eta(b) value for level boundaries - real*8 AREAXY(I_,J_) ! area (m^2) - integer MONTH - integer NSLAT ! Latitude(J) index of current column - integer NSLON ! Longitude(I) index of current column - - real*8, dimension(I_,J_,L1_) :: TJ, DM, DO3, ZH - real*8, dimension(I_,J_,L1_) :: DAER1, DAER2, DAER3, ODCLD - integer,dimension(I_,J_,L1_) :: NAER1, NAER2, NAER3, NCLDX - real*8, dimension(I_,J_) :: PMEAN, SA -c - real*8 STT(I_,J_,L_,NTR_) - real*8 TREF(51,18,12),OREF(51,18,12) - character*10 TCNAME(NTR_) -c - common/metdat/P,T,OD, STT, - & XGRD,YGRD,XDGRD,YDGRD,ETAA,ETAB,AREAXY, - & TREF,OREF,PMEAN,SA, MONTH,NSLAT,NSLON, TCNAME -c - common /jvdatIJ/TJ,DM,DO3,ZH, - & DAER1,DAER2,DAER3,ODCLD, - & NAER1,NAER2,NAER3,NCLDX -c----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/fastJX.f b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/fastJX.f deleted file mode 100644 index b5ff3765..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastJX53c_ref/tempsrc/fastJX.f +++ /dev/null @@ -1,2378 +0,0 @@ -c >>>>>>>>>>>>>>>>current code revised to JX ver 5.3c (4/06)<<<<<<<<<<<< -c version 5.3c adds -c calculates reflected UV-vis solar energy (relative to 1.0) -c new solar spectrum (J-O2 increases in strat by 10%, J-NO by 15+%) -c -c version 5.3b changes include: -c new data files for specral Xsection and mie-scattering. -c add sub-layers (JXTRA) to thick cloud/aerosol layers, -c sets up log-spaced sub-layers of increasing thickness ATAU -c correction 'b' does massive clean up of the linking code, -c now the only subroutine that has access to CTM arrays is PHOTOJ -c Also, the access to the cmn_JVdat.f is 'read-only' after init. -c This should enable safe openMP/MPI coding. -c -c common files and what they mean: -c parm_CTM.f dimensions & params for code (CTM and fast-JX) -c parm_MIE.f dimensions for mie code variables. -c cmn_metdat.f CTM 3-D arrays, time of day, grid, etc. -c cmn_JVdat.f Xsects, Mie, etc., (initialized and then read-only) -c -c<<<<<<<<<<<<<<<<<<<<>>>>overall program revised to run with FAST-JX J-code ver 5.3 (6/05) -c >>>>> now designed to use log spacing in TAU to get <0.5% accuracy -c much better accuracy and fewer added levels vs. old linear adds. -c -c----------------------------------------------------------------------- -c -c<<<<<<<<<<<<<<<<<<<<>>>> keyed to chem code - call RD_JS(IPH,'ratj.dat') -c -c Read in T & O3 climatology >>>> general backup clim. - call RD_PROF(IPH,'atmos_std.dat') -c - return - end - - - subroutine RD_JS(NJ1,NAMFIL) -C----------------------------------------------------------------------- -c Reread the ratj.dat file to map photolysis rate to reaction -c Read in quantum yield 'jfacta' and fastj2 label 'jlabel' -C----------------------------------------------------------------------- -c -c jfacta Quantum yield (or multiplication factor) for photolysis -c jlabel Reference label identifying appropriate J-value to use -c ipr Photolysis reaction counter - should total 'JVN_' -c -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_metdat.f' - include 'cmn_JVdat.f' -c - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - - integer IPR, I, J, K - character*120 CLINE -c -c Reread the ratj.dat file to map photolysis rate to reaction -c Read in quantum yield jfacta and fastj2 label jlabel - IPR = 0 - open (NJ1,file=NAMFIL,status='old',form='formatted') - 10 read (NJ1,'(A)',err=20) CLINE - if (IPR .eq. JVN_) goto 20 - - if (CLINE(2:5).eq.'9999') then - go to 20 - elseif (CLINE(1:1).eq.'#') then - go to 10 - elseif (CLINE(5:5).eq.'$') then - go to 10 - else - IPR = IPR+1 - read (CLINE(79:83),'(F5.1)') JFACTA(IPR) - read (CLINE(86:92),'(A7)') JLABEL(IPR) - JFACTA(IPR) = JFACTA(IPR)/100.d0 - go to 10 - endif - 20 close(NJ1) - - NRATJ = IPR - -C----------------------------------------------------------------------- -c compare Xsections titles with J-values listed in chem code (jratd.dat) -c map the J-values needed for chemistry (ratj.dat) onto the fast-JX rates -c >>>>>>>>>>>>>>>>current code revised to JPL-02 ver 8.5 (5/05)<<<<<<<<< -c >>>this must now follow the read in of Xsects, etc<<< -C----------------------------------------------------------------------- - -c---Zero / Set index arrays that map Jvalue(j) onto rates - do J = 1,JVN_ - JIND(J) = 0 - enddo - do J = 1,NJVAL - do K = 1,NRATJ - if (JLABEL(K) .eq. TITLEJ(J)) JIND(K)=J - enddo - enddo - - write(6,'(a,i4,a)') ' Photochemistry Scheme with ',IPR,' J-values' - do K=1,NRATJ - J = JIND(K) - if (J.eq.0) then - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), - & ' has no mapping onto onto fast-JX' - else - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), - & ' mapped onto fast-JX:',J,TITLEJ(J) - endif - enddo - - return - end - - -C----------------------------------------------------------------------- - subroutine RD_PROF(NJ2,NAMFIL) -C----------------------------------------------------------------------- -c Routine to input T and O3 reference profiles -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_metdat.f' - - integer, intent(in) :: NJ2 - character(*), intent(in) :: NAMFIL -c - integer IA, I, M, L, LAT, MON, NTLATS, NTMONS, N216 - real*8 OFAC, OFAK - character*72 TITLE0 -c - open (NJ2,file=NAMFIL,status='old',form='formatted') - read (NJ2,'(A)') TITLE0 - read (NJ2,'(2I5)') NTLATS,NTMONS -c write(6,'(1X,A)') TITLE0 - write(6,1000) NTLATS,NTMONS - N216 = min(216, NTLATS*NTMONS) - do IA = 1,N216 - read (NJ2,'(1X,I3,3X,I2)') LAT, MON - M = min(12, max(1, MON)) - L = min(18, max(1, (LAT+95)/10)) - read (NJ2,'(3X,11F7.1)') (TREF(I,L,M), I=1,41) - read (NJ2,'(3X,11F7.4)') (OREF(I,L,M), I=1,31) - enddo - close (NJ2) - -c Extend climatology to 100 km - OFAC = exp(-2.d5/5.d5) - do I = 32,51 - OFAK = OFAC**(I-31) - do M = 1,NTMONS - do L = 1,NTLATS - OREF(I,L,M) = OREF(31,L,M)*OFAK - enddo - enddo - enddo - do L = 1,NTLATS - do M = 1,NTMONS - do I = 42,51 - TREF(I,L,M) = TREF(41,L,M) - enddo - enddo - enddo - - return - 1000 format(1x,'std atmos profiles: ',i3,' lat x ',i2,' mon') - end - - - -c----------------------------------------------------------------------- - subroutine SET_CLD0(TINIT,ODINIT,ODINDX,ALBEDO) -c----------------------------------------------------------------------- -c Routine to set cloud and surface properties: now loads the input prof's -c -c >>>>>> this subroutine will need to be customized -c >>>>>> it is separate from aerosols since it comes from met fields -c----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_metdat.f' - include 'cmn_JVdat.f' - - integer, intent(in) :: ODINDX - real*8, intent(in) :: TINIT(L_),ODINIT(L_),ALBEDO - integer I, J, L -c - do J = 1,J_ - do I = 1,I_ - do L = 1,L_ - ODCLD(I,J,L) = ODINIT(L) - T(I,J,L) = TINIT(L) - enddo - ODCLD(I,J,L1_) = 0.d0 - SA(I,J) = ALBEDO - enddo - enddo - NCLDX(:,:,:) = ODINDX -c - return - end - - -C----------------------------------------------------------------------- - subroutine SET_AER0 -C----------------------------------------------------------------------- -c Set up aerosols >>>>customize for climatology or CTM as source. -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_metdat.f' - include 'cmn_JVdat.f' - - integer I, J, L, K - -c Add aerosol OD and indices -c DAERn(L=1:L_) = aerosol/cloud Optical Depth (OD) within CTM layer L -c DAERn(L1_=L_+1)= aerosol/cloud OD in layer above CTM (L1_) - - NAER1(:,:,:) = 0 - NAER2(:,:,:) = 0 - NAER3(:,:,:) = 0 - do J = 1,J_ - do I = 1,I_ - do L = 1,L_+1 - DAER1(I,J,L) = 0.d0 - DAER2(I,J,L) = 0.d0 - DAER3(I,J,L) = 0.d0 - enddo - enddo - enddo - - end - - -c----------------------------------------------------------------------- - subroutine SET_ATM0 -C----------------------------------------------------------------------- -c Routine to set up atmospheric profiles required by Fast-J2 using a -c doubled version of the level scheme used in the CTM. First pressure -c and z* altitude are defined, then O3 and T are taken from the supplied -c climatology and integrated to the CTM levels (may be overwritten with -c values directly from the CTM, if desired). -c Oliver (04/07/99) & MJP (7/05) -C----------------------------------------------------------------------- -c -c -c PJ Pressure at boundaries of model levels (hPa) -c MASFAC Conversion factor for pressure to column density -c -c TJ Temperature profile on model grid -c DM Air column for each model level (molecules.cm-2) -c DO3 Ozone column for each model level (molecules.cm-2) -c ZH Altitude of boundaries of model levels (cm) -c PSTD Approximate pressures of levels for supplied climatology -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_metdat.f' - - integer I, J, K, L, M, N - real*8 PSTD(52),OREF2(51),TREF2(51),PJ(L1_+1) - real*8 DLOGP,F0,T0,PB,PC,XC,MASFAC,SCALEH -c -c Select appropriate month - M = max(1,min(12,MONTH)) - -c Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - -C----------------------------------------------------------------------- - do J = 1,J_ - -c Select appropriate latitudinal profiles - N = max(1, min(18, (int(YDGRD(J))+99)/10 )) -c Temporary zonal arrays for climatology data - do K = 1,51 - OREF2(K) = OREF(K,N,M) - TREF2(K) = TREF(K,N,M) - enddo - - do I = 1,I_ - -c Apportion O3 and T on supplied climatology z* levels onto CTM levels -c with mass (pressure) weighting, assuming constant mixing ratio and -c temperature half a layer on either side of the point supplied. -c L1_ = L_+1: -c PJ(L=1:L1_) = pressure at CTM layer edge, PJ(L1_+1)=0 (top-of-atmos) - - PJ(L1_+1) = 0.d0 - do K = 1,L1_ - PJ(K) = ETAA(K) + ETAB(K)*PMEAN(I,J) - enddo - -c Set up pressure levels for O3/T climatology - assume that value -c given for each 2 km z* level applies from 1 km below to 1 km above, -c so select pressures at these boundaries. Surface level values at -c 1000 mb are assumed to extend down to the actual P(ILNG,JLAT). -c - PSTD(1) = max(PJ(1),1000.d0) - PSTD(2) = 1000.d0 * 10.d0**(-1.d0/16.d0) - DLOGP = 10.d0**(-2.d0/16.d0) - do K = 3,51 - PSTD(K) = PSTD(K-1)*DLOGP - enddo - PSTD(52) = 0.d0 - - do L = 1,L1_ - F0 = 0.d0 - T0 = 0.d0 - do K = 1,51 - PC = min(PJ(L),PSTD(K)) - PB = max(PJ(L+1),PSTD(K+1)) - if (PC .gt. PB) then - XC = (PC-PB)/(PJ(L)-PJ(L+1)) - F0 = F0 + OREF2(K)*XC - T0 = T0 + TREF2(K)*XC - endif - enddo - TJ(I,J,L) = T0 - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = F0*1.d-6*DM(I,J,L) - enddo - -c Calculate effective altitudes using scale height at each level - ZH(I,J,1) = 0.d0 - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -( LOG(PJ(L+1)/PJ(L)) * SCALEH ) - enddo - - enddo - enddo - - return - end - -c<<<<<<<<<<<<<<<<<<<<<<< 98.0 deg => tan ht = 63 km -c or 99. 80 km - if (SZA .gt. SZAMAX) goto 99 - -c---load the amtospheric column data - do L = 1,L1_ - PPJ(L) = ETAA(L) + ETAB(L)*P(ILNG,JLAT) - TTJ(L) = TJ(ILNG,JLAT,L) - DDJ(L) = DM(ILNG,JLAT,L) - ZZJ(L) = DO3(ILNG,JLAT,L) - enddo - PPJ(L1_+1) = 0.d0 - -c---calculate spherical weighting functions (AMF: Air Mass Factor) - do L = 1,L1_ - ZHL(L) = ZH(ILNG,JLAT,L) - enddo - -C----------------------------------------------------------------------- - call SPHERE(U0,RAD,ZHL,ZZHT,AMF,L1_) -C----------------------------------------------------------------------- - -c---load the profiles of aerosols & clouds: treated as the same from here - do L = 1,L1_ - AER(1,L) = DAER1(ILNG,JLAT,L) ! Opt. Depth aerosol 1 in layer L - AER(2,L) = DAER2(ILNG,JLAT,L) ! Opt. Depth aerosol 2 in layer L - AER(3,L) = DAER3(ILNG,JLAT,L) ! Opt. Depth aerosol 3 in layer L - AER(4,L) = ODCLD(ILNG,JLAT,L) ! cloud Opt. Depth in L - AER(5,L) = 0.d0 ! save space for Rayleigh - ADX(1,L) = NAER1(ILNG,JLAT,L) ! index for aerosol 1 at layer L - ADX(2,L) = NAER2(ILNG,JLAT,L) ! index for aerosol 2 at layer L - ADX(3,L) = NAER3(ILNG,JLAT,L) ! index for aerosol 3 at layer L - ADX(4,L) = NCLDX(ILNG,JLAT,L) ! index for cloud at layer L - ADX(5,L) = 1 ! index for Rayleigh phase in L - enddo - - do L = 1,L1_ - do I=1,4 - ADX(I,L) = min(NAA, max(0, ADX(I,L))) - enddo - enddo - -c---Now given the aerosol+cloud OD/layer in visible (600 nm) can calculate -c how to add additonal levels at top of clouds (now uses log spacing) -C----------------------------------------------------------------------- - call EXTRAL(AER,ADX,L1_,L2_,N_,JTAUMX,ATAU,ATAU0, JXTRA) -C----------------------------------------------------------------------- - -c---set surface reflectance - RFLECT = SA(ILNG,JLAT) - RFLECT = max(0.d0,min(1.d0,RFLECT)) - -C---Loop over all wavelength bins to calc mean actinic flux AVGF(L) - do K = NW1,NW2 - WAVE = WL(K) -C---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 ! use 300 nm aerosol properties for <355 nm - if( WAVE .gt. 355.d0 ) KM=2 ! use 400 nm prop for 355-500 nm - if( WAVE .gt. 500.d0 ) KM=3 - if( WAVE .gt. 800.d0 ) KM=4 - -c---Loop over CTM layers L=1:L1_ = 1:L_+1, -c values at L1_=L_+1 are a pseudo layer above the top CTM layer (L_) - do L = 1,L1_ - TTT = TTJ(L) - XQO3 = FLINT(TTT,TQQ(1,2),TQQ(2,2),TQQ(3,2) - & ,QO3(K,1),QO3(K,2),QO3(K,3)) - XQO2 = FLINT(TTT,TQQ(1,1),TQQ(2,1),TQQ(3,1) - & ,QO2(K,1),QO2(K,2),QO2(K,3)) - - ABX(L) = XQO3*ZZJ(L) + XQO2*DDJ(L)*0.20948d0 - - AER(5,L) = DDJ(L)*QRAYL(K) - enddo - -C----------------------------------------------------------------------- - call OPMIE - & (K,KM, WAVE, ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,AVGF,FTOP,FBOT) -C----------------------------------------------------------------------- - - do L = 1,JVL_ - FFF(K,L) = FFF(K,L) + SOLF*FL(K)*AVGF(L) - enddo - FREFL = FREFL + SOLF*FL(K)*FTOP/WAVE - FREFS = FREFS + SOLF*FL(K)/WAVE - - enddo ! loop over wavelength K - - FREFL = FREFL/FREFS !calculate reflected flux (energy weighted) - -C----------------------------------------------------------------------- - call JRATET(PPJ,TTJ,FFF, VALJL) -C----------------------------------------------------------------------- - -c---map the J-values from fast-JX onto ASAD ones (use JIND & JFACTA) - do L = 1,JVL_ - do J = 1,NRATJ - if (JIND(J).gt.0) then - ZPJ(L,J) = VALJL(L,JIND(J))*JFACTA(J) - else - ZPJ(L,J) = 0.d0 - endif - enddo - enddo - -c---diagnostics that are NOT returned to the CTM code - -C----------------------------------------------------------------------- - write(6,*) 'fast-JX(5.3b)--------------internal print------------' - - call JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) - -C---Print solar flux terms - write(6,'(a,5f10.4)') ' fast-JX: SZA/u0/Frefl/albedo/SOL*fact/', - & SZA,U0,FREFL,RFLECT,SOLF - write(6,'(a5,18i9)') ' bin:',(K, K=NW1,NW2) - write(6,'(a5,18f9.2)') ' wvl:',(WL(K), K=NW1,NW2) - do L = JVL_,1,-1 - write(6,'(i3,2x,18f9.6)') L,(FFF(K,L)/FL(K),K=NW1,NW2) - enddo - write(6,*) 'fast-JX(5.3b)--------------internal print------------' -C----------------------------------------------------------------------- - - 99 continue - return - end - -c<<<<<<<<<<<<<<<<<<<<<< CH3CO + CH3 -c--- 62 = NJVAL = J2(acetone-b) ==> CH3 + CO + CH3 - VALJ(NJVAL-1) = 0.d0 - VALJ(NJVAL) = 0.d0 -c---IV=NJVAL-1 = Xsect (total abs) for Acetone - pre-calc Temp interp factors - IV = NJVAL-1 - TFACA = (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - TFACA = max(0.d0, min(1.d0, TFACA)) -c---IV=NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. -c--- but force to Q2=0 by 210K - IV = NJVAL - TFAC0 = ( (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) )**2 - if (TT .lt. TQQ(1,IV)) then - TFAC0 = (TT - 210.d0)/(TQQ(1,IV)-210.d0) - endif - TFAC0 = max(0.d0, min(1.d0, TFAC0)) -c---IV=NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - TT200 = min(300.d0, max(200.d0, TT)) - TFAC1 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) -c---IV=NJVAL+2 = Q1B for Acetone => (1) - IV = NJVAL+2 - TFAC2 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - -c---now integrate over wavelengths - do K = NW1,NW2 -c---NJVAL-1 = Xsect (total abs) for Acetone - IV = NJVAL-1 - QQQA = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFACA -c---NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. - IV = NJVAL - QQ2 = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC0 - if (TT .lt. TQQ(1,IV)) then - QQ2 = QQQ(K,1,IV)*TFAC0 - endif -c---NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - QQ1A = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC1 -c---NJVAL+2 = Q1B for Acetone => (1) ! scaled to [M]=2.5e19 - IV = NJVAL+2 - QQ1B = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC2 - QQ1B = QQ1B*4.d-20 -c---J(61) - VALJ(NJVAL-1) = VALJ(NJVAL-1) - & + FFF(K,L)*QQQA*(1.d0-QQ2)/(QQ1A + QQ1B*DD) -c---J(62) - VALJ(NJVAL) = VALJ(NJVAL) + FFF(K,L)*QQQA*QQ2 - - enddo !K -c-----------end v-8.3 includes Blitz ACETONE q-yields-------------- - endif - -c----Load array of J-values in native order, need to be indexed/scaled -c by ASAD-related code later: ZPJ(L,JJ) = VALJL(L,JIND(JJ))*JFACTA(JJ) - do J=1,NJVAL - VALJL(L,J) = VALJ(J) - enddo - - enddo ! master loop over L=1,JVL_ - return - end - - -c----------------------------------------------------------------------- - subroutine JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) -c----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' -c----------------------------------------------------------------------- -c--------key amtospheric data needed to solve plane-parallel J--------- - real*8, dimension(5,L1_) :: AER - integer,dimension(5,L1_) :: ADX - real*8, dimension(L1_) :: ABX, TTJ,DDJ,ZZJ,ZHL - real*8, dimension(L1_+1) :: PPJ - integer,dimension(L2_+1) :: JXTRA - real*8 :: ZZHT -c----------------------------------------------------------------------- - integer I,J,K,L - real*8 COL(4),COLO2,COLO3,ZKM,DELZ,ZTOP - - write(6,100) - 100 format(' L z(km) p T ',' d(air) d(O3)', - & ' col(O2) col(O3) ndx col(aer/cld)') - - COLO2 = 0.d0 - COLO3 = 0.d0 - do I=1,4 - COL(I) = 0.d0 - enddo - ZTOP = ZHL(L1_) + ZZHT - - do L = L1_,1,-1 - - do I=1,4 - COL(I) = COL(I) + AER(I,L) - enddo - COLO2 = COLO2 + DDJ(L)*0.20948d0 - COLO3 = COLO3 + ZZJ(L) - DELZ = ZTOP-ZHL(L) - ZTOP = ZHL(L) - ZKM = ZHL(L)*1.d-5 - - write(6,110) L,ZKM,PPJ(L),TTJ(L),DDJ(L)/DELZ,ZZJ(L)/DELZ, - & COLO2,COLO3, - & (ADX(I,L),COL(I), I=1,4), JXTRA(L+L),JXTRA(L+L-1) - 110 format(1x,i3,0p,f6.2,f10.3,f7.2,1p,4e9.2,4(i3,e9.2),2i3) - - enddo - - return - end - - -C----------------------------------------------------------------------- - subroutine RD_XXX(NJ1,NAMFIL) -C----------------------------------------------------------------------- -c Read in wavelength bins, solar fluxes, Rayleigh parameters, -c T-dependent X-sections. - -c >>>current code revised to JPL-02 ver 8.5 (5/05)<<<<< - -C----------------------------------------------------------------------- -c NAMFIL Name of spectral data file (j2_spec.dat) >> j2 for fast-J2 -c NJ1 Channel number for reading data file -c -c NJVAL Number of species to calculate J-values for -c NWWW Number of wavelength bins, from 1:NWWW -c WBIN Boundaries of wavelength bins -c WL Centres of wavelength bins - 'effective wavelength' -c FL Solar flux incident on top of atmosphere (cm-2.s-1) -c QRAYL Rayleigh parameters (effective cross-section) (cm2) -c QO2 O2 cross-sections -c QO3 O3 cross-sections -c Q1D O3 => O(1D) quantum yield -c TQQ Temperature for supplied cross sections -c QQQ Supplied cross sections in each wavelength bin (cm2) -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_JVdat.f' - - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - - integer I, J, K, IW, NQQQ, NWWW - - TQQ(:,:) = 0.d0 - -C----------spectral data----set for new format data J-ver8.3------------------ -c note that NJVAL = # J-values, but NQQQ (>NJVAL) = # Xsects read in -c for 2005a data, NJVAL = 62 (including a spare XXXX) and -c NQQQ = 64 so that 4 wavelength datasets read in for acetone -c note NQQQ is not used outside this subroutine! - - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - read (NJ1,100) TITLE0 - read (NJ1,101) NJVAL,NQQQ, NWWW,NW1,NW2 - if (NJVAL.gt.X_ .or. NQQQ.gt.X_) then - write(6,201) NJVAL,X_ - stop - endif - write(6,'(1X,A)') TITLE0 -C----J-values: 1=O2, 2=O3P,3=O3D 4=readin Xsects - read (NJ1,102) (WL(IW),IW=1,NWWW) - read (NJ1,102) (FL(IW),IW=1,NWWW) - read (NJ1,102) (QRAYL(IW),IW=1,NWWW) - -C---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - read (NJ1,103) TITLEJ(1),TQQ(1,1), (QO2(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,1), (QO2(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,1), (QO2(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(2),TQQ(1,2), (QO3(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,2), (QO3(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,2), (QO3(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(3),TQQ(1,3), (Q1D(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,3), (Q1D(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,3), (Q1D(IW,3),IW=1,NWWW) - - do J = 1,3 - write(6,200) TITLEJ(J),(TQQ(I,J),I=1,3) - enddo - -C---Read remaining species: X-sections at 2 T_s - do J = 4,NQQQ - read (NJ1,103) TITLEJ(J),TQQ(1,J),(QQQ(IW,1,J),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,J),(QQQ(IW,2,J),IW=1,NWWW) - write(6,200) TITLEJ(J),(TQQ(I,J),I=1,2) - enddo - -c Reset the titles for NJVAL-1 & NJVAL to be the two acetone J_s -c 61: C3H6O = Acet-a (CH3CO + CH3) -c 62: Q2-Ac = Acet-b (CH3 + CO + CH3) - - TITLEJ(NJVAL-1) = 'Acet-a' - TITLEJ(NJVAL) = 'Acet-b' - - close(NJ1) - - 100 format(a) - 101 format(10x,5i5) - 102 format(10x, 6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 103 format(a7,f3.0,6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 200 format(1x,' x-sect:',a10,3(3x,f6.2)) - 201 format(' Number of x-sections supplied to Fast-J2: ',i3,/, - & ' Maximum number allowed (X_) only set to: ',i3, - & ' - increase in cmn_jv.f') - - return - end - - -C----------------------------------------------------------------------- - subroutine RD_MIE(NJ1,NAMFIL) -C----------------------------------------------------------------------- -C-------aerosols/cloud scattering data set for fast-JX (ver 5.3) -c >>>>>>>>>>>>>>>>spectral data rev to J-ref ver8.5 (5/05)<<<<<<<<<<<< -C----------------------------------------------------------------------- -c NAMFIL Name of scattering data file (e.g., FJX_scat.dat) -c NJ1 Channel number for reading data file -c NAA Number of categories for scattering phase functions -c QAA Aerosol scattering phase functions -c NK Number of wavelengths at which functions supplied (set as 4) -c WAA Wavelengths for the NK supplied phase functions -c PAA Phase function: first 8 terms of expansion -c RAA Effective radius associated with aerosol type -c SSA Single scattering albedo -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'cmn_JVdat.f' - - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - integer I, J, K - - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - - read (NJ1,'(i2,a78)') NAA,TITLE0 - read (NJ1,'(5x,i5,2f10.5)') JTAUMX,ATAU,ATAU0 - write(6,'(a,2f9.5,i5)') ' ATAU/ATAU0/JMX',ATAU,ATAU0,JTAUMX - read (NJ1,*) - - do J = 1,NAA - read (NJ1,'(3x,a20)') TITLEA(J) - do K = 1,4 ! Fix number of aerosol wavelengths at 4 - read (NJ1,'(f5.0,f8.1,f7.3,f8.4,f7.3,7f6.3)') - & WAA(K,J),QAA(K,J),RAA(K,J),SSA(K,J),(PAA(I,K,J),I=1,8) - enddo - enddo - - close(NJ1) - - write(6,*) 'Aerosol phase functions & wavelengths' - write(6,*) TITLE0 - do J=1,NAA - write(6,'(1x,A8,I2,A,9F8.1)') - & TITLEA(J),J,' wavel=',(WAA(K,J),K=1,4) - write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,4) - enddo - - return - end - - -c----------------------------------------------------------------------- - real*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -C----------------------------------------------------------------------- -c Three-point linear interpolation function -C----------------------------------------------------------------------- - real*8 TINT,T1,T2,T3,F1,F2,F3 - if (TINT .le. T2) then - if (TINT .le. T1) then - FLINT = F1 - else - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - endif - else - if (TINT .ge. T3) then - FLINT = F3 - else - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - endif - endif - return - end - - -c----------------------------------------------------------------------- - subroutine SOLARZ(GMTIME,NDAY,YGRDJ,XGRDI, SZA,COSSZA,SOLFX) -C----------------------------------------------------------------------- -c GMTIME = UT for when J-values are wanted -c (for implicit solver this is at the end of the time step) -c NDAY = integer day of the year (used for solar lat and declin) -c YGRDJ = laitude (radians) for grid (I,J) -c XGDRI = longitude (radians) for grid (I,J) -c -c SZA = solar zenith angle in degrees -c COSSZA = U0 = cos(SZA) -C----------------------------------------------------------------------- - implicit none - real*8, intent(in) :: GMTIME,YGRDJ,XGRDI - integer, intent(in) :: NDAY - real*8, intent(out) :: SZA,COSSZA,SOLFX - - real*8 PI, PI180, LOCT - real*8 SINDEC, SOLDEK, COSDEC, SINLAT, SOLLAT, COSLAT, COSZ -c - PI = 3.141592653589793d0 - PI180 = PI/180.d0 - SINDEC = 0.3978d0*sin(0.9863d0*(dble(NDAY)-80.d0)*PI180) - SOLDEK = asin(SINDEC) - COSDEC = cos(SOLDEK) - SINLAT = sin(YGRDJ) - SOLLAT = asin(SINLAT) - COSLAT = cos(SOLLAT) -c - LOCT = (((GMTIME)*15.d0)-180.d0)*PI180 + XGRDI - COSSZA = COSDEC*COSLAT*cos(LOCT) + SINDEC*SINLAT - SZA = acos(COSSZA)/PI180 - - SOLFX = 1.d0-(0.034d0*cos(dble(NDAY-186)*2.d0*PI/365.d0)) - - return - end - - -c----------------------------------------------------------------------- - subroutine SPHERE(GMU,RAD,ZHL,ZZHT,AMF,L1_) -C----------------------------------------------------------------------- -c Calculation of spherical geometry; derive tangent heights, slant path -c lengths and air mass factor for each layer. Not called when -c SZA > 98 degrees. Beyond 90 degrees, include treatment of emergent -c beam (where tangent height is below altitude J-value desired at). -C----------------------------------------------------------------------- -c in: -c GMU = MU0 = cos(solar zenith angle) -c RAD radius of Earth mean sea level (cm) -c ZHL(L) height (cm) of the bottome edge of CTM level L -c ZZHT scale height (cm) used above top of CTM (ZHL(L_+1) -c L1_ dimension of CTM = levels +1 -c out: -c AMF(I,J) = air mass factor for CTM level I for sunlight reaching J -C----------------------------------------------------------------------- - implicit none - integer, intent(in) :: L1_ - real*8, intent(in) :: GMU,RAD,ZHL(L1_),ZZHT - real*8, intent(out) :: AMF(L1_,L1_) - -c RZ Distance from centre of Earth to each point (cm) -c RQ Square of radius ratios -c TANHT Tangent height for the current SZA -c XL Slant path between points - - integer I, J, K, II - real*8 AIRMAS, XMU1, XMU2, XL, DIFF, TANHT - & ,Ux,H,RZ(L1_),RQ(L1_),ZBYR -c -c Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- - & 0.6817d0*EXP(-57.3d0*abs(Ux)/SQRT(1.0d0+5500.d0*H))/ - & (1.0d0+0.625d0*H))) -c - RZ(1) = RAD + ZHL(1) - ZBYR = ZZHT/RAD - do II = 2,L1_ - RZ(II) = RAD + ZHL(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - enddo - if (GMU .lt. 0.0d0) then - TANHT = RZ(1)/dsqrt(1.0d0-GMU**2) - else - TANHT = RZ(1) - endif -c -c Go up from the surface calculating the slant paths between each level -c and the level above, and deriving the appropriate Air Mass Factor - do 16 J = 1,L1_ - do I = 1,L1_ - AMF(I,J) = 0.d0 - enddo -c -c Air Mass Factors all zero if below the tangent height - if (RZ(J) .lt. TANHT) goto 16 -c Ascend from layer J calculating AMFs - XMU1 = abs(GMU) - do I = J,L1_-1 - XMU2 = dsqrt(1.0d0 - RQ(I)*(1.0d0-XMU1**2)) - XL = RZ(I+1)*XMU2 - RZ(I)*XMU1 - AMF(I,J) = XL / (RZ(I+1)-RZ(I)) - XMU1 = XMU2 - enddo -c Use function and scale height to provide AMF above top of model - AMF(L1_,J) = AIRMAS(XMU1,ZBYR) -c -c Twilight case - Emergent Beam - if (GMU .ge. 0.0d0) goto 16 - XMU1 = abs(GMU) -c Descend from layer J - do II = J-1,1,-1 - DIFF = RZ(II+1)*sqrt(1.0d0-XMU1**2)-RZ(II) - if (II.eq.1) DIFF = max(DIFF,0.d0) ! filter -c Tangent height below current level - beam passes through twice - if (DIFF .lt. 0.0d0) then - XMU2 = sqrt(1.0d0 - (1.0d0-XMU1**2)/RQ(II)) - XL = abs(RZ(II+1)*XMU1-RZ(II)*XMU2) - AMF(II,J) = 2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1 = XMU2 -c Lowest level intersected by emergent beam - else - XL = RZ(II+1)*XMU1*2.0d0 - AMF(II,J) = XL/(RZ(II+1)-RZ(II)) - goto 16 - endif - enddo - - 16 continue - return - end - - -C----------------------------------------------------------------------- - subroutine EXTRAL(AER,ADX,L1X,L2X,NX,JTAUMX,ATAU,ATAU0, JXTRA) -C----------------------------------------------------------------------- -c -c new version 5.3, add sub-layers (JXTRA) to thick cloud/aerosol layers -c this version sets up log-spaced sub-layers of increasing thickness ATAU -c -c AER(5,L=1:L1X) = Optical Depth in layer L (general visible OD) -c This is not used in the calculation of J's but in calculating -c the number in levels to insert in each layer L -c Set for log-spacing of tau levels, increasing top-down. -c AER(1:4,L) = aerosol+cloud OD (up to 4 types, index type = ADX(1:4,L) -c AER(5,L) = Rayleigh-not used here -c -c N.B. the TTAU, etc caluclate here are not really used elsewhere - -c---The log-spacing parameters have been tested for convergence and chosen -c--- to be within 0.5% for ranges OD=1-500, rflect=0-100%, mu0=0.1-1.0 -c--- use of ATAU = 1.18 and min = 0.01, gives at most +135 pts for OD=100 -C----------------------------------------------------------------------- -c - implicit none - integer, intent(in) :: JTAUMX,L1X,L2X !index of cloud/aerosol - integer, intent(in) :: NX !Mie scattering array size - real*8, intent(in) :: AER(5,L1X) !cloud+3aerosol OD in each layer - real*8, intent(in) :: ATAU,ATAU0 - integer, intent(in) :: ADX(5,L1X) !index of cloud/aerosol - integer, intent(out) :: JXTRA(L2X+1) !number of sub-layers to be added -c - integer JTOTL,I,L,L2 - real*8 DTAUX(L1X),TTAU(L2X+1),DTAUJ, ATAU1,ATAULN,ATAUM,ATAUN1 -c -C---Reinitialize arrays - TTAU(:) = 0.d0 - JXTRA(:) = 0 -c -C---Set up total optical depth over each CTM level (L=1:L1X) -c--- DTAUX(L) = bulk properties (OD) of each CTM layer - - do L = 1,L1X -c Total optical depth from all elements I=1:4 = clouds + 3 aerosol types -c Assume here that AER(1:4, 1:L1X) is 'visible' Optical Depth = 600 nm -c do NOT count if ADX = 0 - DTAUX(L) = 0.d0 - do I = 1,4 - if (ADX(I,L) .gt. 0) DTAUX(L) = DTAUX(L) + AER(I,L) - enddo - enddo -c -c---combine these edge- and mid-layer points into grid of size: -c--- L2X+1 = 2*L1X+1 = 2*L_+3 -c---calculate column optical depths above each level, TTAU(1:L2X+1) -c--- note that TTAU(L2X+1)=0 and TTAU(1)=total OD -c -c---Divide thick layers to achieve better accuracy in the scattering code -c---In the original fast-J, equal sub-layers were chosen, this is wasteful -c---and this new code (ver 5.3) uses log-scale: -c--- Each succesive layer (down) increase thickness by ATAU > 1 -c--- e.g., if ATAU = 2, a layer with OD = 15 could be divided into -c--- 4 sub-layers with ODs = 1 - 2 - 4 - 8 -c---The key parameters are: -c--- ATAU = factor increase from one layer to the next -c--- ATAUMN = the smallest OD layer desired -c--- JTAUMX = maximum number of divisions (i.e., may not get to ATAUMN) -c---These are hardwired below, can be changed, but have been tested/optimized - - ATAU1 = ATAU - 1.d0 - ATAULN = log(ATAU) - TTAU(L2X+1) = 0.0d0 - do L2 = L2X,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ -c---Now compute the number of log-spaced sub-layers to be added in -c--- the interval TTAU(L2) > TTAU(L2+1) -c---The objective is to have successive TAU-layers increasing by factor ATAU >1 -c---the number of sub-layers + 1 - if (TTAU(L2) .lt. ATAU0) then - JXTRA(L2) = 0 - else - ATAUM = max(ATAU0, TTAU(L2+1)) - ATAUN1 = log(TTAU(L2)/ATAUM) / ATAULN - JXTRA(L2) = min(JTAUMX, max(0, int(ATAUN1 - 0.5d0))) - endif - enddo - -c---check on overflow of arrays, cut off JXTRA at lower L if too many levels - JTOTL = L2X + 2 - do L2 = L2X,1,-1 - JTOTL = JTOTL + JXTRA(L2) - if (JTOTL .gt. NX/2) then - write(6,'(A,2I5,F9.2)') 'N_/L2_/L2-cutoff JXTRA:',NX,L2X,L2 - do L = L2,1,-1 - JXTRA(L) = 0 - enddo - go to 10 - endif - enddo - 10 continue - - return - end - - -C----------------------------------------------------------------------- - subroutine OPMIE - & (KW,KM,WAVEL,ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,FMEAN,FJTOP,FJBOT) -C----------------------------------------------------------------------- -c in: -c KW = wavelength bin # (1:18) -c KM = wavelength index for Mie properties (1:4 = 300-400-600-999 nm) -c WAVEL = wavelength of bin (in nm) - not now used -c ABX(L1_) = vertical profiles of ABSORPTION Optical Depth in each layer -c includes O2 and O3 for now (BC under aerosols) -c AER(1:5,1:L1_) = 5 vertical profiles of Optical Depth in each layer -c ADX(1:5,1:L1_) = integer index of the scattering properties of each AER -c 1:4 are reserved for aerosols and clouds -c 5 is meant only for Rayleigh scattering! -c JXTRA(1:L1_) = number 0:J = no. of additional levels to be inserted -c U0 = cos (SZA) -c RFLECT = Lambertian albedo of surface -c out: -c FMEAN(1:L_) = mean actinic flux at standard CTM levels (mid-layer) -C----------------------------------------------------------------------- -c -c DTAUX Local optical depth of each CTM level -c TTAU Optical depth of air vertically above each point (to top of atm) -c FTAU Attenuation of solar beam -c POMEGA Scattering phase function -c -c---new Ver 5.3 code adds sub-layers (# = JXTRA(L2)) using ATAU as the -c factor increase from sub-layer to sub-layer - -C fast-J Mie code for J_s, only uses 8-term expansion, 4-Gauss pts -C Currently allow up to A_ aerosol phase functions (at all altitudes) to -C be associated with optical depth AER(1:L2_) = aerosol opt.depth @ 1000 nm -C -C Pick Mie-wavelength with phase function and Qext: e.g., -C 01 RAYLE = Rayleigh phase -C 02 ISOTR = isotropic -C 03 ABSRB = fully absorbing 'soot', wavelength indep. -C 04 X_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -C 05 X_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -C. . . -C 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -C. . . -C 13 Ice-H = hexagonal ice cloud (Mishchenko) -C 14 Ice-I = irregular ice cloud (Mishchenko) -C -C Choice of the 4 aerosol/cloud indices ADX is made earlier -c Optical depths for the 4 (aerosol+clouds) = AER -c -C----------------------------------------------------------------------- - implicit none - include 'parm_CTM.f' - include 'parm_MIE.f' - include 'cmn_JVdat.f' - - real*8, intent(in) :: WAVEL,AER(5,L1_),ABX(L1_),AMF(L1_,L1_) - real*8, intent(in) :: U0,RFLECT - integer, intent(in) :: KW,KM,ADX(5,L1_) - integer, intent(in) :: JXTRA(L2_+1) - real*8, intent(out) :: FMEAN(L_),FJTOP,FJBOT -c - integer JNDLEV(L_),JADDLV(L2_+1),JADDTO(L2_+1),L2LEV(L2_+1) - & ,JTOTL,I,II,J,K,L,IX,JK, L2,L2L,L22,LZ,LZZ,NDZ -c - real*8 QXMIE(5),XLAER(5),SSALB(5),DTAUX(L1_),PIAER(5,L1_) - & ,POMEGAJ(2*M_,L2_+1),TTAU(L2_+1),FTAU(L1_) - & ,FTAU2(L2_+1),DTTAU,DFTAU,dPOMEGA(2*M_) - & ,XLO2,XLO3,XLRAY,XLTAU,ZK,TAUDN,TAUUP,ZK2 - & ,DTAUJ,DTAUAD,TAUBTM,TAUTOP,FBTM,FTOP,POMEGAB(2*M_) - & ,ATAUA,ATAUZ -c--- variables used in mie code----------------------------------------- - real*8 FJ(N_),POMEGA(2*M_,N_),FZ(N_),ZTAU(N_),ZREFL,ZU0,ZFLUX - real*8 FJT,FJB - integer MFIT, ND - -C---Reinitialize arrays - ZTAU(:) = 0.d0 - FZ(:) = 0.d0 - POMEGA(:,:) = 0.d0 - - -C---Set up optical depth DTAUX(L), and scattering fraction PIAER(1:5,L) -c--- where L = 1:L1_ = bulk properties of each CTM layer. - do L = 1,L1_ - - do I = 1,4 - if (ADX(I,L) .eq. 0) then - QXMIE(I) = 0.d0 - SSALB(I) = 0.d0 - else -C---for Mie code scale extinction at 600 nm to wavelength WAVEL (QXMIE) - QXMIE(I) = QAA(KM,ADX(I,L))/QAA(3,ADX(I,L)) - SSALB(I) = SSA(KM,ADX(I,L)) - endif - enddo -c---special case for Rayleigh scattering - QXMIE(5) = 1.d0 - SSALB(5) = 1.d0 - do I = 1,5 - XLAER(I) = AER(I,L)*QXMIE(I) - enddo - - DTAUX(L) = ABX(L) - do I = 1,5 - DTAUX(L) = DTAUX(L) + XLAER(I) - enddo -c---fractional extinction for Rayleigh scattering and each aerosol type - do I = 1,5 - PIAER(I,L) = SSALB(I)*XLAER(I)/DTAUX(L) - enddo - - enddo - -C---Calculate attenuated incident beam exp(-TTAU/U0 = DTAUX * AirMassFactor) -c--- at the edges of the CTM layers L=1:L1_ - do L = 1,L1_ - if (AMF(L,L) .gt. 0.0d0) then - XLTAU = 0.0d0 - do I = 1,L1_ - XLTAU = XLTAU + DTAUX(I)*AMF(I,L) - enddo - if (XLTAU .gt. 76.d0) then ! zero out flux at 1e-33 - FTAU(L) = 0.d0 - else - FTAU(L) = exp(-XLTAU) - endif - else - FTAU(L) = 0.0d0 - endif - enddo -c -C---Define the total scattering phase fn for each CTM layer L=1:L_+1 -c--- from a DTAUX-wt_d mix of aerosols, cloud & Rayleigh -C---No. of quadrature pts fixed at 4(M_), expansion of phase fn @ 8 - MFIT = 2*M_ - do L = 1,L1_ - do I = 1,MFIT - POMEGAJ(I,L) = 0.d0 - do K = 1,5 - POMEGAJ(I,L)=POMEGAJ(I,L) + PIAER(K,L)*PAA(I,KM,ADX(K,L)) - enddo - enddo - enddo - -c--printout diagnositcs of different aerosol+cld contrib to OD -c if(KW.eq.18) then -c do L=1,L1_ -c write(6,'(3i5,1p,20e12.5)') L,JXTRA(L+L),JXTRA(L+L-1), -c & DTAUX(L),(AER(I,L),I=1,5) -c enddo -c endif - -c -C------------------------------------------------------------------------ -c Take optical properties on CTM layers and convert to a photolysis -c level grid corresponding to layer centres and boundaries. This is -c required so that J-values can be calculated for the centre of CTM -c layers; the index of these layers is kept in the JNDLEV array. -C------------------------------------------------------------------------ -c -c---Now combine the CTM layer edges (1:L_+2) with the CTM mid-layer -c--- points (1:L_) plus 1 for the mid point of added top layer. - -c---combine these edge- and mid-layer points into grid of size: -c--- L2_+1 = 2*L1_+1 = 2*L_+3 -c---calculate column optical depths above each level, TTAU(1:L2_+1) -c--- note that TTAU(L2_+1)=0 and TTAU(1)=total OD - TTAU(L2_+1) = 0.0d0 - do L2 = L2_,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ - enddo -c -C---reflected flux from surface - if (U0 .gt. 0.d0) then - ZFLUX = U0*FTAU(1)*RFLECT/(1.d0+RFLECT) - else - ZFLUX = 0.d0 - endif -c -c---calculate attenuated beam FTAU2 on the new doubled-levels L2=1:L2_+1 -c--- calculate FTAU2 at CTM mid-layers from sqrt -c--- L2_ = 2*L1_ = 2*L_+2 - - FTAU2(L2_+1) = 1.0d0 - FTAU2(L2_) = sqrt(1.0d0*FTAU(L1_)) - FTAU2(L2_-1) = FTAU(L1_) - do L2 = L2_-3,1,-2 - L = (L2+1)/2 - FTAU2(L2) = FTAU(L) - FTAU2(L2+1) = sqrt(FTAU(L+1)*FTAU(L)) - enddo -c -c Calculate scattering properties, level centres then level boundaries -c ***be careful of order, we are shifting the 'POMEGAJ' upward in index*** - do L2 = L2_,2,-2 - L = L2/2 - do I = 1,MFIT - POMEGAJ(I,L2) = POMEGAJ(I,L) - enddo - enddo -c---lower boundary value is set (POMEGAJ(I,1), but set upper: - do I = 1,MFIT - POMEGAJ(I,L2_+1) = POMEGAJ(I,L2_) - enddo -c---now have POMEGAJ filled at even points from L2=3:L2_-1 -c---use inverse interpolation for correct tau-weighted values at edges - do L2 = 3,L2_-1,2 - TAUDN = TTAU(L2-1)-TTAU(L2) - TAUUP = TTAU(L2)-TTAU(L2+1) - do I = 1,MFIT - POMEGAJ(I,L2) = (POMEGAJ(I,L2-1)*TAUDN + - & POMEGAJ(I,L2+1)*TAUUP) / (TAUDN+TAUUP) - enddo - enddo -C---at this point FTAU2(1:L2_+1) and POMEAGJ(1:8, 1:L2_+1) -c--- where FTAU2(L2_+1) = 1.0 = top-of-atmos, FTAU2(1) = surface -c -C------------------------------------------------------------------------ -c Calculate cumulative total and define levels we want J-values at. -c Sum upwards for levels, and then downwards for Mie code readjustments. -c -c JXTRA(L2) Number of new levels to add between (L2) and (L2+1) -c ***JXTRA(1:L2_+1) is calculated based on the aerosol+cloud OD_s -c JADDLV(L2) Number of new levels actually added at each wavelength -c where JADDLV = 0 when there is effectively no FTAU2 -c JADDTO(L2) Total number of new levels to add to and above level (L2) -c JNDLEV(L) = L2 index that maps on CTM mid-layer L -c -C------------------------------------------------------------------------ - -c---JADDLV(L2=1:L2_) = number of levels to add between TTAU2(L2) and TTAU(L2+1) -c--- JADDLV is taken from JXTRA, which is based on visible OD. -c--- JADDTO(L2=1:L2_+1) is the cumulative number of levels to be added -c---note that JADDLV and JADDTO will change with wavelength and solar zenith - -c--now try to insert additional levels for thick clouds, ONLY IF FTAU2 > 1.e-8 -c-- this will cut off additional levels where the solar beam is negligible. - - do L2 = 1,L2_ - if (FTAU2(L2+1) .lt. 1.d-30) then - JADDLV(L2) = 0 - else - JADDLV(L2) = JXTRA(L2) - endif - enddo - JADDTO(L2_+1) = 0 - do L2 = L2_,1,-1 - JADDTO(L2) = JADDTO(L2+1) + JADDLV(L2) - enddo - -c---expanded grid now included CTM edge and mid layers plus expanded -c--- grid to allow for finer delta-tau at tops of clouds. -c--- DIM of new grid = L2_ + JADDTO(1) + 1 - -c---L2LEV(L2) = L2-index for old level L2 in expanded J-grid (w/JADDLV) -c in absence of JADDLV, L2LEV(L2) = L2 - L2LEV(1) = 1 - do L2 = 2,L2_+1 - L2LEV(L2) = L2LEV(L2-1) + 1 + JADDLV(L2-1) - enddo - -c---JNDLEV(L=1:L_) = L2-index in expanded grid for CTM mid-layer L - do L = 1,L_ - JNDLEV(L) = L2LEV(2*L) - enddo - -C---------------------SET UP FOR MIE CODE------------------------------- -c -c Transpose the ascending TTAU grid to a descending ZTAU grid. -c Double the resolution - TTAU points become the odd points on the -c ZTAU grid, even points needed for asymm phase fn soln, contain 'h'. -c Odd point added at top of grid for unattenuated beam (Z='inf') -c -c The following mapping holds for JADDLV=0 -c Surface: TTAU(1) ==> ZTAU(2*L2_+1) -c Top: TTAU(L2_) ==> ZTAU(3) -c Infinity: 0.0 ==> ZTAU(1) -c index: 2*(L2_+1-L2)+1 ==> LZ -c -c Mie scattering code only used from surface to level L2_ -C------------------------------------------------------------------------ -c -C------------------------------------------------------------------------ -c Insert new levels, working downwards from the top of the atmosphere -c to the surface (down in 'LZ', up in 'L2'). This allows ztau and pomega -c to be incremented linearly (in a +ve sense), and the flux fz to be -c attenuated top-down (avoiding problems where lower level fluxes are -c zero). -c -c zk fractional increment in level -c dTTAU change in ttau per increment (linear, positive) -c dPOMEGA change in pomega per increment (linear) -c ftaulog change in ftau per increment (exponential, normally < 1) -c -C------------------------------------------------------------------------ -c -c Ascend through atmosphere transposing grid and adding extra points -c remember L2=1 is surface of CTM, but last layer (LZ) in scattering code. -c there are twice the number of layers in the LZ arrays (2*L2_ + 2*JADDTO + 1) -c because we need to insert the intermediate layers (even LZ) for the -c asymmetric scattering code. - - -c Transfer the L2=1:L2_+1 values (TTAU,FTAU2,POMEGAJ) onto the reverse -c order, expanded, doubled-level scatter grid. -c Note that we need to deal with the expansion by JADD levels (L2L). -c These JADDLV levels are skipped and need to be interpolated later. -c Note that only odd LZ levels are filled, - - NDZ = 2*L2_ + 2*JADDTO(1) + 1 - -c Note that the successive sub-layers have the ratio in OD of ATAU -c ATAUA = (ATAU - 1.d0)/ATAU ! this is the limit for L22=>inf - - do L2 = 1,L2_+1 ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - ZTAU(LZ) = TTAU(L2) - FZ(LZ) = FTAU2(L2) - do I=1,MFIT - POMEGA(I,LZ) = POMEGAJ(I,L2) - enddo - enddo - -c Now go thru the pairs of L2 levels to see if we need JADD levels - do L2 = 1,L2_ ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - L22 = L2LEV(L2+1) - L2LEV(L2) - 1 ! L22 = 0 if no added levels - if (L22 .gt. 0) then - TAUBTM = TTAU(L2) - TAUTOP = TTAU(L2+1) - FBTM = FTAU2(L2) - FTOP = FTAU2(L2+1) - do I = 1,MFIT - POMEGAB(I) = POMEGAJ(I,L2) - enddo - -c---to fit L22 new layers between TAUBOT > TAUTOP, calculate new 1/ATAU factor -c--- such that TAU(just above TAU-btm) = ATUAZ * TAUBTM < TAUBTM - - ATAUZ = exp(-log(TAUBTM/max(TAUTOP,ATAU0))/float(L22+1)) - - do L = 1,L22 ! add odd levels between L2LEV(L2) & L2LEV(L2+1) - LZZ = LZ - 2*L ! LZZ = index(odd) of added level in scatt arrays - ZTAU(LZZ) = TAUBTM * ATAUZ - ATAUA=(TAUBTM-ZTAU(LZZ))/(TAUBTM-TAUTOP) !fraction from TAUBTM=>TAUTOP - if (FBTM .lt. 1.d-32) then - FZ(LZZ) = 0.d0 - else - FZ(LZZ) = FBTM * (FTOP/FBTM)**ATAUA - endif - do I = 1,MFIT - POMEGA(I,LZZ) = POMEGAB(I) + - & ATAUA*(POMEGAJ(I,L2+1)-POMEGAB(I)) - enddo - TAUBTM = ZTAU(LZZ) - FBTM = FZ(LZZ) - do I = 1,MFIT - POMEGAB(I) = POMEGA(I,LZZ) - enddo - enddo - endif - enddo - -c Now fill in the even points with simple interpolation in scatter arrays: - do LZ = 2,NDZ-1,2 - ZTAU(LZ) = 0.5d0*(ZTAU(LZ-1)+ZTAU(LZ+1)) - FZ(LZ) = sqrt(FZ(LZ-1)*FZ(LZ+1)) - do I=1,MFIT - POMEGA(I,LZ) = 0.5d0*(POMEGA(I,LZ-1)+POMEGA(I,LZ+1)) - enddo - enddo - - ND = NDZ - ZU0 = U0 - ZREFL = RFLECT - -c---PRINT diagnostics -c write(6,'(A,2I6)') 'Total levels of photolysis in OPMIE',ND - if(ND .gt. N_) then - write(6,'(a,2i9)') ' overflow of scatter arrays:',ND,N_ - stop - endif - -C----------------------------------------------------------------------- - call MIESCT(FJ,FJT,FJB,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,ZU0,MFIT,ND) -C----------------------------------------------------------------------- - -c---Move mean intensity from scatter array FJ(LZ=1:ND) -c--- to CTM mid-level array FMEAN(L=1:L_) - do L = 1,L_ - L2L = JNDLEV(L) - LZ = ND+2 - 2*L2L - FMEAN(L) = FJ(LZ) - enddo -c---fluxes reflected at top, incident at bottom (1/2 layer flux) - FJTOP = FJT - FJBOT = FJB - - return - end - -c<<<<<<<<<<<<<<<<<<<<<<>>this is supplied here as newcol.f file<<< - jv_cmn.h Parameters and common blocks - 'include' file - jv_mie.h Mie scattering common blocks - 'include' file - jv_atms.dat Temperature and ozone profiles - jv_spec.dat Wavelengths, cross-sections, phase functions - - ratj.d List of photolysis reactions (example) - (part of the ASAD chemistry scheme, not part - of Fast-J2, but included for completeness) - - - Brief description of what's happening: - - inphot Routine to initialise photolysis data, called once from - model (or chemistry) set-up routine. Reads in reactions - to consider, keeping the quantum yield for the reaction - and the reaction label (used to identify the X-sections - in jv_spec.dat); the chemical parameters are read in - again elsewhere in the chemistry code. - Also reads in spectral data and the T and O3 fields, which - can be overwritten with model T and O3 profiles if desired. - (18 lats, 12 months, 21/31 1-km levels) - Sets the maximum d(tau) for the Mie code (greater than - unity leads to drift from solution, less leads to too many - extra levels) and maximum zenith angle for top of atmosphere. - - photoj Main photolysis routine called every chemical timestep. - J-values output profile-at-a-time as level x reaction array - jpnl = number of levels for chemistry (No. CTM levels) - jppj = number of photolysis reactions - nslat/nslon = lat. and long. indices of current profile - - ctm_adj Sets up pressures (P) and opt.depths (OD) for scheme, - sets surface albedo (RFLECT) - - solar2 Sets up Zenith angle - - rd_prof Reads T and O3 profiles and sets mean Black Carbon profile - - int_prof Interpolate profiles onto appropriate levels - - jratet Calculate J-values (the final routine) - - rd_tjpl Read in spectral data (ex-JPL sources) from jv_spec.dat - and map to photolysis reactions required. - - prtatm Output routine (not called by default) for debugging, etc. - - jvalue Calculate the actinic flux at each level for the current SZA - Calls scattering code - - sphere Calculation of spherical geometry - - opmie Mie code - sets up the appropriate levels for the Mie - scattering code (inserting levels where d(tau) is greater - than dtaumax), and the profiles for ZTAU, FZ and POMEGA - - miesct Mie scattering code (plus following subroutines) - - - -CTM INPUTS: - -The CTM provides the pressure profile (surface pressure, P, together with -eta values for the level boundaries), the temperature profile T (for -X-sections but currently not for O3/density profile), the optical depth -profile OD (depth for each model level), the surface albedo SA and the -temporal and spatial details (tau, iday, nslat, nslon). These are passed -into the code with the included header file 'cmn_h.f' (main header), -'cmn_w.f' (P,SA,OD from wind files) and 'cmn_t.f' (tropospheric chemistry). -These includes should be replaced with the appropriate commons from -the model used. See 'further details' below. - - - -CAVEATS: - -1) Currently we're using fixed profiles of T and O3, and a single step - profile for black carbon (in 'rd_prof'). Eventually we may want to use - model-calculated values, but fixed profiles make a better place to start. - -2) The default phase function for cloud water assumes 8-micron droplets - (aerosol type 10), with ice (aerosol type 14) below a threshold - temperature. External mixtures of different aerosol types are - fine - alter the set_aer routine to define the aerosol data - available, and set up the appropriate masses of optical depths in - set_prof. - -3) Where optical depth over a level exceeds dtaumax (usually 1.0), a - new level is inserted for the scattering code. Fast-J2 works in Tau- - space; ZTAU and POMEGA are interpolated linearly, FZ log-interpolated. - Large optical depths generate many new levels! Reducing dtaumax - to 0.1 improves accuracy, but degrades performance. - -4) Optical depths are taken from the met data for each level/timestep. - Current GISS runs truncate opt. depth at 100 for any individual level. - To prevent the number of levels getting out of hand, we truncate the - total column optical depth at 200 or 150, scaling to this where necessary. - This makes very little absolute difference to J-values in most cases. - The column truncation value is 'odmax', hardwired into ctm_adj. If this - number is increased, then it may be necessary to increase the 'N__' - value in jv_mie.h - -5) O2 photolysis is neglected in the troposphere, but the section in - the code is left in place to allow it to be reintroduced if anyone - is interested in focussing on the tropical upper troposphere. - [This has now been added - 8/8/2000] - -6) The annual variation in the distance to the sun, SOLF, is not used - by default, but can be added as the argument to the call to JRATET. - -7) The main photolysis routine, photoj, should be called whenever - J-values are required - the argument 'timej' is an offset time in hours - between the time of the call (TAU, hours GMT) and the time the J-values - are required - typically half the timestep length in order to give the - mid-point J-values over the timestep. (J-values are output in the - 'zpj' array dimensioned by level and species) - - - - FURTHER DETAILS - -The following are a list of - -Include Files --------------- - - cmn_t.f Trop. chem. nslon, nslat - - cmn_w.f Wind fields P, T, OD, SA - - cmn_h.f Header file tau, iday, xgrd, ygrd, ydgrd (etc) - - -- Our chemistry code does one column at a time, and photolysis is called from - within the chemistry - nslon, nslat are the i,j values for the current - column. Set them before every call to Fast-J2, and put the following in - the include file: (you can then remove the cmn_t.f includes) - - integer nslat, nslon - common/currentcol/ nslat, nslon - -- Surface pressure (P), temperature (T), optical depth (OD) and surface - albedo (SA) are all taken from the met. data., which we have a separate - include file for; if these are all provided in your main include file, - then the cmn_w.f includes can be removed, too. - -- Everything else is taken from cmn_h.f - this can safely be replaced with - your own CTM include file. ipar, jpar and lpar (the number of latitudes, - longitudes and levels) are passed here. - - -jlabel ------- - -When you're implementing the code, you might want to make one or two -changes to the 'inphot' routine, the first in the pphot.f file. This is -the photolysis initialisation routine, where you need to map the -appropriate cross-sections to the photolysis reactions (plus specified -fractions or constant quantum yields if desired). The way I've done it -fits with my chemistry - alter it to suit yours, but the key is to label -each of your reactions ('jlabel') with the 7-character cross-section label -given in the main 'jv_spec.dat' data file. The mapping is then done in the -RD_TJPL routine. - - -jfacta ------- - -"jfacta" isn't a true quantum yield (which would need to be wavelength- -dependent in most cases). It's simply a multiplication factor for -the cross-section. For example, CH3OOH has two photolysis channels, -and assuming you want to take 50% by each route, jfacta should be 50 -for both of them. Alternatively, it can be used as a scaling factor; -if you want to assume the photolysis rate of C2H5OOH is 20% greater -than that of CH3OOH, the C2H5OOH photolysis route can be labelled with -jlabel='MeOOH' and jfacta='120.0'. - -True quantum yields are wavelength-dependent, and are not all treated -correctly here: exceptions: O3 --> O(1D) + O2, ClONO2, CH2O, .... - -'ActAld' is now acetaldehyde - - -jppj/jpnl ---------- - -'jppj' is the number of photolysis reactions to be considered (ie. 3 in -the example 'ratj.d'). 'jpnl' is the number of model levels to -do chemistry/photolysis at, and should be less than or equal to the -number of CTM model levels. - -Note that most of the CPU time required by the code goes into solving -the radiative transfer equations - calculating photolysis rates for -100 species takes little more time than calculating one. - - -P -- - -Fast-J/J2/JX requires pressures at the bottom and centre of each model level -(pj(j-1) and p(j) respectively in the ctm_adj routine). In the GISS II' -framework, pressure of level boundaries is calculated using the expression -"ETAA(i) + ETAB(i)*P", where P is the surface pressure, and ETAA and ETAB -are fractions (using sigma levels, '(1-sigma)*top_pressure' and 'sigma' -respectively, using pressure levels 'pressure' and 'zero' respectively). -The pressure column 'pj' internal to Fast-J2 requires pressure in mbars. - - -xgrd/ygrd/ydgrd ---------------- - -XGRD are the longitudes of grid box centres expressed in radians -YGRD are the latitudes of grid box centres expressed in radians -YDGRD are the latitudes of grid box centres expressed in degrees - - - -NOTES: - -Sorry about the mixed cases in the code - the original code was all in -upper case, but most new additions are in lower case. These historical -differences may aid understanding! - -If you spot any errors/bugs, let us know. - -If you have problems implementing the code, try the 'standalone' code -first to work out what's going on. However, this code doesn't have many -features of the main code (including bug fixes!), so it's not advisable -to try implementing this version. - - - Oliver (13 May 99) - Prather (Jul 04) diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/GmiFastJX_ParametersMod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/GmiFastJX_ParametersMod.F90 deleted file mode 100644 index ecee7097..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/GmiFastJX_ParametersMod.F90 +++ /dev/null @@ -1,27 +0,0 @@ - - module GmiFastJX_ParametersMod - - PUBLIC - - INTEGER, PARAMETER :: LPAR_MAX=72 ! max number of vertical levels - INTEGER, PARAMETER :: JPNL_MAX = lpar_max - INTEGER, PARAMETER :: JPPJ_MAX=82 ! Number of photolytic reactions supplied - INTEGER, PARAMETER :: IPAR = 1 ! Number of lon points in CTM - INTEGER, PARAMETER :: JPAR = 1 ! Number of lat points in CTM - LOGICAL, PARAMETER :: LDEG45=.false. ! Logical flag for degraded CTM resolution - - INTEGER, PARAMETER :: NS = 61 ! Max # species which require J-values calculating - INTEGER, PARAMETER :: NW = 18 ! Max # wavelength bins that can be used - INTEGER, PARAMETER :: NP = 56 ! Max # aerosol/cloud types that can be used - INTEGER, PARAMETER :: NH = 7 ! Max # Herzberg X-sections that can be used - INTEGER, PARAMETER :: MX = 35 ! aerosol/cloud types supplied from CTM - INTEGER, parameter :: NB_MAX = LPAR_MAX+1 ! Added for GMI {AOO, 8/04} - INTEGER, parameter :: NC_MAX = 2*NB_MAX ! Added for GMI {AOO, 8/04} - -!----------------------------------------------------------------------- - INTEGER, PARAMETER :: NL = 1000 ! Max # levels after insertion of extra Mie levels - INTEGER, PARAMETER :: N__ = 2*NL ! # levels in Mie grid: 2*(2*lpar+2+jaddto(1))+3 - INTEGER, PARAMETER :: M__ = 4 ! #Gauss points used - - - end module GmiFastJX_ParametersMod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/README_JX.txt b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/README_JX.txt deleted file mode 100644 index 429538f3..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/README_JX.txt +++ /dev/null @@ -1,151 +0,0 @@ ------------------------------------------------ -Fast-JX Photolysis Code, V 2. (XZ & MP, 7/04) ------------------------------------------------ - -Fast-JX scheme is new: - it calculates photolysis rates in both troposphere AND stratosphere; - the new spectral data has been updated to JPL-02 and IUPAC(2004); - see notes on jx_spec_04a.dat. - -The main features of fast-J (troposphere, wvl > 291 nm) are combined with fast-J2 -(includes stratosphere, all J's to 60 km). The new fast-Jx now calculates short -wavelengths the same as long wavelengths: - 1) pseudo-spherical attenuation of the solar beam (curved atmos) - 2) multiple scattering in a plane parallel atmosphere - 3) full scattering phase function (+ 8-stream anisotropic) - 4) optimized wavelength bins: 7 bins 291-850 nm (troposphere) - +11 bins 180-291 nm (stratosphere) - -Fast-JX has been compared with the full 77-bin (145 bins counting S-Runge bins) -standard UCI photolysis code. Both for all altitudes (18 JX-bins to do 0-60 km) -and for the Fast-J version for troposphere (use last 7 bins to do 0-18 km). -This was done for SZA=0 and the US Std atmosphere. Agreement is within 3% over -all regions of relevance (e.g., J for CFCs only in stratosphere). -(The lowest level does not match, since Fast-JX reports the middle of that -level (~0.5 km) and the std code reports the surface (0 km), but all else -looks fine!). - -Features: - >>> the new fast-JX release can be used for troposphere only CTMs with the - same code and spectral dataset: select wavelength bins 12:18 in the - jx_spec.dat file, no other changes needed. - - > O3 climatology integrated rather than interpolated, to ensure - preservation of the supplied column. (An updated climatology needed) - - > Simplified level scheme to allow easy replacement of climatological - O3 and T with model-supplied values. - - > Supports scattering from more than one type of aerosol at once; - data file now includes phase functions for 14 types. - - > Finer tau-steps at cloud tops to improve accuracy at higher solar - zenith angles. - - > Alternate flux attenuation scheme using second-order finite - difference method - better for calculating heating rates. - - > Additional diagnostic routines and comments to aid in understanding - - -The current release comes in the form used in the UCI CTM, with a model framework -supplied so that the code can be run in "stand-alone" mode, with the parameters -set in 'cmn_h.t' and user controls in 'input' - both files contain additional -comments. The following files are required: - - Fast-JX bits: - - newcol.f Fast-JX CTM code - - jv_cmn.h Fast-JX include file - main variables and commons - jv_mie.h Fast-JX include file - Mie variables - - jx_spec.dat Fast-JX input - spectral data file - ************************************************************** - ***These are the new 2004 updates (designated 04b) to all the - *** cross-sections, including some IUPAC ones. see the notes - *** at the end of the table to calculate branching rates and - *** dissociation J's for NO3, acetone, MeVK. - ************************************************************** - - jv_atms.dat Fast-JX input - T and O3 climatology (dated, M&M-I data) - This file is not essential except to fill in above CTM levels, - you can write your own. - - ratj.d Specimen file for supplying photolysis reactions, - factors and labels - keyed to Wild etal's UCI CTM - ************************************************************** - ***this is extremely obscure and set for UCI's chem code - ***as enclosed it matches the jx_spec.dat cross-sections - *** and will print out all of them - ************************************************************** - - Model bits: - - standalone.f Fortran routine to simulate model environment; - sets up the spatial and temporal variables - - cmn_h.f Simulated header files 'included' in model code, - cmn_t.f and including documentation on the parameters - cmn_w.f and variables required - - input Control file for run - - Makefile/Run: - - Just compile standalone.f + newcol.f together and run. - - The standalone code will write the calculated photolysis rates at each - supplied model level to a file 'output', and write diagnostics and/or - climatologies to stdout (unit=6). - ------------------------------------------------------------- - 2004-b version cross-section notes for pratmo and fast-JX ------------------------------------------------------------- - -The x-section data have been revised using JPL-02, IUPAC (up to 2004) -and Gierczak's acetone tables. - -(1) The NO2 temperature dependence in JPL-02 and before appears to be in -error, producing large x-sections for colder temperatures - opposite to -that in the IUPAC tabulations. The systematic error is about 2%, smaller -than the JPL vs IUPAC recommendations at 298K (J-IUPAC > J-JPL by 5-7%). ->>>>have decided to use the JPL 298K values for ALL temperatures. - -(2) The wavelength-density dependence of the quantum yield for dissociation -of acetone (CH3C(O)CH3 aka C3H6O) is awkward. Have devised and tested -the new method of computing J at 1000 mbar and at 300 mbar and then -interpolating in log[M #/cm3]. The choice of 300 mbar was chosen to -minimize the error over the range 100-1000 mbar. See notes at end -of jx_spec.dat - -(3) MethylVinylKetone has a pressure dependent quantum yield, the cross -sections used are for the low density limit (M = 0) and the rational -polynomial formula is given in the jx_spec.dat notes. - -(4) NO3 cross-sections are combined into a total with fixed branching factors. - -(5) ClONO2 dissociation yields (Cl+NO3 vs. ClO+NO2) are very wavelength -dependent and change with large zenith angle (e.g., polar twilight), hence -the new method give x-sections for both branches separately. - -(6) HO2NO2 (aka HNO4) photolysis in the near IR at a 'daytime' clear-sky -rate of 1E-5 /sec has been added as a cross-section at the longest wavelength -(412-850 nm). This may overestimate the effects of Rayleigh and other -scattering: e.g., a clear-sky, 10% albedo enhancement is 1.3E-5. - -(7) Some of the original Harvard x-sections for methacrolein, glyoxal, -etc have been dropped, because I could not find back in the IUPAC or JPL -listings. Many of these are too slow to be important and should be dropped. -The methacrolein (MACR) is included, but has only a 'guesstimate' for the -quantum yield of about 0.008(??). - -(8) NEW cross-sections can be added easily as before. The key is to use -the fast-J2 bins (these are unchanged) and to generate x-sections by -averaging with solar-flux weighting. - ------------------------------------------------------------ - - Oliver Wild (29/07/99) - Huisheng Bian (29/08/02) - Michael Prather (Jul'04) \ No newline at end of file diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/fast_JX_control.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/fast_JX_control.F90 deleted file mode 100644 index 742e47a5..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/fast_JX_control.F90 +++ /dev/null @@ -1,262 +0,0 @@ - module fast_JX - - use GmiPrintError_mod, only : GmiPrintError - use GmiASCIIoperations_mod, only : AsciiOpenRead - USE GmiFastJX_ParametersMod - USE GmiFastJX_includeMod, ONLY : t_fastJXbundle - - implicit none - - private - public :: Control_Fast_JX - public :: InitializeFastJX - public :: GetQAA_RAAinFastJX - contains -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! Original code by Philip Cameron-Smith, LLNL -! (Adapted from standalone.f in Fast-J v3 distributed by Oliver Wild, UCI) -! cameronsmith1@llnl.gov -! Modifeid by A. Oloso, GSFC, 8/04, for Fast-JX v2 distributed by M. Prather, UCI, 7/04) -! -! FILE -! fast_JX_control.F -! -! ROUTINES -! Control_Fast_JX -! -! HISTORY -! - March 9, 2005 * Jules Kouatchou -! The variable "ozone_ij" is now an optional arguments. When it is available, -! the code uses the model climatology and the variable "do3" is set. -! The variables "ODAER_ij" and "ODMDUST_ij" were added as arguments. -! - May 25, 2016 * Luke Oman -! Now use Pressures on Edges instead of on Centers (fixed long-standing bug) -! -!============================================================================= - - -!----------------------------------------------------------------------------- -! -! ROUTINE -! Control_Fast_JX -! -! DESCRIPTION -! This routine acts as the interface between the GMI model and Fast-JX. -! -! ARGUMENTS -! -! INPUTS -! cross_section_file : X-Section quantum yield -! rate_file : Master rate file -! T_O3_climatology_file : T & O3 climatology -! k1 : first interface index [lpar = k2 - k1 + 1] -! k2 : last interface index [lpar = k2 - k1 + 1] -! chem_mask_khi : number of chemistry levels [jpnl] -! num_qjs : number of photolysis reactions [jppj] -! month_gmi : number of month (1- 12) [month] -! jday : day of year (1-365) [iday] -! time_sec : time of day in model (s, GMT) [tau (hrs)] -! fastj_offset_sec : offset from tau at which to do photolysis (s) -! [timej (hrs)] -! londeg_i : longitude (midpoint, deg) [xgrd (rad)] -! latdeg_j : latitude (midpoint, deg) [ygrd (rad), ydgrd (deg)] -! am : hybrid am levels (mid-point of level) [etaa = pt*am] -! pt : scale factor for am's [etaa = pt*am] -! bm : hybrid bm levels (mid-point of level) [etab] -! pctm_ij : surface pressure (mb) [p] -! kel_ij : temperature at box centers (degK) [t] -! optdepth_ij : optical depth in box (unitless) [od] -! surf_alb_ij : surface albedo (fraction 0-1) [sa] -! ODAER_ij : optical depth for aerosol -! ODMDUST_ij : optical depth for mineral dust -! ozone_ij : mixing ratio for ozone -! sza_ij : solar zenith angle -! OUTPUTS -! qjgmi_ij : jvalues at grid centers (s^-1?) [zpj] -! n_qj_O3_2OH : index of O3 -> O1d photolysis IF it is actually -! intended to be corrected to be O3 -> 2OH photolysis -! -!----------------------------------------------------------------------------- - - subroutine Control_Fast_JX & - & (JXbundle, k1, k2, chem_mask_khi, num_qjs, & - & month_gmi, jday, time_sec, fastj_offset_sec, sza_ij, & - & press3e_ij, pctm_ij, kel_ij, optdepth_ij, & - & surf_alb_ij, qjgmi_ij, overheadO3col_ij, & - & ODAER_ij, ODMDUST_ij, ozone_ij) - - - implicit none - -# include "gmi_AerDust_const.h" -# include "setkin_par.h" - -! ---------------------- -! Argument declarations. -! ---------------------- - integer, intent(in) :: k1 - integer, intent(in) :: k2 - integer, intent(in) :: chem_mask_khi - integer, intent(in) :: num_qjs - integer, intent(in) :: month_gmi - integer, intent(in) :: jday - real*8, intent(in) :: time_sec - real*8, intent(in) :: fastj_offset_sec - real*8, intent(in) :: sza_ij - real*8, intent(in) :: press3e_ij(k1:k2) - real*8, intent(in) :: pctm_ij - real*8, intent(in) :: kel_ij(k1:k2) - real*8, intent(in) :: optdepth_ij(k1:k2) - real*8, intent(in) :: surf_alb_ij - real*8, intent(out) :: overheadO3col_ij(k1:k2) - real*8, intent(out) :: qjgmi_ij(k1:chem_mask_khi, num_qjs) - real*8, intent(in) :: ODAER_ij(k1:k2,NSADaer*nrh_b) - real*8, intent(in) :: ODMDUST_ij(k1:k2,NSADdust) - real*8, intent(in), optional :: ozone_ij (k1:k2) - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle -! -! !LOCAL VARIABLES: - integer :: il, ik - real*8 :: pi - real*8 :: timej - real*8 :: amm(k1-1:k2) - real*8 :: bmm(k1-1:k2) - real*8 :: zpj(chem_mask_khi-k1+1, num_qjs) -!-------------------------------------------------------------------------- -!BOC - pi = 3.141592653589793d0 ! FLAG {PJC} - -! ------------------------------------------------- -! Set up Fast-JX variables from GMI variables {PJC}. -! ------------------------------------------------- - - if ( present(ozone_ij) ) then - JXbundle%do_model_clima = .true. - else - JXbundle%do_model_clima = .false. - endif - - JXbundle%month = month_gmi - JXbundle%iday = jday - JXbundle%tau = time_sec / 3600.0d0 ! convert to hours {PJC} - timej = fastj_offset_sec / 3600.0d0 ! convert to hours {PJC} - - JXbundle%pj(1) = pctm_ij - JXbundle%pj(2:JXbundle%NB) = press3e_ij(k1:k2) - JXbundle%pj(JXbundle%NB+1) = 0.0d0 - -! p (nslon, nslat) = pctm_ij - JXbundle%t (JXbundle%nslon, JXbundle%nslat, 1:JXbundle%lpar) = kel_ij (k1:k2) - JXbundle%od(JXbundle%nslon, JXbundle%nslat, 1:JXbundle%lpar) = optdepth_ij(k1:k2) - if (JXbundle%do_model_clima) then - JXbundle%do3(1:JXbundle%lpar) = ozone_ij(k1:k2) - endif - JXbundle%sa(JXbundle%nslon, JXbundle%nslat) = surf_alb_ij - - ! Aerosol OD profile [unitless] - !optaer(nslon, nslat, 1:lpar,:) = ODAER_ij(k1:k2,:) - JXbundle%optaer(1:JXbundle%lpar,:) = ODAER_ij(k1:k2,:) - - ! Mineral dust OD profile [unitless] - ! optdust(nslon, nslat, 1:lpar,:) =ODMDUST_ij(k1:k2,:) - JXbundle%optdust(1:JXbundle%lpar,:) =ODMDUST_ij(k1:k2,:) - - zpj(:,:) = -1.0d0 - -! -------------------------------------------------------------------- -! call main Fast-JX routine, which actually calculates photolysis rates. -! -------------------------------------------------------------------- - - JXbundle%sza = sza_ij ! Oloso added sza_ij 12/2010 - -! =========== - call Photo (JXbundle, zpj, timej) -! =========== - - qjgmi_ij(:,:) = zpj(:,:) - -!!!! -!!!! Overhead ozone column -!!!! - overheadO3col_ij = 0.0d0 - overheadO3col_ij(k2) = JXbundle%DO3(k2) - do il = k1, k2-1 - do ik = il+1, k2 - overheadO3col_ij(il) = overheadO3col_ij(il) + JXbundle%DO3(ik) - end do - end do - - return - - end subroutine Control_Fast_JX - -!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! - - subroutine InitializeFastJX (JXbundle, & - cross_section_file,rate_file, T_O3_climatology_file, & - & rootProc,n_qj_O3_2OH, num_qjs, chem_mask_khi, k2, k1) - - implicit none - - integer :: n_qj_O3_2OH, num_qjs, chem_mask_khi, k2, k1 - character (len=128), intent(in) :: cross_section_file - character (len=128), intent(in) :: rate_file - character (len=128), intent(in) :: T_O3_climatology_file - logical, intent(in) :: rootProc - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - JXbundle%nslat = 1 - JXbundle%nslon = 1 - -! ------------------------- -! Set up Fast-JX dimensions. -! ------------------------- - - JXbundle%lpar = k2 - k1 + 1 - - JXbundle%jpnl = chem_mask_khi - JXbundle%jppj = num_qjs - - JXbundle%nb = JXbundle%lpar + 1 - JXbundle%nc = 2 * JXbundle%nb - -! ---------------------------------------- -! Initial call to Fast-JX to set things up. -! ---------------------------------------- -! =========== - call Inphot & -! =========== - & (JXbundle, rootProc,cross_section_file,rate_file, & - & T_O3_climatology_file, n_qj_O3_2OH) - - return - - end subroutine InitializeFastJX - -!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! - - subroutine GetQAA_RAAinFastJX (JXbundle, bRAA, bQAA) - -! USE GmiFastJX_includeMod, ONLY : RAA, QAA - - implicit none - - real*8 , intent(out) :: bRAA(:,:), bQAA(:,:) - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - bRAA(:,:) = JXbundle%RAA(:,:) - bQAA(:,:) = JXbundle%QAA(:,:) - - return - - end subroutine GetQAA_RAAinFastJX - -!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! - -# include "newcol.code" - - end module fast_JX diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/newcol.code b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/newcol.code deleted file mode 100644 index 41cd17ce..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX/newcol.code +++ /dev/null @@ -1,2220 +0,0 @@ -!---(pphot.f)-------generic CTM shell from UCIrvine (p-code 5.0, 7/04) -! -!---------Oliver Wild (7/99,troposphere), Huisheng Bian (8/02,stratosphere) -!---------PPHOT calculates photolysis rates with the Fast-J2 scheme -!---------subroutines: inphot, photoj, Fast-J2 schemes... -! -!--------- updated MP 7/04 to fast-JX -!--------- make pseudo-spherical scattering for all wvl -!--------- correct J(O3P) and add new press dep J's -!--------- Modified for GMI, Amidu Oloso (9/04) -!----------------------------------------------------------------------- -! - subroutine inphot(JXbundle, rootProc,cross_section_file, rate_file, & - & T_O3_climatology_file, n_qj_O3_2OH) - -!----------------------------------------------------------------------- -! Routine to initialise photolysis rate data, called directly from the -! cinit routine in ASAD. Currently use it to read the JPL spectral data -! and standard O3 and T profiles and to set the appropriate reaction index. -!----------------------------------------------------------------------- -! -! iph Channel number for reading all data files -! rad Radius of Earth (cm) -! zzht Effective scale height above top of atmosphere (cm) -! dtaumax Maximum opt.depth above which a new level should be inserted -! dtausub No. of opt.depths at top of cloud requiring subdivision -! dsubdiv Number of additional levels to add at top of cloud -! szamax Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - - logical, intent(in) :: rootProc - character (len=128),intent(in) :: cross_section_file ! Added for GMI {AOO, 10/04} - character (len=128),intent(in) :: rate_file ! Added for GMI {AOO, 10/04} - character (len=128),intent(in) :: T_O3_climatology_file ! Added for GMI {AOO, 10/04} - integer, intent(out) :: n_qj_O3_2OH ! Added for GMI {AOO, 8/04} - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - -! character (len=128) :: filnam - integer iph -! -! Use channel 8 to read files at the moment -! iph=8 -! -! Defaults & constants - JXbundle%RAD = 6375.d5 - JXbundle%ZZHT = 5.d5 -! -! Calculate new levels if tau exceeds DTAUMAX - JXbundle%dtaumax = 1.d0 -! Add dsubdiv additional levels in first dtausub of cloud - JXbundle%dtausub = 1.0d0 - JXbundle%dsubdiv = 10.d0 -! -! Maximum Zenith Angle (98 degrees at 63 km; 99 degrees at 80 km) - JXbundle%szamax = 98.0d0 -! -! Read in labels of photolysis rates required - call Rd_Js (JXbundle, iph, rate_file, n_qj_O3_2OH) -! -! Read in JPL spectral data set - call Rd_Tjpl (JXbundle, rootProc, iph, cross_section_file) -! -! Read in T & O3 climatology - call Rd_Prof (JXbundle, iph, T_O3_climatology_file) -! -! Select Aerosol/Cloud types to be used - call SET_AER(JXbundle) -! - return - end subroutine inphot - - subroutine rd_Js(JXbundle, nj1,namfil, n_qj_O3_2OH) -!----------------------------------------------------------------------- -! Reread the ratj.d file to map photolysis rate to reaction -! Read in quantum yield 'jfacta' and fastj2 label 'jlabel' -!----------------------------------------------------------------------- -! -! jfacta Quantum yield (or multiplication factor) for photolysis -! jlabel Reference label identifying appropriate J-value to use -! ipr Photolysis reaction counter - should total 'jppj' -! -!----------------------------------------------------------------------- - -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" -! - integer nj1, ipr - integer :: n_qj_O3_2OH ! Added for GMI {AOO, 8/04} -!c integer i ! Only used for diagnostics {AOO, 8/04} -!c character*6 namfil - character (len=128) :: namfil - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - character*120 cline -! -! Reread the ratj.d file to map photolysis rate to reaction -! Read in quantum yield jfacta and fastj2 label jlabel - ipr=0 - n_qj_O3_2OH = 0 -! open(nj1,file=namfil,status='old',form='formatted') - call AsciiOpenRead (nj1,namfil) - 10 read(nj1,'(a)',err=20) cline - if(cline(2:5).eq.'9999') then - go to 20 - elseif(cline(1:1).eq.'#') then - go to 10 - elseif(cline(5:5).eq.'$') then - go to 10 - else - ipr=ipr+1 - read(cline(79:83),'(f5.1)') JXbundle%jfacta(ipr) - read(cline(86:92),'(a7)') JXbundle%jlabel(ipr) - JXbundle%jfacta(ipr)=JXbundle%jfacta(ipr)/100.d0 - if ( JXbundle%jlabel(ipr) == "O3_1dOH" ) then ! Added for GMI {AOO, 8/04} - JXbundle%jlabel(ipr) = "O3(1D)" ! Catch O3 -> O1d for later - n_qj_O3_2OH = ipr ! Correction to provide - endif ! Effective J for O3 -> 2OH. - if ( JXbundle%jlabel(ipr) == "C3H6O" ) then ! Added for GMI {AOO, 8/04} - JXbundle%jlabel(ipr) = "C3H6Ot" ! Added for GMI {AOO, 8/04} - endif ! Added for GMI {AOO, 8/04} - go to 10 - endif - 20 close(nj1) - if(ipr.ne.JXbundle%jppj) then - write(6,1000) ipr,JXbundle%jppj - STOP "Fast_JX" - endif -! - 1000 format(' Error: ',i3,' photolysis labels but ',i3,' reactions') - return - - end subroutine rd_Js - - - subroutine photo(JXbundle, zpj,timej) -!----------------------------------------------------------------------- -!----jv_trop.f: new FAST J/J2-Value code, troposphere only (mjprather 6/96) -!---- uses special wavelength quadrature spectral data (j2_spec.dat) -!--- that includes only 289 nm - 800 nm (later a single 205 nm add-on) -!--- uses special compact Mie code based on Feautrier/Auer/Prather vers. -!----------------------------------------------------------------------- -! -! zpj External array providing J-values to main CTM code -! timej Offset in hours from start of timestep to time J-values -! required for - take as half timestep for mid-step Js. -! solf Solar distance factor, for scaling; normally given by: -! 1.0-(0.034*cos(real(iday-186)*2.0*pi/365.)) -! -!----------basic common blocks:----------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_jv_cmn.h" -# include "gmi_phys_constants.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - real*8 zpj(JXbundle%jpnl,JXbundle%jppj),timej,solf - integer i,j,K -!----------------------------------------------------------------------- -! - do i=1,JXbundle%jpnl - do j=1,JXbundle%jppj - JXbundle%zj(i,j)=0.D0 - zpj(i,j)=0.D0 - enddo - enddo -! -!---Calculate new solar zenith angle - call SOLAR2(JXbundle, timej) - if(JXbundle%SZA.gt.JXbundle%szamax) go to 10 -! -!---Set up profiles on model levels - call SET_PROF(JXbundle) -! -!---Print out atmosphere -!AOO call PRTATM(3) -! -!----------------------------------------------------------------------- - call JVALUE(JXbundle) -!----------------------------------------------------------------------- -!---Print solar flux terms - -!aoo write(6,'(a5,18i9)') ' bin:',(K, K=JXbundle%NW1,JXbundle%NW2) -!aoo write(6,'(a5,18f9.2)') ' wvl:',(WL(K), K=JXbundle%NW1,JXbundle%NW2) -!aoo do J=JPNL,1,-1 -!aoo write(6,'(i3,2x,18f9.6)') J, (FFF(K,J)/FL(K),K=JXbundle%NW1,JXbundle%NW2) -!aoo enddo - -! -!---Include variation in distance to sun - solf=1.d0-(0.034d0*cos(dble(JXbundle%iday-186)*2.d0*GMI_PI/365.d0)) -!aoo solf=1.d0 -!----------------------------------------------------------------------- - call JRATET(JXbundle, solf) -!----------------------------------------------------------------------- -! -! "zj" updated in JRATET - pass this back to ASAD as "zpj" - do i=1,JXbundle%jpnl - do j=1,JXbundle%jppj - zpj(i,j)= JXbundle%zj(i,j) - enddo - enddo -!c write(6,'(2(1x,i2),10(1pe10.3))') nslon,nslat,(JXbundle%zj(i,1),i=1,jpnl) -! -!---Output selected values - 10 if((.not.ldeg45.and.JXbundle%nslon.eq.37.and.JXbundle%nslat.eq.36).or. & - & (ldeg45.and.JXbundle%nslon.eq.19.and.JXbundle%nslat.eq.18)) then - i=min(JXbundle%jppj,8) -! write(6,1000) iday, tau+timej, sza, jlabel(i), zpj(1,i) - endif -! - return - 1000 format(' Photolysis on day ',i4,' at ',f4.1,' hrs: SZA = ',f7.3, & - & ' J',a7,'= ',1pE10.3) - end subroutine photo - - - subroutine set_prof (JXbundle) -!----------------------------------------------------------------------- -! Routine to set up atmospheric profiles required by Fast-J2 using a -! doubled version of the level scheme used in the CTM. First pressure -! and z* altitude are defined, then O3 and T are taken from the supplied -! climatology and integrated to the CTM levels (may be overwritten with -! values directly from the CTM, if desired) and then black carbon and -! aerosol profiles are constructed. -! Oliver (04/07/99) -! -! HISTORY -! March 4, 2005 - Jules Kouatchou -! Added the include file "gmi_AerDust_const.h" and "setkin_par.h". -! Modified the section on "Add Aerosol Column". -!----------------------------------------------------------------------- -! -! pj Pressure at boundaries of model levels (hPa) -! z Altitude of boundaries of model levels (cm) -! odcol Optical depth at each model level -! masfac Conversion factor for pressure to column density -! -! TJ Temperature profile on model grid -! DM Air column for each model level (molecules.cm-2) -! DO3 Ozone column for each model level (molecules.cm-2) -! DBC Mass of Black Carbon at each model level (g.cm-3) ! .....! -! PSTD Approximate pressures of levels for supplied climatology -! -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_w.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_jv_cmn.h" - - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer i, k, l, m, N - real*8 odcol(JXbundle%lpar),dlogp,f0,t0,b0,pb,pc,xc,masfac,scaleh - real*8 pstd(52),oref2(51),tref2(51),bref2(51) - -! Set up cloud and surface properties - call CLDSRF(JXbundle, odcol) -! -! Set up pressure levels for O3/T climatology - assume that value -! given for each 2 km z* level applies from 1 km below to 1 km above, -! so select pressures at these boundaries. Surface level values at -! 1000 mb are assumed to extend down to the actual P(nslon,nslat). -! - pstd(1) = max(JXbundle%pj(1),1000.d0) - pstd(2) = 1000.d0*10.d0**(-1.d0/16.d0) - dlogp = 10.d0**(-2.d0/16.d0) - do i=3,51 - pstd(i) = pstd(i-1)*dlogp - enddo - pstd(52) = 0.d0 -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - masfac=100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) -! -! Select appropriate monthly and latitudinal profiles - m = max(1,min(12,JXbundle%month)) - l = max(1,min(18,(int(JXbundle%ydgrd(JXbundle%nslat))+99)/10)) -! - -! Temporary arrays for climatology data - do i=1,51 -!AOO use T and O3 from model oref2(i)=oref(i,l,m) -!AOO use T and O3 from model tref2(i)=tref(i,l,m) - if (.not. JXbundle%do_model_clima) then - oref2(i)=JXbundle%oref(i,l,m) - tref2(i)=JXbundle%tref(i,l,m) - endif - bref2(i)=JXbundle%bref(i) - enddo -! -! Apportion O3 and T on supplied climatology z* levels onto CTM levels -! with mass (pressure) weighting, assuming constant mixing ratio and -! temperature half a layer on either side of the point supplied. -! - - do i = 1,JXbundle%NB -!AOO use T and O3 from model F0 = 0.d0 -!AOO use T and O3 from model T0 = 0.d0 - if (.not. JXbundle%do_model_clima) then - F0 = 0.d0 - T0 = 0.d0 - endif - B0 = 0.d0 - do k = 1,51 - PC = min(JXbundle%pj(i),pstd(k)) - PB = max(JXbundle%pj(i+1),pstd(k+1)) - if(PC.gt.PB) then - XC = (PC-PB)/(JXbundle%pj(i)-JXbundle%pj(i+1)) -!AOO use T and O3 from model F0 = F0 + oref2(k)*XC -!AOO use T and O3 from model T0 = T0 + tref2(k)*XC - if (.not. JXbundle%do_model_clima) then - F0 = F0 + oref2(k)*XC - T0 = T0 + tref2(k)*XC - endif - B0 = B0 + bref2(k)*XC - endif - enddo -!AOO use T and O3 from model TJ(i) = T0 -!AOO use T and O3 from model DO3(i)= F0*1.d-6 - if (.not. JXbundle%do_model_clima) then - JXbundle%TJ(i) = T0 - JXbundle%DO3(i)= F0*1.d-6 - endif - JXbundle%DBC(i)= B0 - enddo -! -! Insert model values here to replace or supplement climatology. -! Note that CTM temperature is always used in x-section calculations -! (see JRATET); TJ is used in actinic flux calculation only. - -! do I = 1,NB -! write(6,*) I,PJ(I),TJ(I),DO3(I) -! enddo - -! - if (JXbundle%do_model_clima) then - do i=1,JXbundle%lpar -!AOO set in fast_JX_control DO3(i) = my_ozone(i) ! Mole fraction Mixing Ratio - JXbundle%TJ(i) = JXbundle%T(JXbundle%nslon,JXbundle%nslat,I) ! Kelvin - enddo - JXbundle%DO3(JXbundle%lpar+1) = JXbundle%DO3(JXbundle%lpar) ! Above top of model (or use climatology) - JXbundle%TJ(JXbundle%lpar+1) = JXbundle%T(JXbundle%nslon,JXbundle%nslat,JXbundle%lpar) ! Above top of model (or use climatology) -! DO3(lpar+1) = my_ozone*exp() ! Above top of model (or use climatology) -! TJ(lpar+1) = my_temp(lpar) ! Above top of model (or use climatology) - end if -! -! -! Calculate effective altitudes using scale height at each level - JXbundle%z(1) = 0.d0 - do i=1,JXbundle%lpar - scaleh=1.3806d-19*masfac*JXbundle%TJ(i) - JXbundle%z(i+1) = JXbundle%z(i)-(log(JXbundle%pj(i+1)/JXbundle%pj(i))*scaleh) - enddo -! -! Add Aerosol Column - include aerosol types here. Currently use soot -! water and ice; assume black carbon x-section of 10 m2/g, independent -! of wavelength; assume limiting temperature for ice of -40 deg C. -! -!!!! -!Beg: Bryan & Jules -!!!! - do i=1,JXbundle%lpar - JXbundle%AER(1,i) = JXbundle%DBC(i)*10.d0*(JXbundle%z(i+1)-JXbundle%z(i)) - - ! Turn off uniform black carbon profile (rvm, bmy, 2/27/02) - JXbundle%AER(1,I) = 0D0 - - if(JXbundle%T(JXbundle%nslon,JXbundle%nslat,I).gt.233.d0) then - JXbundle%AER(2,i) = odcol(i) - JXbundle%AER(3,i) = 0.d0 - else - JXbundle%AER(2,i) = 0.d0 - JXbundle%AER(3,i) = odcol(i) - endif - - ! Also add in aerosol optical depth columns (rvm, bmy, 9/30/00) - DO N = 1, NSADdust - JXbundle%AER(3+N,I) = JXbundle%OPTDUST(I,N) - ENDDO - - ! Also add in other aerosol optical depth columns (rvm, bmy, 2/27/02) - DO N = 1, NSADaer*NRH_b - JXbundle%AER(3+N+NSADdust,I) = JXbundle%OPTAER(I,N) - ENDDO - - enddo - - do k=1,MX - JXbundle%AER(k,JXbundle%lpar+1) = 0.d0 - enddo -!!!! -!End: Bryan & Jules -!!!! -! -! Calculate column quantities for Fast-J2 - do i=1,JXbundle%NB - JXbundle%DM(i) = (JXbundle%PJ(i)-JXbundle%PJ(i+1))*masfac - JXbundle%DO3(i) = JXbundle%DO3(i)*JXbundle%DM(i) - enddo -! - return - end subroutine set_prof - - - subroutine CLDSRF(JXbundle, odcol) -!----------------------------------------------------------------------- -! Routine to set cloud and surface properties -!----------------------------------------------------------------------- -! rflect Surface albedo (Lambertian) -! odmax Maximum allowed optical depth, above which they are scaled -! odcol Optical depth at each model level -! odsum Column optical depth -! nlbatm Level of lower photolysis boundary - usually surface -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_cmn_w.h" -!# include "fast_JX_jv_cmn.h" - integer i, j, k - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - real*8 odcol(JXbundle%lpar), odsum, odmax, odtot - -! -! Default lower photolysis boundary as bottom of level 1 - JXbundle%nlbatm = 1 -! -! Set surface albedo - JXbundle%RFLECT = dble(JXbundle%SA(JXbundle%nslon,JXbundle%nslat)) - JXbundle%RFLECT = max(0.d0,min(1.d0,JXbundle%RFLECT)) -! -! Zero aerosol column - do k=1,MX - do i=1,JXbundle%NB - JXbundle%AER(k,i) = 0.d0 - enddo - enddo -! -! Scale optical depths as appropriate - limit column to 'odmax' - odmax = 200.0d0 - odsum = 0.0d0 -! print *, "HERE HERE HERE ", odsum, lpar - do i=1,JXbundle%lpar -! odcol(i) = dble(OD(nslon,nslat,i)) - odcol(i) = JXbundle%OD(JXbundle%nslon,JXbundle%nslat,i) - odsum = odsum + odcol(i) - enddo - if(odsum.gt.odmax) then - odsum = odmax/odsum - do i=1,JXbundle%lpar - odcol(i) = odcol(i)*odsum - enddo - odsum = odmax - endif -! -! Use clear-sky conditions -! do i=1,jpnl -! odcol(i)=0.d0 -! enddo -! -! Set sub-division switch if appropriate - odtot=0.d0 - JXbundle%jadsub(JXbundle%nb)=0 - JXbundle%jadsub(JXbundle%nb-1)=0 - do i=JXbundle%nb-1,1,-1 - k=2*i - JXbundle%jadsub(k)=0 - JXbundle%jadsub(k-1)=0 - odtot=odtot+odcol(i) - if(odcol(i).gt.0.d0.and.JXbundle%dtausub.gt.0.d0) then - if(odtot.le.JXbundle%dtausub) then - JXbundle%jadsub(k)=1 - JXbundle%jadsub(k-1)=1 - elseif(odtot.gt.JXbundle%dtausub) then - JXbundle%jadsub(k)=1 - JXbundle%jadsub(k-1)=0 - do j=1,2*(i-1) - JXbundle%jadsub(j)=0 - enddo - go to 20 - endif - endif - enddo - 20 continue -! - return - end subroutine CLDSRF - - - subroutine solar2(JXbundle, timej) -!----------------------------------------------------------------------- -! Routine to set up SZA for given lat, lon and time -!----------------------------------------------------------------------- -! timej Offset in hours from start of timestep to time J-values -! required for - take as half timestep for mid-step Js. -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - real*8 pi, pi180, loct, timej - real*8 sindec, soldek, cosdec, sinlat, sollat, coslat, cosz -! - pi=3.141592653589793D0 - pi180=pi/180.d0 -! sindec=0.3978d0*sin(0.9863d0*(dble(iday)-80.d0)*pi180) -! soldek=asin(sindec) -! cosdec=cos(soldek) -! sinlat=sin(ygrd(nslat)) -! sollat=asin(sinlat) -! coslat=cos(sollat) -!! -! loct = (((tau+timej)*15.d0)-180.d0)*pi180 + xgrd(nslon) -! cosz = cosdec*coslat*cos(loct) + sindec*sinlat -! sza = acos(cosz)/pi180 - - JXbundle%U0 = cos(JXbundle%SZA*pi180) -! - return - end subroutine solar2 - - - subroutine rd_prof(JXbundle, nj2,namfil) -!----------------------------------------------------------------------- -! Routine to input T and O3 reference profiles -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer ia, i, m, l, lat, mon, ntlats, ntmons, n216, nj2 - real*8 ofac,ofak -!c character*11 namfil - character (len=128) :: namfil -! -!c open(NJ2,file=namfil) - call AsciiOpenRead (NJ2, namfil) - read(NJ2,'(A)') JXbundle%TITLE0 -! write(6,'(1X,A)') JXbundle%TITLE0 - read(NJ2,'(2I5)') NTLATS,NTMONS -! write(6,1000) NTLATS,NTMONS - N216 = MIN0(216, NTLATS*NTMONS) - do IA=1,N216 - read(NJ2,'(1X,I3,3X,I2)') LAT, MON - M = MIN(12, MAX(1, MON)) - L = MIN(18, MAX(1, (LAT+95)/10)) - read(NJ2,'(3X,11F7.1)') (JXbundle%TREF(I,L,M), I=1,41) - read(NJ2,'(3X,11F7.4)') (JXbundle%OREF(I,L,M), I=1,31) - enddo - close(NJ2) -! -! Extend climatology to 100 km - ofac=exp(-2.d5/JXbundle%ZZHT) - do i=32,51 - ofak=ofac**(i-31) - do m=1,ntmons - do l=1,ntlats - JXbundle%oref(i,l,m)=JXbundle%oref(31,l,m)*ofak - enddo - enddo - enddo - do l=1,ntlats - do m=1,ntmons - do i=42,51 - JXbundle%tref(i,l,m)=JXbundle%tref(41,l,m) - enddo - enddo - enddo -! - - return -! 1000 format(1x,'Data: ',i3,' Lats x ',i2,' Months') - end subroutine rd_prof - - - subroutine set_aer(JXbundle) -!----------------------------------------------------------------------- -! Set aerosol/cloud types and define black carbon profile -!----------------------------------------------------------------------- -! MX Number of different types of aerosol to be considered -! MIEDX Index of aerosol types in j2_spec.dat - hardwire in here -! -! HISTORY -! January 5, 2004 - Jules Kouatchou -! Added more values to the array MIEDX (index 4 to 35) -! -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer i -! -! Initialise aerosol index - do i=1,MX - JXbundle%MIEDX(i) = 0 - enddo -! -! Select Aerosol/Cloud types to be used - define types here - JXbundle%MIEDX(1) = 3 ! Black carbon absorber - JXbundle%MIEDX(2) = 10 ! Water Cloud (Deirmenjian 8 micron) - JXbundle%MIEDX(3) = 14 ! Irregular Ice Cloud (Mishchenko) -!!!! -!Beg: Bryan & Jules -!!!! - JXbundle%MIEDX(4) = 15 ! Mineral Dust .15 micron (rvm, 9/30/00) - JXbundle%MIEDX(5) = 16 ! Mineral Dust .25 micron (rvm, 9/30/00) - JXbundle%MIEDX(6) = 17 ! Mineral Dust .4 micron (rvm, 9/30/00) - JXbundle%MIEDX(7) = 18 ! Mineral Dust .8 micron (rvm, 9/30/00) - JXbundle%MIEDX(8) = 19 ! Mineral Dust 1.5 micron (rvm, 9/30/00) - JXbundle%MIEDX(9) = 20 ! Mineral Dust 2.5 micron (rvm, 9/30/00) - JXbundle%MIEDX(10) = 21 ! Mineral Dust 4.0 micron (rvm, 9/30/00) - JXbundle%MIEDX(11) = 22 ! Tropospheric Sulfate, RH=0 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(12) = 23 ! Tropospheric Sulfate, RH=50 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(13) = 24 ! Tropospheric Sulfate, RH=70 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(14) = 25 ! Tropospheric Sulfate, RH=80 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(15) = 26 ! Tropospheric Sulfate, RH=90 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(16) = 29 ! Black Carbon, RH=0 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(17) = 30 ! Black Carbon, RH=50 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(18) = 31 ! Black Carbon, RH=70 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(19) = 32 ! Black Carbon, RH=80 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(20) = 33 ! Black Carbon, RH=90 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(21) = 36 ! Organic Carbon, RH=0 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(22) = 37 ! Organic Carbon, RH=50 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(23) = 38 ! Organic Carbon, RH=70 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(24) = 39 ! Organic Carbon, RH=80 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(25) = 40 ! Organic Carbon, RH=90 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(26) = 43 ! Sea Salt (accum), RH=0 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(27) = 44 ! Sea Salt (accum), RH=50 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(28) = 45 ! Sea Salt (accum), RH=70 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(29) = 46 ! Sea Salt (accum), RH=80 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(30) = 47 ! Sea Salt (accum), RH=90 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(31) = 50 ! Sea Salt (coarse), RH=0 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(32) = 51 ! Sea Salt (coarse), RH=50 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(33) = 52 ! Sea Salt (coarse), RH=70 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(34) = 53 ! Sea Salt (coarse), RH=80 (rvm, bmy, 2/27/02) - JXbundle%MIEDX(35) = 54 ! Sea Salt (coarse), RH=90 (rvm, bmy, 2/27/02) -!!!! -!End: Bryan & Jules -!!!! -! -! Ensure all 'MX' types are valid selections - do i=1,MX -! write(6,1000) JXbundle%MIEDX(i),JXbundle%TITLEA(JXbundle%MIEDX(i)) - if(JXbundle%MIEDX(i).gt.JXbundle%NAA.or.JXbundle%MIEDX(i).le.0) then -! write(6,1200) JXbundle%MIEDX(i),JXbundle%NAA - STOP "Fast_JX" - endif - enddo -! -! Approximate Black Carbon up to 10 km; surface 200 ng/m3 (Liousse et al) -! Scale: 1 ng/m3 = 1.0d-15 g/cm3 (1.0d-11 g/m2/cm as BREF is in cm)) -! -! Simple place-holder profile - do i=1,51 - JXbundle%BREF(i)=10.d0*1.0d-11 - if(i.gt.6) JXbundle%BREF(i)=0.d0 - enddo -! - return - 1000 format('Using Aerosol type: ',i2,1x,a) - 1200 format('Aerosol type ',i1,' unsuitable; supplied values must be ', & - & 'between 1 and ',i1) - end subroutine set_aer - - - subroutine JRATET(JXbundle, SOLF) -!----------------------------------------------------------------------- -! Calculate and print J-values. Note that the loop in this routine -! only covers the jpnl levels actually needed by the CTM. -!----------------------------------------------------------------------- -! -! FFF Actinic flux at each level for each wavelength bin -! QQQ Cross sections for species (read in in RD_TJPL) -! SOLF Solar distance factor, for scaling; normally given by: -! 1.0-(0.034*cos(real(iday-186)*2.0*pi/365.)) -! Assumes aphelion day 186, perihelion day 3. -! TQQ Temperatures at which QQQ cross sections supplied -! -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_cmn_w.h" -!# include "fast_JX_jv_cmn.h" -!# include "gmi_phys_constants.h" - - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer i, j, k - real*8 qo2tot, qo3tot, qo31d, qo33p, qqqt -!AOO real*8 xseco2, xseco3, xsec1d, solf, tfact - real*8 solf, tfact, PP, DD - real*8 VACET_trop,VACET_stra, FRACT -! - do I=1,JXbundle%jpnl - PP = (JXbundle%PJ(I)+JXbundle%PJ(I+1))*0.5d0 - if (I.eq.1) PP = JXbundle%PJ(1) - DD = 7.24e18*PP/JXbundle%T(JXbundle%nslon,JXbundle%nslat,I) - JXbundle%VALJ(1) = 0.d0 - JXbundle%VALJ(2) = 0.d0 - JXbundle%VALJ(3) = 0.d0 - do K=JXbundle%NW1,JXbundle%NW2 ! Using model 'T's here - QO2TOT= XSECO2(JXbundle, K,dble(JXbundle%T(JXbundle%nslon,JXbundle%nslat,I))) - JXbundle%VALJ(1) = JXbundle%VALJ(1) + QO2TOT*JXbundle%FFF(K,I) - QO3TOT= XSECO3(JXbundle, K,dble(JXbundle%T(JXbundle%nslon,JXbundle%nslat,I))) - QO31D = XSEC1D(JXbundle, K,dble(JXbundle%T(JXbundle%nslon,JXbundle%nslat,I)))*QO3TOT -!cc -!cc ***NB*** original fast-J/2 code had VALJ(2) as J[O3 -> O(3P)+O2] -!cc which is different from std pratmo code - fixed 7/04 MP -!cc QO33P = QO3TOT - QO31D - JXbundle%VALJ(2) = JXbundle%VALJ(2) + QO3TOT*JXbundle%FFF(K,I) - JXbundle%VALJ(3) = JXbundle%VALJ(3) + QO31D*JXbundle%FFF(K,I) - enddo - JXbundle%VALJ(2) = JXbundle%VALJ(2) - JXbundle%VALJ(3) !AOO for GMI per the above comment - -!------Calculate remaining J-values with T-dep X-sections - do J=4,JXbundle%NJVAL - JXbundle%VALJ(J) = 0.d0 - TFACT = 0.d0 - if(JXbundle%TQQ(2,J).gt.JXbundle%TQQ(1,J)) TFACT = max(0.d0,min(1.d0, & - & (JXbundle%T(JXbundle%nslon,JXbundle%nslat,I)-JXbundle%TQQ(1,J))/(JXbundle%TQQ(2,J)-JXbundle%TQQ(1,J)) )) - do K=JXbundle%NW1,JXbundle%NW2 - QQQT = JXbundle%QQQ(K,1,J-3) + (JXbundle%QQQ(K,2,J-3) - JXbundle%QQQ(K,1,J-3))*TFACT - JXbundle%VALJ(J) = JXbundle%VALJ(J) + QQQT*JXbundle%FFF(K,I) - enddo - if(J.eq.JXbundle%ncat_acetone_trop)VACET_trop =JXbundle%VALJ(J) ! Added for GMI {AOO 8/04} - if(J.eq.JXbundle%ncat_acetone_stra)VACET_stra =JXbundle%VALJ(J) ! Added for GMI {AOO 8/04} - if(J.eq.JXbundle%ncat_met_vinyl_ketone)JXbundle%VALJ(J)=JXbundle%VALJ(J)/(1.0+1.67e-19*DD) ! Added for GMI {AOO 8/04} - if(J.eq.JXbundle%ncat_met_ethyl_ketone)JXbundle%VALJ(J)=JXbundle%VALJ(J)/(1.0+0.80e-19*DD) ! Added for GMI {AOO 8/04} - if(J.eq.JXbundle%ncat_methyl_glyoxal)JXbundle%VALJ(J) =JXbundle%VALJ(J)/(1.0+1.66e-19*DD) ! Added for GMI {AOO 8/04} - enddo -!---last 2 J's need density-adjusted quantum yields: -!---NB acetone(C3H6O) uses 0.3 & 1.0 atm J's to interpolate from 0.1 to 1.0 atm -!cc FRACT = min(1.0, max(0.0, 19.4014-log10(DM(J)) )) -!cc VC3H6O(J) = VACET1(J) + (VACET3(J)-VACET1(J))*FRACT*1.9125 - FRACT = min(1.0, max(0.0, 19.4014-log10(DD) )) - JXbundle%VALJ(JXbundle%ncat_acetone_trop)=VACET_trop + & - & (VACET_stra - VACET_trop)*FRACT*1.9125 -!---methylvinylketone J1 calculated for zero density, scale by [M] -!cc VMEVK(J) = VMEVK1(J)/(1.0 + 1.67e-19*DM(J)) -!--- - do j=1,JXbundle%jppj - JXbundle%zj(i,j)=JXbundle%VALJ(JXbundle%jind(j))*JXbundle%jfacta(j)*SOLF - enddo -! print *, "HERE HERE 1 ", VALJ -!c write(6,'(I5,1P,7E10.3/(5X,7E10.3))') I, (VALJ(J), J=1,JXbundle%NJVAL) -! write(6,'(I5,1P,4E10.3)') I, VALJ(2),VALJ(3),VALJ(25),VALJ(27) - enddo - return - end subroutine JRATET - - - subroutine RD_TJPL(JXbundle, rootProc,NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Read in wavelength bins, solar fluxes, Rayleigh parameters, temperature- -! dependent cross sections and Rayleigh/aerosol scattering phase functions -! with temperature dependences. Current data originates from JPL'97 -!----------------------------------------------------------------------- -! -! NAMFIL Name of spectral data file (j2_spec.dat) >> j2 for fast-J2 -! NJ1 Channel number for reading data file -! NJVAL Number of species to calculate J-values for -! NWWW Number of wavelength bins, from NW1:NW2 -! WBIN Boundaries of wavelength bins -! WL Centres of wavelength bins - 'effective wavelength' -! FL Solar flux incident on top of atmosphere (cm-2.s-1) -! QRAYL Rayleigh parameters (effective cross-section) (cm2) -! QBC Black Carbon absorption extinct. (specific cross-sect.) (m2/g) -! QO2 O2 cross-sections -! QO3 O3 cross-sections -! Q1D O3 => O(1D) quantum yield -! TQQ Temperature for supplied cross sections -! QQQ Supplied cross sections in each wavelength bin (cm2) -! NAA Number of categories for scattering phase functions -! QAA Aerosol scattering phase functions -! NK Number of wavelengths at which functions supplied (set as 4) -! WAA Wavelengths for the NK supplied phase functions -! PAA Phase function: first 8 terms of expansion -! RAA Effective radius associated with aerosol type -! SSA Single scattering albedo -! -! npdep Number of pressure dependencies -! zpdep Pressure dependencies by wavelength bin -! jpdep Index of cross sections requiring pressure dependence -! lpdep Label for pressure dependence -! -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - logical, intent(in) :: rootProc - integer i, j, k, iw, nk, nqqq, nwww, nj1 -!AOO character*7 lpdep(3) -!c character*11 NAMFIL - character (len=128) namfil - do J=1,NS - do K=1,3 - JXbundle%TQQ(K,J) = 0.d0 - enddo - enddo -!-------------spectral data--------------------------------------------- -!c open(NJ1, FILE=NAMFIL) - call AsciiOpenRead (NJ1, NAMFIL) - read(NJ1,'(A)') JXbundle%TITLE0 -! write(6,'(1X,A)') JXbundle%TITLE0 - read(NJ1,'(10X,14I5)') JXbundle%NJVAL,NWWW,JXbundle%NW1,JXbundle%NW2 - if(JXbundle%NJVAL.gt.NS) then -! write(6,300) JXbundle%NJVAL,NS - STOP "Fast_JX" - endif -!------------NQQQ = no. additional J-values from X-sects (O2,O3P,O3D+NQQQ) - NQQQ = JXbundle%NJVAL-3 -! read(NJ1,102) (WBIN(IW),IW=1,NWWW) -! read(NJ1,102) (WBIN(IW+1),IW=1,NWWW) - read(NJ1,102) (JXbundle%WL(IW),IW=1,NWWW) - read(NJ1,102) (JXbundle%FL(IW),IW=1,NWWW) - read(NJ1,102) (JXbundle%QRAYL(IW),IW=1,NWWW) - read(NJ1,102) (JXbundle%QBC(IW),IW=1,NWWW) ! From Loiusse et al. [JGR, 1996] -! -!---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - do K=1,3 - read(NJ1,103) JXbundle%TITLEJ(K,1),JXbundle%TQQ(K,1), (JXbundle%QO2(IW,K),IW=1,NWWW) - enddo - do K=1,3 - read(NJ1,103) JXbundle%TITLEJ(K,2),JXbundle%TQQ(K,2), (JXbundle%QO3(IW,K),IW=1,NWWW) - enddo - do K=1,3 - read(NJ1,103) JXbundle%TITLEJ(K,3),JXbundle%TQQ(K,3), (JXbundle%Q1D(IW,K),IW=1,NWWW) - enddo -!aoo do K=1,3 -!aoo write(6,200) JXbundle%titlej(1,k),(tqq(i,k),i=1,3) -!aoo enddo -! -!---Read remaining species: X-sections at 2 T's - do J=1,NQQQ - read(NJ1,103) JXbundle%TITLEJ(1,J+3),JXbundle%TQQ(1,J+3),(JXbundle%QQQ(IW,1,J),IW=1,NWWW) - read(NJ1,103) JXbundle%TITLEJ(2,J+3),JXbundle%TQQ(2,J+3),(JXbundle%QQQ(IW,2,J),IW=1,NWWW) - if(JXbundle%titlej(1,j+3).eq."C3H6Ot") JXbundle%ncat_acetone_trop = J+3 ! Added for GMI to catch trop acetone {AOO, 8/04} - if(JXbundle%titlej(1,j+3).eq."C3H6Os") JXbundle%ncat_acetone_stra = J+3 ! Added for GMI to catch strat acetone {AOO, 8/04} - if(JXbundle%titlej(1,j+3).eq."MeVK") JXbundle%ncat_met_vinyl_ketone = J+3 ! Added for GMI to catch methylvinylketone {AOO, 8/04} - if(JXbundle%titlej(1,j+3).eq."MEKeto") JXbundle%ncat_met_ethyl_ketone = J+3 ! Added for GMI to catch methylethylketone {AOO, 8/04} - if(JXbundle%titlej(1,j+3).eq."MGlyxl") JXbundle%ncat_methyl_glyoxal = J+3 ! Added for GMI to catch methy glyoxal {AOO, 8/04} -!aoo write(6,200) JXbundle%titlej(1,j+3),(tqq(i,j+3),i=1,2) - enddo - - read(NJ1,'(A)') JXbundle%TITLE0 -! -! JXbundle%npdep=0 -!---Pressure dependencies - see utils/pdep if required -! read(NJ1,104) JXbundle%npdep -! do k=1,JXbundle%npdep -! read(NJ1,105) lpdep(k),(zpdep(iw,k),iw=1,nwww) -! write(6,201) lpdep(k),(zpdep(iw,k),iw=1,nwww) -! enddo -! read(NJ1,'(A)') JXbundle%TITLE0 -! -!---Read aerosol phase functions: - read(NJ1,'(A10,I5,/)') JXbundle%TITLE0,JXbundle%NAA - if(JXbundle%NAA.gt.NP) then -! write(6,350) JXbundle%NAA - STOP "Fast_JX" - endif - NK=4 ! Fix number of wavelengths at 4 - do j=1,JXbundle%NAA - read(NJ1,110) JXbundle%TITLEA(j) - do k=1,NK - read(NJ1,*) JXbundle%WAA(k,j),JXbundle%QAA(k,j),JXbundle%RAA(k,j),JXbundle%SSA(k,j), & - & (JXbundle%PAA(i,k,j),i=1,8) - enddo - enddo -! -!aoo write(6,*) 'Aerosol phase functions & wavelengths' -!aoo do J=1,JXbundle%NAA -!aoo write(6,'(1x,A8,I2,A,9F8.1)') -!aoo $ JXbundle%TITLEA(J),J,' wavel=',(WAA(K,J),K=1,NK) -!aoo write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,NK) -!aoo enddo -! -!---Zero index arrays - do j=1,JXbundle%jppj - JXbundle%jind(j)=0 - enddo -!AOO do j=1,JXbundle%NJVAL -!AOO JXbundle%jpdep(j)=0 -!AOO enddo - -! -!---Set mapping index - do j=1,JXbundle%NJVAL - do k=1,JXbundle%jppj - if(JXbundle%jlabel(k).eq.JXbundle%titlej(1,j)) JXbundle%jind(k)=j - enddo -!AOO do k=1,JXbundle%npdep -!AOO if(lpdep(k).eq.JXbundle%titlej(1,j)) JXbundle%jpdep(j)=k -!AOO enddo - enddo - do k=1,JXbundle%jppj - if(JXbundle%jfacta(k).eq.0.d0 .AND. rootProc) & - & write(6,*) 'RD_TJPL: Not using photolysis reaction ',k - if(JXbundle%jind(k).eq.0) then - if(JXbundle%jfacta(k).eq.0.d0) then - JXbundle%jind(k)=1 - else - write(6,*) 'RD_TJPL: Which J-rate for photolysis reaction ',k,' ?' - STOP "Fast_JX" - endif - endif - enddo -! -!-------- - 101 FORMAT(8E10.3) - 102 FORMAT((10X,6E10.3)/(10X,6E10.3)/(10X,6E10.3)) - 103 FORMAT(A7,F3.0,6E10.3/(10X,6E10.3)/(10X,6E10.3)) -! 103 FORMAT(A7,F3.0,7E10.3/(10X,7E10.3)) - 104 FORMAT(13x,i2) - 105 FORMAT(A7,3x,7E10.3) - 110 format(3x,a20) - 200 format(1x,' x-sect:',a10,3(3x,f6.2)) - 201 format(1x,' pr.dep:',a10,7(1pE10.3)) - 300 format(' Number of x-sections supplied to Fast-J2: ',i3,/, & - & ' Maximum number allowed (NS) only set to: ',i3, & - & ' - increase in fast_JX_jv_cmn.h') - 350 format(' Too many phase functions supplied; increase NP to ',i2) - 400 format(' Not using Herzberg bin') - close(NJ1) - return - end subroutine RD_TJPL - - - subroutine PRTATM(JXbundle, N) -!----------------------------------------------------------------------- -! Print out the atmosphere and calculate appropriate columns -! N=1 Print out column totals only -! N=2 Print out full columns -! N=3 Print out full columns and climatology -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer n, i, k, l, m - real*8 COLO3(JXbundle%NB),COLO2(JXbundle%NB),COLAX(MX,JXbundle%NB),ZKM,ZSTAR,PJC - real*8 climat(9),masfac,dlogp - if(N.eq.0) return -!---Calculate columns, for diagnostic output only: - COLO3(JXbundle%NB) = JXbundle%DO3(JXbundle%NB) - COLO2(JXbundle%NB) = JXbundle%DM(JXbundle%NB)*0.20948d0 - do K=1,MX - COLAX(K,JXbundle%NB) = JXbundle%AER(K,JXbundle%NB) - enddo - do I=JXbundle%NB-1,1,-1 - COLO3(i) = COLO3(i+1)+JXbundle%DO3(i) - COLO2(i) = COLO2(i+1)+JXbundle%DM(i)*0.20948d0 - do K=1,MX - COLAX(k,i) = COLAX(k,i+1)+JXbundle%AER(k,i) - enddo - enddo - write(6,1200) ' Tau=',JXbundle%tau,' SZA=',JXbundle%sza - write(6,1200) ' O3-column(DU)=',COLO3(1)/2.687d16, & - & ' column aerosol @1000nm=',(COLAX(K,1),K=1,MX) -!---Print out atmosphere - if(N.gt.1) then - write(6,1000) (' AER-X ','col-AER',k=1,mx) - do I=JXbundle%NB,1,-1 - PJC = JXbundle%PJ(I) - ZKM =1.d-5*JXbundle%Z(I) - ZSTAR = 16.d0*DLOG10(1000.d0/PJC) - write(6,1100) I,ZKM,ZSTAR,JXbundle%DM(I),JXbundle%DO3(I),1.d6*JXbundle%DO3(I)/JXbundle%DM(I), & - & JXbundle%TJ(I),PJC,COLO3(I),COLO2(I),(JXbundle%AER(K,I),COLAX(K,I),K=1,MX) - enddo - endif -! -!---Print out climatology - if(N.gt.2) then - do i=1,9 - climat(i)=0.d0 - enddo - m = max(1,min(12,JXbundle%month)) - l = max(1,min(18,(int(JXbundle%ydgrd(JXbundle%nslat))+99)/10)) - masfac=100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - write(6,*) 'Specified Climatology' - write(6,1000) - do i=51,1,-1 - dlogp=10.d0**(-1.d0/16.d0) - PJC = 1000.d0*dlogp**(2*i-2) - climat(1) = 16.d0*DLOG10(1000.D0/PJC) - climat(2) = climat(1) - climat(3) = PJC*(1.d0/dlogp-dlogp)*masfac - if(i.eq.1) climat(3)=PJC*(1.d0-dlogp)*masfac - climat(4)=climat(3)*JXbundle%oref(i,l,m)*1.d-6 - climat(5)=JXbundle%oref(i,l,m) - climat(6)=JXbundle%tref(i,l,m) - climat(7)=PJC - climat(8)=climat(8)+climat(4) - climat(9)=climat(9)+climat(3)*0.20948d0 - write(6,1100) I,(climat(k),k=1,9) - enddo - write(6,1200) ' O3-column(DU)=',climat(8)/2.687d16 - endif - return - 1000 format(5X,'Zkm',3X,'Z*',8X,'M',8X,'O3',6X,'f-O3',5X,'T',7X,'P',6x, & - & 'col-O3',3X,'col-O2',2X,10(a7,2x)) - 1100 format(1X,I2,0P,2F6.2,1P,2E10.3,0P,F7.3,F8.2,F10.4,1P,10E9.2) - 1200 format(A,F8.1,A,10(1pE10.3)) - end subroutine PRTATM - - subroutine JVALUE(JXbundle) -!----------------------------------------------------------------------- -! Calculate the actinic flux at each level for the current SZA value. -! quit when SZA > 98.0 deg ==> tangent height = 63 km -! or 99. 80 km -!----------------------------------------------------------------------- -! -! AVGF Attenuation of beam at each level for each wavelength -! FFF Actinic flux at each desired level -! WAVE Effective wavelength of each wavelength bin -! XQO2 Absorption cross-section of O2 -! XQO3 Absorption cross-section of O3 -! -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_cmn_t.h" -!# include "fast_JX_cmn_w.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer j, k - -!AOO real*8 wave, xseco3, xseco2 - real*8 wave - real*8 AVGF(JXbundle%lpar),XQO3(JXbundle%NB),XQO2(JXbundle%NB) -! - do J=1,JXbundle%jpnl - do K=JXbundle%NW1,JXbundle%NW2 - JXbundle%FFF(K,J) = 0.d0 - enddo - enddo -! -!---SZA check -! write(6,1000) SZA, JXbundle%RFLECT, (OD(nslon,nslat,j),j=1,JXbundle%lpar) - if(JXbundle%SZA.gt.JXbundle%szamax) GOTO 99 -! -!---Calculate spherical weighting functions - call SPHERE(JXbundle) - -!---Loop over all wavelength bins - do K=JXbundle%NW1,JXbundle%NW2 - WAVE = JXbundle%WL(K) - do J=1,JXbundle%NB - XQO3(J) = XSECO3(JXbundle, K,dble(JXbundle%TJ(J))) - enddo - do J=1,JXbundle%NB - XQO2(J) = XSECO2(JXbundle, K,dble(JXbundle%TJ(J))) - enddo -!----------------------------------------- - call OPMIE(JXbundle, K,WAVE,XQO2,XQO3,AVGF) -!----------------------------------------- - do J=1,JXbundle%jpnl - JXbundle%FFF(K,J) = JXbundle%FFF(K,J) + JXbundle%FL(K)*AVGF(J) - enddo - enddo -! - 99 continue -!c 1000 format(' SZA=',f6.1,' Reflectvty=',f6.3,' OD=',10(1pe10.3)) - return - end subroutine JVALUE - - FUNCTION XSECO3(JXbundle, K,TTT) -!----------------------------------------------------------------------- -! Cross-sections for O3 for all processes interpolated across 3 temps -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle) :: JXbundle - integer k -!AOO real*8 ttt, flint, xseco3 - real*8 ttt, xseco3 - XSECO3 = & - & FLINT(TTT,JXbundle%TQQ(1,2),JXbundle%TQQ(2,2),JXbundle%TQQ(3,2),JXbundle%QO3(K,1),JXbundle%QO3(K,2),JXbundle%QO3(K,3)) - return - end FUNCTION XSECO3 - - FUNCTION XSEC1D(JXbundle, K,TTT) -!----------------------------------------------------------------------- -! Quantum yields for O3 --> O2 + O(1D) interpolated across 3 temps -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle) :: JXbundle - integer k -!AOO real*8 ttt, flint, xsec1d - real*8 ttt, xsec1d - XSEC1D = & - & FLINT(TTT,JXbundle%TQQ(1,3),JXbundle%TQQ(2,3),JXbundle%TQQ(3,3),JXbundle%Q1D(K,1),JXbundle%Q1D(K,2),JXbundle%Q1D(K,3)) - return - end FUNCTION XSEC1D - - FUNCTION XSECO2(JXbundle, K,TTT) -!----------------------------------------------------------------------- -! Cross-sections for O2 interpolated across 3 temps; No S_R Bands yet! -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle) :: JXbundle - integer k -!AOO real*8 ttt, flint, xseco2 - real*8 ttt, xseco2 - XSECO2 = & - & FLINT(TTT,JXbundle%TQQ(1,1),JXbundle%TQQ(2,1),JXbundle%TQQ(3,1),JXbundle%QO2(K,1),JXbundle%QO2(K,2),JXbundle%QO2(K,3)) - return - end FUNCTION XSECO2 - - REAL*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -!----------------------------------------------------------------------- -! Three-point linear interpolation function -!----------------------------------------------------------------------- - real*8 TINT,T1,T2,T3,F1,F2,F3 - IF (TINT .LE. T2) THEN - IF (TINT .LE. T1) THEN - FLINT = F1 - ELSE - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - ENDIF - ELSE - IF (TINT .GE. T3) THEN - FLINT = F3 - ELSE - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - ENDIF - ENDIF - return - end FUNCTION FLINT - - subroutine SPHERE(JXbundle) -!----------------------------------------------------------------------- -! Calculation of spherical geometry; derive tangent heights, slant path -! lengths and air mass factor for each layer. Not called when -! SZA > 98 degrees. Beyond 90 degrees, include treatment of emergent -! beam (where tangent height is below altitude J-value desired at). -!----------------------------------------------------------------------- -! -! GMU MU, cos(solar zenith angle) -! RZ Distance from centre of Earth to each point (cm) -! RQ Square of radius ratios -! TANHT Tangent height for the current SZA -! XL Slant path between points -! AMF Air mass factor for slab between level and level above -! -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer i, j, k, ii - real*8 airmas, gmu, xmu1, xmu2, xl, diff - REAL*8 Ux,H,RZ(JXbundle%NB),RQ(JXbundle%NB),ZBYR -! -! Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- & - & 0.6817d0*EXP(-57.3d0*ABS(Ux)/SQRT(1.0d0+5500.d0*H))/ & - & (1.0d0+0.625d0*H))) -! - GMU = JXbundle%U0 - RZ(1)=JXbundle%RAD+JXbundle%Z(1) - ZBYR = JXbundle%ZZHT/JXbundle%RAD - DO 2 II=2,JXbundle%NB - RZ(II) = JXbundle%RAD + JXbundle%Z(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - 2 CONTINUE - IF (GMU.LT.0.0D0) THEN - JXbundle%TANHT = RZ(JXbundle%nlbatm)/DSQRT(1.0D0-GMU**2) - ELSE - JXbundle%TANHT = RZ(JXbundle%nlbatm) - ENDIF -! -! Go up from the surface calculating the slant paths between each level -! and the level above, and deriving the appropriate Air Mass Factor - DO 16 J=1,JXbundle%NB - DO K=1,JXbundle%NB - JXbundle%AMF(K,J)=0.D0 - ENDDO -! -! Air Mass Factors all zero if below the tangent height - IF (RZ(J).LT.JXbundle%TANHT) GOTO 16 -! Ascend from layer J calculating AMFs - XMU1=ABS(GMU) - DO 12 I=J,JXbundle%lpar - XMU2=DSQRT(1.0D0-RQ(I)*(1.0D0-XMU1**2)) - XL=RZ(I+1)*XMU2-RZ(I)*XMU1 - JXbundle%AMF(I,J)=XL/(RZ(I+1)-RZ(I)) - XMU1=XMU2 - 12 CONTINUE -! Use function and scale height to provide AMF above top of model - JXbundle%AMF(JXbundle%NB,J)=AIRMAS(XMU1,ZBYR) -! -! Twilight case - Emergent Beam - IF (GMU.GE.0.0D0) GOTO 16 - XMU1=ABS(GMU) -! Descend from layer J - DO 14 II=J-1,1,-1 - DIFF=RZ(II+1)*DSQRT(1.0D0-XMU1**2)-RZ(II) - if(II.eq.1) DIFF=max(DIFF,0.d0) ! filter -! Tangent height below current level - beam passes through twice - IF (DIFF.LT.0.0D0) THEN - XMU2=DSQRT(1.0D0-(1.0D0-XMU1**2)/RQ(II)) - XL=ABS(RZ(II+1)*XMU1-RZ(II)*XMU2) - JXbundle%AMF(II,J)=2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1=XMU2 -! Lowest level intersected by emergent beam - ELSE - XL=RZ(II+1)*XMU1*2.0D0 -! WTING=DIFF/(RZ(II+1)-RZ(II)) -! AMF(II,J)=(1.0D0-WTING)*2.D0**XL/(RZ(II+1)-RZ(II)) - JXbundle%AMF(II,J)=XL/(RZ(II+1)-RZ(II)) - GOTO 16 - ENDIF - 14 CONTINUE -! - 16 CONTINUE - RETURN - END subroutine SPHERE - - - subroutine OPMIE(JXbundle, KW,WAVEL,XQO2,XQO3,FMEAN ) - - implicit none -!----------------------------------------------------------------------- -! NEW Mie code for J's, only uses 8-term expansion, 4-Gauss pts -! Currently allow up to NP aerosol phase functions (at all altitudes) to -! be associated with optical depth AER(1:NC) = aerosol opt.depth @ 1000 nm -! -! Pick Mie-wavelength with phase function and Qext: -! -! 01 RAYLE = Rayleigh phase -! 02 ISOTR = isotropic -! 03 ABSRB = fully absorbing 'soot', wavelength indep. -! 04 S_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -! 05 S_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -! 06 W_H01 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.1um /alpha=2) -! 07 W_H04 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.4um /alpha=2) -! 08 W_C02 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=2.0um /alpha=6) -! 09 W_C04 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=4.0um /alpha=6) -! 10 W_C08 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=8.0um /alpha=6) -! 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -! 12 W_L06 = water cloud (Lacis) (n=1.335, r-mode=5.5um / alpha=11/3) -! 13 Ice-H = hexagonal ice cloud (Mishchenko) -! 14 Ice-I = irregular ice cloud (Mishchenko) -! -! Choice of aerosol index MIEDX is made in SET_AER; optical depths are -! apportioned to the AER array in SET_PROF -! -!----------------------------------------------------------------------- -! FUNCTION RAYLAY(WAVE)---RAYLEIGH CROSS-SECTION for wave > 170 nm -! WSQI = 1.E6/(WAVE*WAVE) -! REFRM1 = 1.0E-6*(64.328+29498.1/(146.-WSQI)+255.4/(41.-WSQI)) -! RAYLAY = 5.40E-21*(REFRM1*WSQI)**2 -!----------------------------------------------------------------------- -! -! DTAUX Local optical depth of each CTM level -! PIRAY Contribution of Rayleigh scattering to extinction -! PIAER Contribution of Aerosol scattering to extinction -! TTAU Optical depth of air vertically above each point (to top of atm) -! FTAU Attenuation of solar beam -! POMEGA Scattering phase function -! FMEAN Mean actinic flux at desired levels -! -!----------------------------------------------------------------------- -!# include "fast_JX_cmn_h.h" -!# include "fast_JX_jv_cmn.h" -!# include "fast_JX_jv_mie.h" - - TYPE(t_fastJXbundle), intent(inOut) :: JXbundle - - integer jndlev(JXbundle%lpar),jaddlv(JXbundle%nc),jaddto(JXbundle%nc+1) - integer KW,km,i,j,k,l,ix,j1 - real*8 QXMIE(MX),XLAER(MX),SSALB(MX) - real*8 xlo2,xlo3,xlray,xltau,zk,taudn,tauup,zk2 - real*8 WAVEL,XQO2(JXbundle%NB),XQO3(JXbundle%NB),FMEAN(JXbundle%lpar),POMEGAJ(2*M__,JXbundle%NC+1) - real*8 DTAUX(JXbundle%NB),PIRAY(JXbundle%NB),PIAER(MX,JXbundle%NB),TTAU(JXbundle%NC+1),FTAU(JXbundle%NC+1) - real*8 ftaulog,dttau,dpomega(2*M__) - real*8 ftaulog2,dttau2,dpomega2(2*M__) -! -!---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 ! use 300 nm aerosol properties for <355 nm - if( WAVEL .gt. 355.d0 ) KM=2 ! use 400 nm prop for 355-500 nm - if( WAVEL .gt. 500.d0 ) KM=3 -! if( WAVEL .gt. 800.d0 ) KM=4 !drop the 1000 nm wavelength -! -!---For Mie code scale extinction at 1000 nm to wavelength WAVEL (QXMIE) - do I=1,MX - QXMIE(I) = JXbundle%QAA(KM,JXbundle%MIEDX(I))/JXbundle%QAA(4,JXbundle%MIEDX(I)) - SSALB(I) = JXbundle%SSA(KM,JXbundle%MIEDX(I)) - enddo -! -!---Reinitialize arrays - do j=1,JXbundle%nc+1 - ttau(j)=0.d0 - ftau(j)=0.d0 - enddo -! -!---Set up total optical depth over each CTM level, DTAUX - J1 = JXbundle%NLBATM - do J=J1,JXbundle%NB - XLO3=JXbundle%DO3(J)*XQO3(J) - XLO2=JXbundle%DM(J)*XQO2(J)*0.20948d0 - XLRAY=JXbundle%DM(J)*JXbundle%QRAYL(KW) - -!xxx Have dropped fast-J2 formlation for full scattering -!cc if (WAVEL.le.291.d0) then -!cc XLRAY=XLRAY * 0.57 -!cc endif - -! Zero absorption for testing purposes -! call NOABS(XLO3,XLO2,XLRAY,AER(1,j),RFLECT) - do I=1,MX - XLAER(I)=JXbundle%AER(I,J)*QXMIE(I) - enddo - -! Total optical depth from all elements - DTAUX(J)=XLO3+XLO2+XLRAY - do I=1,MX - DTAUX(J)=DTAUX(J)+XLAER(I) - enddo -! Fractional extinction for Rayleigh scattering and each aerosol type - PIRAY(J)=XLRAY/DTAUX(J) - do I=1,MX - PIAER(I,J)=SSALB(I)*XLAER(I)/DTAUX(J) - enddo - enddo -! -!---Calculate attenuated incident beam EXP(-TTAU/U0) and flux on surface - do J=J1,JXbundle%NB - if(JXbundle%AMF(J,J).gt.0.0D0) then - XLTAU=0.0D0 - do I=1,JXbundle%NB - XLTAU=XLTAU + DTAUX(I)*JXbundle%AMF(I,J) - enddo -!AOO if(XLTAU.gt.76.d0) then ! zero out flux at 1e-33 - if(XLTAU.gt.450.d0) then ! zero out flux at 1e-33 - FTAU(j)=0.d0 - else - FTAU(J)=DEXP(-XLTAU) - endif - else - FTAU(J)=0.0D0 - endif - enddo - -!xxx Have dropped fast-J2 formlation for full scattering -!cc---in UV region, use pseudo-Rayleigh absorption instead of scattering -!cc if (WAVEL.le.291.d0) then !<<<>>>>>>this version is keyed to test with EC T42 grid and 37-level model ------------------------------------------------------------------------ - 80 Day of year - 1 Number of steps to run - 12.0 Start time of day (UT) to calculate J's - 1.0 Time step (hours, if multiple steps) - 33 JLatitude - 1 Longitude -1000.0 Surface Pressure - 0.10 Surface Albedo - 10 Cloud's Mie index for OD below - Eta(a) Eta(b) Temp OD - 1 0.0000000 1.0000000 278.7 0.0 - 2 0.6588924 0.9882701 278.6 0.0 - 3 4.6733350 0.9676452 278.1 10.0 - 4 8.5536182 0.9518215 277.5 0.0 - 5 13.8591260 0.9319403 276.9 0.0 - 6 20.6377979 0.9078839 276.2 0.0 - 7 28.8769653 0.8796569 275.4 0.0 - 8 38.5091333 0.8473749 274.5 0.0 - 9 49.4177734 0.8112534 273.5 0.0 - 10 61.4431641 0.7715966 272.4 0.0 - 11 74.3880469 0.7287858 271.2 0.0 - 12 88.0235547 0.6832686 269.8 0.0 - 13 102.0950000 0.6355475 268.0 0.0 - 14 116.3275781 0.5861684 265.8 0.0 - 15 130.4321875 0.5357099 263.4 0.0 - 16 144.1112500 0.4847716 260.8 0.0 - 17 157.0644922 0.4339629 258.0 0.0 - 18 168.9946875 0.3838922 254.9 0.0 - 19 179.6135938 0.3351549 251.5 0.0 - 20 188.6475000 0.2883229 247.8 0.0 - 21 195.8432813 0.2439331 243.8 0.0 - 22 200.9740234 0.2024760 239.5 0.0 - 23 203.8448047 0.1643843 235.2 0.0 - 24 204.2986328 0.1300225 230.9 0.0 - 25 202.2220703 0.0996747 226.8 0.0 - 26 197.5510938 0.0735338 223.3 0.0 - 27 190.2769531 0.0516904 220.5 0.0 - 28 180.4518359 0.0341212 218.1 0.0 - 29 168.1947656 0.0206779 215.9 0.0 - 30 153.6973047 0.0110762 213.4 0.0 - 31 137.2294141 0.0048842 210.7 0.0 - 32 119.1452344 0.0015113 208.4 0.0 - 33 99.8888281 0.0001971 207.7 0.0 - 34 80.0000000 0.0000000 209.2 0.0 - 35 60.0000000 0.0000000 212.2 0.0 - 36 40.0000000 0.0000000 216.4 0.0 - 37 20.0000000 0.0000000 224.9 0.0 - 38 2.0000000 0.0000000 ------------------------------------------------------------------------ - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/atmos_std.dat b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/atmos_std.dat deleted file mode 100644 index 2917a13a..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/atmos_std.dat +++ /dev/null @@ -1,1774 +0,0 @@ -atmos_std.dat: T-O3 profs (McPeters/92 & Nagatani/91) for FAST J-code (prather) - 18 12 latitudes x months -A-85LAT 1M -T1 256.4 251.1 241.9 233.2 228.0 227.8 230.3 232.3 233.4 234.0 234.4 -T2 235.0 236.3 238.7 242.0 245.4 248.9 252.4 256.7 263.2 271.5 279.5 -T3 285.5 289.2 290.2 288.4 283.8 276.0 269.5 263.3 257.1 249.8 242.5 -T4 235.0 227.0 218.2 209.1 199.9 190.7 170.7 170.4 -Z1 .026 .035 .037 .028 .045 .136 .323 .609 1.048 1.822 2.954 -Z2 3.837 4.110 4.052 4.175 4.487 5.011 5.664 6.171 6.287 5.940 5.094 -Z3 4.074 3.169 2.449 1.907 1.524 1.241 1.007 .812 .654 -A-75LAT 1M -T1 262.1 256.4 245.8 235.6 228.6 226.8 228.6 230.6 231.9 232.6 233.2 -T2 234.0 235.4 237.7 240.8 244.1 247.5 251.2 255.8 262.0 269.5 276.8 -T3 282.3 285.7 286.5 284.6 280.0 272.7 266.5 260.6 254.6 247.8 240.6 -T4 232.9 224.9 216.4 207.5 198.6 189.8 180.7 169.0 -Z1 .026 .035 .037 .028 .045 .136 .323 .609 1.048 1.822 2.954 -Z2 3.837 4.110 4.052 4.175 4.487 5.011 5.664 6.171 6.287 5.940 5.094 -Z3 4.074 3.169 2.449 1.907 1.524 1.241 1.007 .812 .654 -A-65LAT 1M -T1 268.5 262.1 250.2 238.5 230.1 227.0 227.6 229.0 229.8 230.2 230.7 -T2 231.6 233.2 235.5 238.4 241.6 245.2 249.4 254.5 260.3 266.7 272.6 -T3 277.1 279.8 280.5 278.7 274.9 268.7 262.5 256.4 250.3 241.7 235.9 -T4 228.1 220.4 212.2 204.0 195.8 187.5 179.8 166.2 -Z1 .025 .033 .040 .044 .067 .134 .282 .565 1.053 1.852 2.970 -Z2 3.890 4.282 4.388 4.725 5.283 5.965 6.632 6.993 6.857 6.268 5.288 -Z3 4.216 3.311 2.612 2.079 1.684 1.379 1.127 .917 .746 -A-55LAT 1M -T1 273.6 267.0 254.6 242.0 231.9 226.2 224.8 224.9 225.2 225.6 226.5 -T2 227.9 229.8 232.4 235.3 238.5 242.2 247.0 252.4 257.9 263.3 268.2 -T3 271.9 274.0 274.4 272.8 269.5 264.2 258.0 251.7 245.4 236.3 230.4 -T4 222.5 214.8 207.6 200.5 193.4 186.3 179.1 174.7 -Z1 .025 .033 .040 .045 .065 .123 .252 .502 .943 1.694 2.795 -Z2 3.810 4.407 4.784 5.463 6.390 7.258 7.865 8.000 7.587 6.756 5.632 -Z3 4.484 3.535 2.805 2.244 1.816 1.481 1.206 .979 .794 -A-45LAT 1M -T1 280.2 273.5 260.8 247.3 234.7 225.3 220.4 218.3 217.7 218.3 220.1 -T2 222.5 225.3 228.4 231.6 235.1 239.1 244.1 249.7 255.2 260.4 265.0 -T3 268.3 270.2 270.4 268.7 265.4 260.1 253.9 247.7 241.5 232.3 226.6 -T4 219.0 211.6 205.6 199.9 194.2 188.7 183.2 179.2 -Z1 .025 .034 .038 .035 .043 .087 .188 .376 .709 1.333 2.335 -Z2 3.366 4.114 4.755 5.842 7.263 8.374 8.903 8.808 8.177 7.178 5.959 -Z3 4.758 3.771 3.010 2.419 1.960 1.595 1.297 1.053 .854 -A-35LAT 1M -T1 287.2 280.3 267.2 252.9 238.8 226.7 217.8 212.1 209.5 210.1 212.9 -T2 216.6 220.4 224.1 227.7 231.5 235.7 240.8 246.4 252.0 257.6 262.5 -T3 266.2 268.1 268.3 266.5 263.0 257.7 252.1 246.5 240.9 233.2 227.8 -T4 220.3 213.2 208.2 203.7 199.2 194.7 190.5 187.2 -Z1 .025 .034 .038 .034 .037 .067 .137 .262 .487 .937 1.715 -Z2 2.737 3.874 5.123 6.559 8.008 9.065 9.541 9.397 8.712 7.651 6.357 -Z3 5.078 4.021 3.201 2.565 2.073 1.686 1.369 1.109 .898 -A-25LAT 1M -T1 291.7 284.7 271.4 257.0 242.6 228.9 217.0 207.6 202.7 203.3 207.3 -T2 212.0 216.5 220.6 224.3 228.1 232.3 237.4 243.1 249.1 255.3 260.9 -T3 265.0 267.3 267.6 265.8 262.3 257.6 252.7 247.7 242.7 234.7 230.9 -T4 223.1 216.4 211.9 208.0 204.1 200.2 196.5 193.8 -Z1 .025 .034 .039 .038 .041 .057 .097 .173 .320 .639 1.236 -Z2 2.240 3.741 5.566 7.222 8.506 9.433 9.923 9.848 9.210 8.141 6.765 -Z3 5.379 4.223 3.323 2.633 2.112 1.709 1.381 1.112 .895 -A-15LAT 1M -T1 293.4 286.4 273.2 259.0 244.4 230.1 216.5 204.9 198.5 199.2 203.9 -T2 209.2 214.0 218.1 221.8 225.5 229.8 234.8 240.7 247.1 253.8 259.9 -T3 264.5 267.1 267.6 265.9 262.8 259.6 254.6 249.3 244.1 235.4 231.2 -T4 223.3 216.6 212.3 208.8 205.3 201.8 198.5 196.3 -Z1 .025 .034 .038 .035 .033 .042 .066 .110 .197 .418 .875 -Z2 1.844 3.597 5.882 7.794 9.077 9.957 10.414 10.322 9.668 8.556 7.082 -Z3 5.586 4.334 3.361 2.622 2.079 1.667 1.333 1.062 .845 -A -5LAT 1M -T1 293.2 286.4 273.5 259.4 244.7 230.2 216.3 204.0 197.1 197.9 203.0 -T2 208.6 213.4 217.3 220.8 224.3 228.5 233.7 239.8 246.4 253.3 259.6 -T3 264.2 266.8 267.4 265.8 263.3 261.4 255.8 249.7 243.6 233.3 228.7 -T4 220.4 213.4 209.6 207.0 204.6 202.1 199.5 197.9 -Z1 .026 .035 .037 .028 .020 .027 .053 .092 .163 .346 .736 -Z2 1.632 3.352 5.687 7.735 9.183 10.116 10.509 10.355 9.711 8.630 7.165 -Z3 5.657 4.375 3.365 2.602 2.051 1.639 1.307 1.037 .821 -A 5LAT 1M -T1 292.8 286.1 273.3 259.3 244.6 230.1 216.2 204.0 197.1 198.1 203.5 -T2 209.3 214.1 217.8 221.0 224.2 228.2 233.4 239.5 246.2 253.1 259.4 -T3 264.1 266.7 267.3 265.7 263.1 261.0 255.1 248.6 242.0 232.5 226.3 -T4 217.5 210.7 207.3 205.4 203.7 201.9 200.2 198.7 -Z1 .026 .035 .038 .029 .021 .026 .047 .082 .149 .327 .708 -Z2 1.592 3.296 5.587 7.529 8.836 9.660 10.009 9.911 9.416 8.499 7.142 -Z3 5.687 4.406 3.375 2.595 2.044 1.638 1.309 1.040 .825 -A 15LAT 1M -T1 291.2 284.5 271.8 257.7 243.3 229.2 216.1 204.9 198.4 199.1 204.2 -T2 209.9 214.5 218.1 221.2 224.3 228.2 233.1 239.0 245.6 252.4 258.8 -T3 263.5 266.4 267.0 265.4 262.2 258.7 253.0 246.9 240.9 232.0 226.3 -T4 218.1 211.5 208.0 205.9 203.9 201.8 199.9 198.1 -Z1 .025 .034 .039 .037 .034 .036 .048 .081 .159 .368 .808 -Z2 1.763 3.508 5.700 7.299 8.141 8.715 9.093 9.205 8.988 8.330 7.130 -Z3 5.741 4.452 3.381 2.574 2.022 1.625 1.302 1.035 .822 -A 25LAT 1M -T1 286.2 279.5 266.7 252.8 239.2 227.0 216.6 208.4 203.5 203.4 206.9 -T2 211.1 214.9 218.2 221.2 224.3 227.9 232.6 238.1 244.2 250.6 256.5 -T3 261.2 264.1 264.9 263.4 259.8 254.9 250.0 245.2 240.3 232.8 228.4 -T4 221.5 215.3 211.4 208.6 205.8 203.1 200.2 198.3 -Z1 .026 .034 .038 .033 .029 .039 .075 .159 .327 .650 1.210 -Z2 2.247 3.953 5.909 7.111 7.534 7.870 8.234 8.507 8.551 8.184 7.224 -Z3 5.967 4.668 3.517 2.641 2.067 1.668 1.343 1.071 .852 -A 35LAT 1M -T1 279.0 271.9 258.7 245.1 232.8 223.4 217.5 213.9 211.4 210.8 211.9 -T2 214.0 216.3 218.7 221.2 223.8 226.9 231.0 235.8 241.1 246.5 251.7 -T3 256.0 259.1 260.4 259.4 256.2 250.6 246.8 243.3 239.8 234.3 231.1 -T4 225.4 220.1 216.2 213.0 209.6 206.3 202.8 201.0 -Z1 .026 .035 .037 .025 .027 .075 .195 .413 .763 1.247 1.882 -Z2 2.912 4.507 6.206 7.060 7.151 7.262 7.527 7.834 8.038 7.944 7.330 -Z3 6.345 5.090 3.838 2.857 2.236 1.817 1.474 1.184 .948 -A 45LAT 1M -T1 269.9 263.6 251.3 238.3 227.1 220.2 217.8 217.2 216.4 215.7 215.5 -T2 215.9 216.9 218.3 220.1 222.2 224.7 228.3 232.5 237.0 241.5 245.9 -T3 249.8 253.0 254.9 255.0 252.8 247.5 244.3 241.5 238.7 234.3 232.3 -T4 229.3 224.7 221.3 218.0 214.6 211.3 207.8 206.2 -Z1 .025 .033 .040 .044 .071 .153 .331 .663 1.183 1.795 2.460 -Z2 3.415 4.813 6.233 6.879 6.863 6.858 6.991 7.217 7.458 7.539 7.250 -Z3 6.581 5.431 4.122 3.055 2.377 1.921 1.553 1.245 .996 -A 55LAT 1M -T1 262.0 256.9 246.0 233.7 223.4 217.5 216.2 216.3 215.8 215.0 214.4 -T2 214.1 214.5 215.5 217.0 218.8 221.2 224.7 228.9 233.3 237.5 241.7 -T3 245.7 249.2 251.8 252.9 252.0 248.0 244.9 241.9 239.0 234.1 232.5 -T4 230.5 228.1 225.0 221.9 218.7 215.6 212.6 210.8 -Z1 .024 .031 .041 .056 .102 .212 .431 .815 1.387 2.030 2.690 -Z2 3.524 4.619 5.709 6.305 6.457 6.543 6.641 6.745 6.829 6.814 6.636 -Z3 6.203 5.293 4.141 3.125 2.402 1.877 1.478 1.169 .926 -A 65LAT 1M -T1 256.6 252.2 242.1 230.3 220.4 214.9 213.5 213.1 212.0 210.7 209.7 -T2 209.2 209.6 210.7 212.4 214.4 217.0 220.9 225.4 230.2 235.0 239.7 -T3 244.2 248.4 251.7 253.7 254.0 251.7 247.6 243.4 239.2 232.1 230.1 -T4 228.0 225.9 223.3 221.0 218.6 216.2 213.8 212.5 -Z1 .024 .032 .041 .052 .094 .201 .416 .796 1.359 1.972 2.572 -Z2 3.301 4.242 5.211 5.851 6.168 6.425 6.658 6.801 6.795 6.601 6.189 -Z3 5.588 4.807 3.949 3.136 2.435 1.866 1.441 1.124 .879 -A 75LAT 1M -T1 252.3 248.3 238.8 227.6 218.3 213.0 211.2 210.2 208.3 206.3 204.8 -T2 204.3 204.7 206.0 207.8 210.0 212.8 216.9 221.9 227.2 232.6 238.0 -T3 243.3 248.2 252.3 255.0 256.3 255.5 250.7 245.2 239.8 231.0 227.9 -T4 223.3 218.9 217.3 216.2 215.2 214.2 213.1 212.5 -Z1 .024 .032 .041 .052 .094 .201 .416 .796 1.359 1.972 2.572 -Z2 3.301 4.242 5.211 5.851 6.168 6.425 6.658 6.801 6.795 6.601 6.189 -Z3 5.588 4.807 3.949 3.136 2.435 1.866 1.441 1.124 .879 -A 85LAT 1M -T1 249.8 245.8 236.4 225.6 216.7 211.5 209.6 208.2 205.9 203.3 201.6 -T2 201.1 201.6 202.8 204.6 206.6 209.5 213.6 218.8 224.4 230.3 236.2 -T3 242.0 247.5 252.2 255.7 257.8 258.3 252.9 246.6 240.4 231.9 226.3 -T4 220.3 216.0 214.4 214.0 213.6 213.2 212.8 212.5 -Z1 .024 .032 .041 .052 .094 .201 .416 .796 1.359 1.972 2.572 -Z2 3.301 4.242 5.211 5.851 6.168 6.425 6.658 6.801 6.795 6.601 6.189 -Z3 5.588 4.807 3.949 3.136 2.435 1.866 1.441 1.124 .879 -A-85LAT 2M -T1 253.3 248.3 239.7 231.8 227.3 227.6 229.9 231.3 231.5 231.1 230.8 -T2 230.9 231.8 233.5 236.0 238.5 241.0 243.4 246.5 252.1 259.7 267.2 -T3 273.2 277.4 279.4 278.9 276.0 270.7 265.0 259.3 253.6 247.4 240.3 -T4 232.7 225.1 217.4 209.6 201.8 194.0 186.1 181.7 -Z1 .026 .036 .036 .023 .040 .142 .339 .598 .966 1.689 2.824 -Z2 3.720 3.985 3.894 3.941 4.140 4.535 5.090 5.664 6.081 6.155 5.688 -Z3 4.874 3.893 2.952 2.218 1.746 1.423 1.157 .931 .748 -A-75LAT 2M -T1 259.6 254.2 244.3 234.6 228.2 226.7 228.2 229.6 230.1 229.9 229.9 -T2 230.2 231.2 233.0 235.4 237.9 240.4 243.1 246.6 252.0 258.9 265.6 -T3 271.0 274.8 276.4 275.6 272.5 267.1 261.7 256.4 251.1 245.5 238.5 -T4 230.8 223.3 215.6 207.9 200.3 192.6 184.7 180.4 -Z1 .026 .036 .036 .023 .040 .142 .339 .598 .966 1.689 2.824 -Z2 3.720 3.985 3.894 3.941 4.140 4.535 5.090 5.664 6.081 6.155 5.688 -Z3 4.874 3.893 2.952 2.218 1.746 1.423 1.157 .931 .748 -A-65LAT 2M -T1 267.5 261.3 249.7 238.3 230.1 227.0 227.3 228.1 228.2 228.0 228.1 -T2 228.7 229.9 231.8 234.2 236.7 239.6 243.1 247.3 252.4 258.1 263.6 -T3 268.0 270.9 272.1 271.2 268.4 263.3 257.8 252.3 246.8 240.0 233.7 -T4 226.1 218.7 211.3 204.1 196.6 189.4 182.3 177.8 -Z1 .025 .033 .039 .039 .059 .128 .273 .524 .944 1.698 2.828 -Z2 3.788 4.210 4.321 4.624 5.123 5.767 6.453 6.967 7.114 6.792 5.925 -Z3 4.832 3.801 2.941 2.283 1.826 1.492 1.217 .985 .795 -A-55LAT 2M -T1 273.9 267.3 255.0 242.6 232.3 226.3 224.4 224.1 223.9 224.0 224.6 -T2 225.9 227.7 229.9 232.5 235.3 238.5 242.7 247.4 252.3 257.1 261.5 -T3 264.9 267.1 267.8 267.0 264.3 259.3 253.5 247.5 241.6 234.1 227.6 -T4 220.0 212.7 206.3 200.0 193.7 187.5 181.8 177.5 -Z1 .025 .034 .039 .038 .053 .108 .229 .449 .833 1.534 2.616 -Z2 3.625 4.205 4.553 5.199 6.110 7.004 7.694 8.000 7.822 7.180 6.110 -Z3 4.920 3.878 3.045 2.405 1.936 1.579 1.286 1.042 .843 -A-45LAT 2M -T1 280.7 274.2 261.6 248.1 235.4 225.7 220.2 217.7 216.7 217.3 219.0 -T2 221.4 224.2 227.2 230.3 233.5 237.2 241.7 246.7 251.5 256.0 260.1 -T3 263.1 264.9 265.3 264.2 261.3 256.1 250.2 244.2 238.2 230.3 224.2 -T4 216.7 209.9 204.7 199.8 195.0 190.1 185.6 182.5 -Z1 .026 .035 .038 .030 .033 .069 .161 .332 .639 1.229 2.192 -Z2 3.206 3.966 4.623 5.677 7.035 8.138 8.737 8.786 8.335 7.478 6.303 -Z3 5.078 4.031 3.200 2.555 2.066 1.686 1.374 1.116 .906 -A-35LAT 2M -T1 287.7 280.9 267.8 253.6 239.5 227.2 217.9 211.8 209.0 209.5 212.4 -T2 216.2 220.0 223.8 227.3 231.0 235.1 239.8 245.0 250.1 255.0 259.5 -T3 262.7 264.4 264.6 263.2 260.1 254.8 249.6 244.4 239.3 233.2 227.1 -T4 220.0 213.6 209.1 204.9 200.9 196.8 193.1 190.3 -Z1 .026 .035 .038 .030 .028 .052 .115 .231 .442 .870 1.617 -Z2 2.627 3.796 5.089 6.505 7.878 8.891 9.386 9.332 8.786 7.846 6.598 -Z3 5.313 4.216 3.344 2.668 2.156 1.759 1.433 1.163 .943 -A-25LAT 2M -T1 292.2 285.1 271.8 257.5 243.1 229.3 217.1 207.4 202.4 203.0 206.9 -T2 211.8 216.4 220.5 224.4 228.3 232.6 237.6 243.1 248.8 254.6 259.9 -T3 263.6 265.6 265.8 264.0 260.6 255.7 251.3 247.1 242.9 235.9 232.5 -T4 225.4 219.2 214.7 210.8 206.9 202.9 199.2 196.5 -Z1 .025 .034 .038 .034 .032 .045 .082 .152 .287 .583 1.142 -Z2 2.115 3.619 5.486 7.201 8.537 9.470 9.925 9.828 9.209 8.176 6.828 -Z3 5.456 4.297 3.385 2.682 2.156 1.749 1.416 1.143 .921 -A-15LAT 2M -T1 293.6 286.6 273.4 259.2 244.6 230.2 216.6 204.9 198.5 199.0 203.5 -T2 208.8 213.7 218.0 221.9 225.9 230.3 235.7 241.8 248.3 254.9 260.9 -T3 265.2 267.4 267.6 265.6 262.1 257.9 253.5 249.1 244.6 237.2 233.7 -T4 226.4 220.0 215.5 211.8 208.0 204.3 200.8 198.4 -Z1 .026 .034 .038 .033 .028 .036 .060 .103 .185 .393 .823 -Z2 1.752 3.463 5.742 7.746 9.181 10.142 10.579 10.387 9.600 8.387 6.895 -Z3 5.429 4.224 3.295 2.588 2.057 1.649 1.319 1.051 .837 -A -5LAT 2M -T1 293.4 286.6 273.6 259.5 244.8 230.3 216.4 204.1 197.2 197.8 202.6 -T2 208.1 212.9 217.0 220.8 224.6 229.1 234.8 241.4 248.3 255.3 261.6 -T3 266.1 268.3 268.4 266.4 263.0 259.6 254.3 248.8 243.2 234.1 229.8 -T4 222.0 215.6 211.6 208.5 205.6 202.6 199.8 198.0 -Z1 .026 .035 .037 .027 .019 .026 .052 .092 .161 .340 .721 -Z2 1.590 3.261 5.572 7.724 9.370 10.460 10.904 10.629 9.719 8.392 6.834 -Z3 5.342 4.134 3.214 2.516 1.990 1.584 1.259 .997 .790 -A 5LAT 2M -T1 293.1 286.3 273.4 259.3 244.7 230.2 216.3 204.1 197.2 197.9 203.1 -T2 208.8 213.6 217.6 221.0 224.5 228.8 234.5 241.1 248.1 255.2 261.6 -T3 266.0 268.3 268.4 266.4 263.0 259.4 253.5 247.2 241.0 232.8 226.1 -T4 217.8 211.4 207.8 205.5 203.4 201.1 198.9 197.5 -Z1 .026 .035 .038 .029 .021 .027 .048 .084 .151 .327 .702 -Z2 1.561 3.215 5.488 7.559 9.100 10.112 10.531 10.304 9.503 8.289 6.804 -Z3 5.347 4.149 3.224 2.522 1.997 1.596 1.272 1.011 .802 -A 15LAT 2M -T1 291.6 284.8 271.8 257.8 243.4 229.4 216.3 205.0 198.4 198.8 203.8 -T2 209.5 214.2 218.0 221.4 224.8 228.9 234.4 240.7 247.4 254.2 260.4 -T3 264.9 267.3 267.5 265.5 262.0 257.4 251.6 245.6 239.5 231.4 225.4 -T4 217.7 211.8 208.3 206.0 203.9 201.7 199.4 197.7 -Z1 .025 .034 .039 .037 .034 .037 .051 .086 .166 .371 .792 -Z2 1.711 3.408 5.616 7.403 8.539 9.324 9.766 9.740 9.214 8.243 6.887 -Z3 5.472 4.261 3.304 2.575 2.044 1.644 1.319 1.053 .840 -A 25LAT 2M -T1 286.7 279.8 266.7 252.7 239.2 227.1 216.8 208.5 203.5 203.2 206.5 -T2 210.8 214.7 218.2 221.4 224.7 228.6 233.7 239.5 245.7 252.0 257.7 -T3 262.0 264.4 265.0 263.3 259.8 254.5 249.5 244.5 239.6 232.7 227.9 -T4 221.4 215.9 212.3 209.5 206.7 203.9 201.2 199.0 -Z1 .025 .034 .038 .034 .033 .046 .087 .177 .350 .667 1.202 -Z2 2.202 3.880 5.877 7.243 7.896 8.413 8.865 9.082 8.923 8.298 7.131 -Z3 5.768 4.499 3.442 2.639 2.085 1.683 1.355 1.083 .864 -A 35LAT 2M -T1 279.2 272.0 258.6 244.9 232.5 223.4 217.8 214.3 211.7 210.9 211.9 -T2 213.9 216.2 218.8 221.3 224.1 227.5 231.9 237.1 242.4 247.8 252.8 -T3 256.8 259.6 260.6 259.8 256.9 251.3 247.3 243.6 239.9 234.9 231.1 -T4 225.7 220.8 216.9 213.5 210.2 206.7 203.4 201.1 -Z1 .026 .035 .037 .026 .032 .092 .232 .472 .843 1.340 1.975 -Z2 2.978 4.517 6.169 7.045 7.210 7.432 7.833 8.254 8.503 8.350 7.545 -Z3 6.353 5.006 3.754 2.796 2.186 1.771 1.431 1.144 .912 -A 45LAT 2M -T1 270.2 263.7 251.1 238.0 226.9 220.3 218.3 218.0 217.2 216.4 216.2 -T2 216.6 217.6 219.2 221.2 223.4 226.1 229.8 234.1 238.5 242.9 247.1 -T3 250.9 253.8 255.6 255.8 254.0 249.2 245.8 242.8 239.8 234.9 232.7 -T4 228.9 224.6 220.8 217.4 213.9 210.5 207.0 204.7 -Z1 .025 .033 .040 .046 .083 .190 .410 .788 1.354 2.023 2.757 -Z2 3.728 5.030 6.299 6.882 6.887 6.948 7.176 7.504 7.821 7.918 7.540 -Z3 6.735 5.483 4.123 3.041 2.372 1.930 1.568 1.261 1.011 -A 55LAT 2M -T1 262.3 257.1 246.1 233.8 223.5 218.0 217.2 217.6 217.5 216.9 216.6 -T2 216.6 217.1 218.3 220.1 222.0 224.4 227.7 231.4 235.3 239.1 242.9 -T3 246.5 249.7 252.2 253.6 253.4 250.4 247.1 243.9 240.6 235.5 233.3 -T4 230.2 227.0 223.7 220.6 217.4 214.3 211.2 209.0 -Z1 .023 .030 .043 .069 .136 .277 .526 .911 1.459 2.158 2.992 -Z2 3.991 5.133 6.163 6.687 6.775 6.824 6.909 7.036 7.180 7.225 7.051 -Z3 6.570 5.550 4.282 3.204 2.492 1.999 1.610 1.292 1.036 -A 65LAT 2M -T1 256.5 252.2 242.2 230.6 221.0 215.9 215.0 215.3 214.9 214.3 214.0 -T2 214.2 214.9 216.3 218.2 220.2 222.7 225.9 229.5 233.3 237.1 240.8 -T3 244.6 248.1 251.2 253.7 255.2 254.7 250.4 245.6 240.8 233.4 230.3 -T4 227.2 224.2 221.6 219.3 217.1 214.8 212.7 210.9 -Z1 .023 .030 .043 .071 .149 .318 .602 1.004 1.538 2.195 2.956 -Z2 3.816 4.741 5.616 6.275 6.694 6.946 7.048 7.037 6.936 6.721 6.399 -Z3 5.923 5.164 4.237 3.346 2.598 2.002 1.562 1.234 .979 -A 75LAT 2M -T1 251.5 247.7 238.5 227.7 218.9 214.3 213.3 212.9 212.0 211.0 210.7 -T2 211.2 212.3 214.0 216.0 218.3 221.0 224.4 228.2 232.2 236.1 240.0 -T3 243.9 247.6 251.2 254.8 258.0 260.0 254.4 247.7 241.0 230.7 226.0 -T4 221.3 217.2 215.4 214.4 213.5 212.6 211.7 210.7 -Z1 .023 .029 .044 .074 .156 .336 .637 1.065 1.633 2.329 3.130 -Z2 3.977 4.803 5.559 6.205 6.708 7.089 7.327 7.385 7.241 6.886 6.305 -Z3 5.581 4.842 4.127 3.405 2.675 2.037 1.558 1.205 .935 -A 85LAT 2M -T1 249.0 245.1 235.9 225.4 216.9 212.4 211.2 210.8 209.5 208.0 207.6 -T2 208.4 209.8 211.7 213.9 216.1 218.9 222.6 226.9 231.1 235.3 239.4 -T3 243.4 247.3 251.5 256.0 260.8 265.1 258.5 250.3 242.1 229.9 224.0 -T4 218.3 213.4 212.1 212.0 211.8 211.6 211.4 210.6 -Z1 .023 .029 .044 .074 .156 .336 .637 1.065 1.633 2.329 3.130 -Z2 3.977 4.803 5.559 6.205 6.708 7.089 7.327 7.385 7.241 6.886 6.305 -Z3 5.581 4.842 4.127 3.405 2.675 2.037 1.558 1.205 .935 -A-85LAT 3M -T1 252.5 247.6 239.1 230.7 224.6 223.2 224.6 225.7 225.4 224.2 223.0 -T2 222.5 222.6 223.6 225.0 226.5 227.5 227.7 228.4 232.2 238.6 245.4 -T3 251.6 256.7 260.5 262.4 262.4 259.9 256.1 252.0 248.0 245.5 238.0 -T4 230.4 223.1 216.5 210.0 203.6 197.3 190.9 187.1 -Z1 .026 .035 .037 .026 .046 .148 .340 .585 .922 1.574 2.609 -Z2 3.521 3.962 4.082 4.215 4.381 4.643 4.996 5.400 5.792 6.101 6.286 -Z3 6.180 5.441 4.313 3.250 2.456 1.869 1.442 1.127 .883 -A-75LAT 3M -T1 256.9 251.9 242.5 232.8 225.9 223.8 224.7 225.6 225.4 224.3 223.3 -T2 222.9 223.2 224.1 225.6 227.0 228.2 229.0 230.5 234.4 240.4 246.8 -T3 252.5 257.3 260.4 261.5 260.6 257.3 253.5 249.7 245.8 243.4 236.4 -T4 228.8 221.6 214.9 208.4 201.9 195.5 188.9 185.4 -Z1 .026 .035 .037 .026 .046 .148 .340 .585 .922 1.574 2.609 -Z2 3.521 3.962 4.082 4.215 4.381 4.643 4.996 5.400 5.792 6.101 6.286 -Z3 6.180 5.441 4.313 3.250 2.456 1.869 1.442 1.127 .883 -A-65LAT 3M -T1 265.4 259.6 248.3 237.0 228.7 225.1 224.9 225.2 224.8 223.9 223.3 -T2 223.2 223.8 224.9 226.4 228.0 229.6 231.5 234.1 238.2 243.5 248.8 -T3 253.7 257.5 259.9 260.4 258.8 254.9 250.6 246.3 242.0 238.2 231.7 -T4 224.2 217.1 210.5 204.0 197.6 191.3 184.7 181.9 -Z1 .025 .033 .039 .040 .061 .132 .273 .503 .878 1.582 2.679 -Z2 3.663 4.167 4.347 4.582 4.893 5.346 5.918 6.531 7.060 7.299 7.013 -Z3 6.270 5.095 3.822 2.809 2.177 1.757 1.415 1.128 .897 -A-55LAT 3M -T1 272.8 266.4 254.3 241.8 231.4 225.0 222.8 222.2 221.7 221.5 221.8 -T2 222.5 223.6 225.2 226.9 228.9 231.1 234.1 237.6 241.7 246.3 250.8 -T3 254.7 257.8 259.5 259.5 257.6 253.3 248.0 242.7 237.4 232.0 224.8 -T4 217.5 210.8 205.0 199.5 194.2 188.8 183.4 181.3 -Z1 .025 .034 .038 .035 .046 .098 .214 .421 .781 1.464 2.546 -Z2 3.561 4.144 4.458 4.964 5.657 6.413 7.121 7.675 7.956 7.794 7.023 -Z3 5.912 4.697 3.582 2.716 2.143 1.742 1.413 1.135 .910 -A-45LAT 3M -T1 279.8 273.3 260.8 247.3 234.5 224.9 219.5 217.1 216.1 216.5 218.0 -T2 219.9 222.1 224.5 227.0 229.5 232.4 236.0 240.0 244.3 248.8 253.0 -T3 256.5 259.0 260.2 259.7 257.4 252.7 246.9 241.0 235.1 228.3 221.5 -T4 214.6 208.6 203.9 199.9 195.9 191.8 187.7 186.5 -Z1 .026 .035 .038 .029 .031 .065 .154 .324 .634 1.229 2.197 -Z2 3.209 3.960 4.568 5.456 6.570 7.564 8.250 8.571 8.498 7.969 6.932 -Z3 5.691 4.507 3.497 2.714 2.165 1.762 1.431 1.155 .931 -A-35LAT 3M -T1 286.9 280.0 266.9 252.6 238.6 226.5 217.7 212.0 209.4 210.0 212.7 -T2 216.1 219.6 222.9 226.1 229.4 232.8 236.8 241.1 245.8 250.7 255.3 -T3 258.9 261.2 262.0 260.8 257.9 252.9 248.0 243.0 238.1 232.7 226.5 -T4 219.8 214.2 209.9 206.3 202.7 199.1 195.6 193.8 -Z1 .026 .035 .038 .030 .028 .050 .112 .227 .439 .872 1.629 -Z2 2.648 3.816 5.071 6.356 7.543 8.465 9.008 9.133 8.842 8.117 6.948 -Z3 5.640 4.453 3.473 2.717 2.174 1.768 1.435 1.159 .934 -A-25LAT 3M -T1 291.8 284.7 271.3 256.9 242.5 228.9 217.1 207.8 203.1 203.6 207.5 -T2 212.2 216.8 220.9 224.7 228.5 232.5 236.9 241.8 247.2 253.0 258.3 -T3 262.2 264.4 264.7 262.8 259.2 254.1 250.4 246.8 243.3 237.1 234.3 -T4 227.8 222.0 217.5 213.5 209.5 205.6 201.9 199.3 -Z1 .026 .034 .038 .033 .030 .043 .079 .147 .280 .573 1.132 -Z2 2.108 3.618 5.481 7.155 8.424 9.293 9.711 9.645 9.125 8.195 6.894 -Z3 5.525 4.338 3.387 2.657 2.124 1.719 1.389 1.117 .897 -A-15LAT 3M -T1 293.8 286.7 273.4 259.2 244.6 230.3 216.8 205.1 198.8 199.4 204.0 -T2 209.4 214.5 219.1 223.2 227.5 232.0 237.2 243.0 249.2 255.7 261.6 -T3 265.7 267.6 267.5 265.1 261.0 256.1 252.3 248.7 245.1 239.0 236.2 -T4 229.3 223.3 218.9 214.8 210.8 206.8 203.0 200.7 -Z1 .026 .034 .038 .031 .026 .034 .058 .101 .181 .386 .812 -Z2 1.737 3.442 5.735 7.807 9.328 10.251 10.531 10.151 9.227 7.969 6.548 -Z3 5.197 4.094 3.242 2.583 2.073 1.672 1.348 1.083 .870 -A -5LAT 3M -T1 293.9 287.0 273.8 259.7 245.1 230.6 216.6 204.2 197.3 198.1 203.0 -T2 208.7 213.8 218.4 222.6 226.9 231.7 237.6 244.2 251.0 257.9 263.9 -T3 267.8 269.5 268.9 266.3 262.2 257.6 252.7 247.8 242.9 234.8 231.1 -T4 223.8 217.7 213.6 210.2 206.7 203.3 200.2 198.3 -Z1 .026 .035 .038 .030 .023 .030 .055 .094 .167 .353 .748 -Z2 1.635 3.320 5.663 7.923 9.696 10.734 10.950 10.357 9.160 7.703 6.247 -Z3 4.949 3.928 3.155 2.550 2.060 1.663 1.342 1.082 .872 -A 5LAT 3M -T1 293.7 286.8 273.7 259.5 244.9 230.4 216.5 204.2 197.3 198.1 203.4 -T2 209.3 214.5 218.9 222.8 226.8 231.6 237.6 244.5 251.5 258.4 264.5 -T3 268.4 270.0 269.4 266.7 262.6 257.7 251.8 245.8 239.8 233.3 225.7 -T4 218.1 211.9 208.4 205.7 203.0 200.3 197.8 196.2 -Z1 .026 .034 .038 .033 .028 .034 .055 .092 .166 .356 .758 -Z2 1.656 3.350 5.679 7.863 9.524 10.499 10.720 10.189 9.078 7.693 6.269 -Z3 4.977 3.950 3.168 2.556 2.066 1.670 1.349 1.089 .879 -A 15LAT 3M -T1 292.6 285.6 272.2 258.0 243.5 229.5 216.3 205.0 198.5 199.0 204.1 -T2 210.0 215.1 219.3 223.2 227.1 231.6 237.3 243.7 250.4 257.1 263.1 -T3 267.2 269.1 268.7 266.2 261.9 256.3 250.3 244.3 238.3 231.0 224.4 -T4 217.5 211.9 208.6 206.1 203.7 201.4 199.0 197.3 -Z1 .025 .033 .040 .043 .046 .050 .063 .101 .190 .412 .861 -Z2 1.816 3.550 5.799 7.650 8.852 9.627 9.969 9.759 9.010 7.892 6.548 -Z3 5.227 4.133 3.279 2.618 2.111 1.713 1.389 1.122 .906 -A 25LAT 3M -T1 288.2 281.0 267.5 253.1 239.2 226.9 216.5 208.3 203.4 203.2 206.7 -T2 211.2 215.4 219.2 222.9 226.6 230.9 236.1 242.0 248.2 254.5 260.2 -T3 264.3 266.5 266.7 264.6 260.5 254.6 249.3 244.2 239.1 232.9 227.4 -T4 221.5 216.6 213.2 210.4 207.7 204.9 202.2 199.8 -Z1 .025 .033 .039 .039 .044 .066 .119 .221 .404 .728 1.260 -Z2 2.256 3.941 5.981 7.462 8.260 8.836 9.235 9.296 8.924 8.124 6.903 -Z3 5.571 4.389 3.429 2.690 2.157 1.756 1.427 1.153 .931 -A 35LAT 3M -T1 281.3 273.9 260.2 246.0 232.9 223.0 217.1 213.6 211.2 210.4 211.5 -T2 213.7 216.2 219.0 222.0 225.1 228.8 233.6 239.1 244.9 250.6 256.0 -T3 260.2 263.0 263.8 262.6 259.2 253.5 249.1 244.9 240.7 235.5 230.9 -T4 225.8 221.3 217.6 214.2 210.7 207.3 204.0 201.2 -Z1 .026 .035 .038 .029 .042 .112 .265 .517 .894 1.386 1.998 -Z2 2.965 4.467 6.143 7.177 7.577 7.986 8.481 8.845 8.874 8.411 7.310 -Z3 5.944 4.634 3.527 2.689 2.124 1.721 1.390 1.114 .890 -A 45LAT 3M -T1 273.0 266.0 253.0 239.5 227.7 220.4 218.0 217.6 216.9 216.1 215.9 -T2 216.4 217.4 219.1 221.1 223.4 226.4 230.7 235.7 240.9 246.1 251.0 -T3 255.3 258.6 260.3 260.0 257.7 252.9 249.1 245.4 241.8 235.7 233.0 -T4 228.6 224.2 220.3 216.8 213.2 209.6 206.1 203.1 -Z1 .025 .033 .040 .046 .085 .197 .424 .813 1.389 2.046 2.738 -Z2 3.638 4.852 6.085 6.765 6.955 7.258 7.756 8.295 8.670 8.586 7.728 -Z3 6.430 4.998 3.702 2.728 2.116 1.704 1.366 1.083 .856 -A 55LAT 3M -T1 265.3 259.2 247.4 234.9 224.7 219.3 218.6 219.1 219.0 218.5 218.1 -T2 218.1 218.5 219.5 221.0 222.8 225.2 228.7 233.0 237.5 242.1 246.6 -T3 250.7 254.3 256.7 257.5 256.5 252.9 249.3 245.7 242.2 236.5 233.9 -T4 229.7 225.6 222.3 219.2 216.1 213.0 209.8 207.1 -Z1 .023 .030 .043 .067 .136 .292 .565 .978 1.557 2.301 3.192 -Z2 4.184 5.205 6.065 6.486 6.554 6.736 7.101 7.580 8.042 8.218 7.782 -Z3 6.841 5.459 4.023 2.913 2.238 1.798 1.441 1.141 .901 -A 65LAT 3M -T1 258.6 253.6 243.0 231.5 222.7 218.7 218.7 219.4 219.4 219.1 219.0 -T2 219.1 219.5 220.5 221.8 223.3 225.3 228.1 231.5 235.2 239.1 243.1 -T3 247.1 250.8 253.9 255.8 256.3 254.3 250.0 245.4 240.9 234.8 230.5 -T4 226.2 222.2 219.8 217.7 215.6 213.5 211.4 209.3 -Z1 .022 .028 .046 .088 .188 .389 .701 1.104 1.622 2.368 3.367 -Z2 4.424 5.360 6.063 6.426 6.514 6.624 6.803 7.055 7.343 7.517 7.410 -Z3 6.909 5.762 4.345 3.172 2.422 1.916 1.521 1.202 .949 -A 75LAT 3M -T1 253.0 248.8 239.4 228.9 221.3 218.3 218.5 219.2 219.2 218.9 219.0 -T2 219.5 220.3 221.4 222.5 223.8 225.4 227.5 230.1 233.2 236.7 240.3 -T3 244.1 248.0 251.6 254.7 256.9 256.7 251.2 244.9 238.7 229.6 224.7 -T4 219.1 214.8 213.3 212.5 211.8 211.1 210.2 208.9 -Z1 .022 .027 .046 .093 .210 .450 .809 1.229 1.724 2.432 3.381 -Z2 4.339 5.119 5.719 6.205 6.573 6.851 7.035 7.144 7.183 7.100 6.866 -Z3 6.416 5.592 4.548 3.539 2.697 2.036 1.556 1.206 .939 -A 85LAT 3M -T1 250.9 246.8 237.5 227.3 219.9 217.0 217.4 218.3 218.3 217.8 218.0 -T2 218.9 220.1 221.3 222.3 223.4 224.6 226.3 228.4 231.1 234.2 237.6 -T3 241.5 245.6 249.8 254.0 257.5 258.9 252.7 245.4 238.1 227.7 221.9 -T4 215.6 211.4 210.1 210.0 210.0 210.0 209.8 209.0 -Z1 .022 .027 .046 .093 .210 .450 .809 1.229 1.724 2.432 3.381 -Z2 4.339 5.119 5.719 6.205 6.573 6.851 7.035 7.144 7.183 7.100 6.866 -Z3 6.416 5.592 4.548 3.539 2.697 2.036 1.556 1.206 .939 -A-85LAT 4M -T1 248.7 244.6 236.8 228.4 221.7 218.7 218.4 218.0 216.5 214.1 211.9 -T2 210.5 210.0 210.2 211.0 211.8 212.4 212.6 213.8 218.1 224.9 232.2 -T3 239.2 245.4 250.7 254.6 257.3 258.3 254.5 250.0 245.6 242.1 234.8 -T4 228.0 221.4 216.6 212.1 207.5 203.1 198.9 196.0 -Z1 .026 .036 .037 .024 .040 .135 .311 .527 .820 1.435 2.458 -Z2 3.344 3.720 3.775 3.916 4.154 4.473 4.851 5.249 5.613 5.930 6.260 -Z3 6.443 6.177 5.453 4.424 3.283 2.320 1.685 1.271 .968 -A-75LAT 4M -T1 253.9 249.3 240.3 230.4 222.8 219.4 219.2 219.2 218.0 216.0 214.0 -T2 212.8 212.2 212.3 212.9 213.5 214.1 214.8 216.5 220.7 226.9 233.7 -T3 240.2 246.0 250.6 253.7 255.3 255.3 251.8 247.7 243.7 239.6 234.0 -T4 227.8 221.4 216.5 211.7 206.9 202.2 197.4 195.1 -Z1 .026 .036 .037 .024 .040 .135 .311 .527 .820 1.435 2.458 -Z2 3.344 3.720 3.775 3.916 4.154 4.473 4.851 5.249 5.613 5.930 6.260 -Z3 6.443 6.177 5.453 4.424 3.283 2.320 1.685 1.271 .968 -A-65LAT 4M -T1 263.3 257.5 246.2 234.6 225.8 221.6 220.9 220.9 219.9 218.5 217.2 -T2 216.3 215.9 216.0 216.4 216.9 217.8 219.2 221.6 225.5 230.7 236.2 -T3 241.5 246.3 250.2 252.5 253.3 252.2 248.5 244.5 240.5 235.8 231.0 -T4 225.8 220.6 215.3 210.2 205.2 200.0 194.9 192.5 -Z1 .025 .032 .040 .048 .076 .149 .290 .519 .890 1.556 2.571 -Z2 3.527 4.114 4.408 4.651 4.867 5.173 5.580 6.060 6.558 7.005 7.386 -Z3 7.427 6.573 5.155 3.822 2.853 2.152 1.647 1.275 .991 -A-55LAT 4M -T1 271.3 264.6 252.1 239.4 228.9 222.5 220.4 220.0 219.4 218.9 218.6 -T2 218.5 218.7 219.2 219.9 220.8 222.2 224.6 227.7 231.5 235.7 240.1 -T3 244.3 248.1 251.1 252.7 252.8 250.8 246.6 242.1 237.6 232.4 227.1 -T4 222.1 217.1 212.1 207.5 202.8 198.2 193.9 191.3 -Z1 .025 .033 .039 .040 .055 .108 .225 .436 .805 1.493 2.573 -Z2 3.627 4.313 4.714 5.117 5.538 6.038 6.598 7.182 7.716 8.027 7.936 -Z3 7.364 6.106 4.584 3.340 2.560 2.041 1.628 1.289 1.018 -A-45LAT 4M -T1 278.1 271.3 258.4 244.7 232.1 222.9 218.4 216.6 215.9 216.1 217.0 -T2 218.2 219.5 221.0 222.6 224.3 226.5 229.6 233.4 237.4 241.6 245.7 -T3 249.4 252.6 254.7 255.4 254.6 251.6 246.8 241.7 236.6 230.0 224.9 -T4 219.6 214.0 209.8 206.1 202.3 198.6 194.9 193.4 -Z1 .026 .035 .038 .030 .032 .067 .159 .336 .660 1.281 2.284 -Z2 3.320 4.074 4.631 5.322 6.126 6.911 7.578 8.097 8.409 8.341 7.717 -Z3 6.698 5.393 4.084 3.051 2.387 1.933 1.563 1.252 1.000 -A-35LAT 4M -T1 284.9 277.9 264.5 250.2 236.3 224.9 217.2 212.6 210.5 210.9 213.1 -T2 215.9 218.7 221.4 224.0 226.6 229.7 233.4 237.6 242.2 246.9 251.4 -T3 255.1 257.9 259.2 258.8 256.7 252.8 248.2 243.6 239.0 233.0 228.0 -T4 221.6 216.0 211.7 208.2 204.8 201.3 197.7 196.3 -Z1 .026 .035 .038 .029 .027 .051 .117 .239 .462 .919 1.716 -Z2 2.764 3.926 5.106 6.204 7.137 7.920 8.493 8.810 8.821 8.397 7.413 -Z3 6.156 4.872 3.731 2.847 2.250 1.825 1.477 1.185 .950 -A-25LAT 4M -T1 290.3 283.2 269.8 255.4 241.0 228.0 217.0 208.6 204.2 204.7 208.3 -T2 212.8 217.1 221.0 224.5 227.9 231.7 236.1 241.0 246.3 251.7 256.8 -T3 260.6 262.9 263.5 262.0 258.8 254.0 250.0 246.2 242.3 235.7 232.5 -T4 225.6 219.5 215.2 211.6 208.0 204.4 201.0 198.6 -Z1 .026 .034 .038 .032 .029 .043 .082 .153 .289 .596 1.181 -Z2 2.190 3.718 5.551 7.105 8.203 8.970 9.387 9.413 9.041 8.254 7.035 -Z3 5.691 4.476 3.476 2.707 2.156 1.746 1.410 1.133 .909 -A-15LAT 4M -T1 293.4 286.3 273.1 258.8 244.3 230.2 216.9 205.5 199.3 200.0 204.7 -T2 210.3 215.5 220.1 224.3 228.6 233.2 238.5 244.3 250.3 256.3 261.6 -T3 265.2 266.9 266.7 264.5 260.7 255.5 251.3 247.3 243.3 236.9 233.4 -T4 225.6 219.2 215.2 211.8 208.5 205.2 202.1 199.9 -Z1 .026 .034 .038 .032 .027 .034 .058 .100 .180 .389 .827 -Z2 1.775 3.515 5.817 7.814 9.193 9.972 10.153 9.775 8.956 7.834 6.521 -Z3 5.235 4.158 3.306 2.642 2.132 1.732 1.405 1.137 .919 -A -5LAT 4M -T1 294.1 287.2 274.0 259.9 245.3 230.9 216.8 204.4 197.5 198.4 203.6 -T2 209.5 215.0 219.9 224.3 228.8 233.8 239.9 246.5 253.0 259.2 264.5 -T3 267.8 268.9 268.1 265.5 261.5 256.4 251.4 246.5 241.6 234.0 230.0 -T4 221.5 214.8 211.3 208.5 205.9 203.2 200.7 198.9 -Z1 .026 .035 .038 .029 .022 .030 .055 .096 .169 .361 .771 -Z2 1.695 3.443 5.836 8.051 9.687 10.516 10.532 9.885 8.804 7.516 6.191 -Z3 4.976 3.993 3.228 2.623 2.136 1.742 1.419 1.155 .940 -A 5LAT 4M -T1 294.3 287.3 274.0 259.9 245.3 230.7 216.7 204.3 197.5 198.5 204.1 -T2 210.4 215.9 220.5 224.7 229.0 233.9 240.0 246.8 253.3 259.6 264.9 -T3 268.2 269.2 268.3 265.6 261.6 256.2 250.7 245.2 239.7 233.2 226.6 -T4 218.2 211.4 208.1 205.5 203.1 200.6 198.3 196.7 -Z1 .025 .034 .038 .034 .032 .039 .062 .101 .179 .385 .822 -Z2 1.785 3.570 5.956 8.068 9.550 10.321 10.383 9.820 8.808 7.559 6.238 -Z3 5.010 4.012 3.235 2.623 2.134 1.740 1.418 1.154 .939 -A 15LAT 4M -T1 294.0 286.6 272.9 258.4 243.7 229.6 216.4 205.2 198.9 199.7 205.1 -T2 211.3 216.6 221.2 225.2 229.3 233.9 239.6 245.8 252.0 258.1 263.3 -T3 266.8 268.3 267.7 265.2 260.9 254.9 249.4 244.0 238.7 232.0 226.0 -T4 218.3 212.2 208.7 206.0 203.4 200.7 198.2 196.3 -Z1 .024 .032 .040 .049 .058 .068 .086 .129 .228 .476 .979 -Z2 2.010 3.820 6.087 7.850 8.894 9.546 9.830 9.615 8.895 7.822 6.522 -Z3 5.236 4.162 3.319 2.662 2.157 1.759 1.433 1.165 .946 -A 25LAT 4M -T1 290.6 283.2 269.2 254.3 239.8 226.9 216.3 208.3 203.7 203.8 207.6 -T2 212.4 217.0 221.2 225.1 229.0 233.5 238.7 244.5 250.4 256.2 261.3 -T3 265.0 266.9 266.8 264.7 260.5 254.3 249.2 244.3 239.4 233.3 227.8 -T4 221.2 215.7 211.8 208.7 205.6 202.5 199.5 197.0 -Z1 .025 .033 .040 .043 .055 .088 .156 .273 .469 .809 1.364 -Z2 2.386 4.090 6.141 7.637 8.450 9.016 9.372 9.353 8.879 8.002 6.767 -Z3 5.460 4.324 3.411 2.706 2.184 1.786 1.457 1.184 .960 -A 35LAT 4M -T1 284.8 277.3 263.3 248.5 234.6 223.5 216.7 212.9 210.7 210.2 211.7 -T2 214.4 217.4 220.7 224.0 227.5 231.6 236.8 242.7 248.5 254.3 259.5 -T3 263.5 265.9 266.5 265.0 261.4 255.7 250.8 246.0 241.2 235.1 230.0 -T4 224.0 218.5 214.2 210.3 206.4 202.4 198.6 195.4 -Z1 .025 .034 .038 .034 .050 .121 .271 .514 .878 1.350 1.939 -Z2 2.883 4.375 6.104 7.306 7.927 8.466 8.950 9.137 8.862 8.116 6.899 -Z3 5.550 4.357 3.395 2.659 2.132 1.737 1.411 1.140 .920 -A 45LAT 4M -T1 277.7 270.4 256.8 242.8 230.1 221.4 217.9 217.0 216.2 215.5 215.6 -T2 216.4 217.9 220.0 222.6 225.4 229.1 234.3 240.4 246.5 252.3 257.7 -T3 262.0 265.0 266.2 265.3 262.4 257.3 252.5 247.7 243.0 235.4 231.9 -T4 226.1 220.6 215.7 211.1 206.6 202.1 197.7 194.0 -Z1 .024 .033 .040 .047 .085 .191 .406 .778 1.331 1.951 2.589 -Z2 3.437 4.627 5.920 6.802 7.273 7.803 8.404 8.804 8.769 8.194 6.999 -Z3 5.593 4.326 3.303 2.534 2.004 1.619 1.303 1.041 .830 -A 55LAT 4M -T1 270.4 263.8 251.2 238.2 227.3 221.0 219.6 219.8 219.4 218.8 218.5 -T2 218.5 219.1 220.4 222.3 224.6 227.8 232.6 238.4 244.2 249.9 255.2 -T3 259.8 263.3 265.1 264.9 262.6 257.9 253.3 248.8 244.3 237.3 233.6 -T4 228.2 222.8 217.9 213.1 208.4 203.7 199.2 195.0 -Z1 .024 .031 .042 .061 .123 .268 .535 .953 1.542 2.246 3.031 -Z2 3.898 4.826 5.686 6.276 6.626 7.094 7.687 8.205 8.425 8.133 7.124 -Z3 5.789 4.477 3.362 2.526 1.977 1.592 1.278 1.015 .805 -A 65LAT 4M -T1 263.1 257.5 246.2 234.6 225.7 221.8 221.8 222.4 222.1 221.6 221.3 -T2 221.1 221.4 222.3 223.8 225.5 228.0 231.9 236.6 241.7 246.9 252.0 -T3 256.6 260.4 262.9 263.5 262.1 258.2 253.6 248.8 244.1 237.6 233.0 -T4 227.6 222.3 217.7 213.2 208.8 204.3 199.9 196.1 -Z1 .023 .029 .044 .074 .160 .351 .665 1.086 1.634 2.377 3.313 -Z2 4.232 4.970 5.508 5.884 6.133 6.507 7.008 7.524 7.892 7.867 7.183 -Z3 6.082 4.787 3.564 2.630 2.039 1.641 1.316 1.044 .825 -A 75LAT 4M -T1 256.2 251.6 241.8 231.6 225.0 223.1 223.9 224.7 224.6 224.2 224.0 -T2 223.9 224.1 224.8 225.7 226.9 228.6 231.3 234.8 239.0 243.6 248.2 -T3 252.8 257.0 260.1 261.7 261.5 258.6 253.6 248.3 243.0 236.9 230.6 -T4 224.5 219.0 214.6 210.7 206.9 203.1 199.2 196.0 -Z1 .022 .028 .045 .083 .193 .437 .805 1.230 1.725 2.456 3.444 -Z2 4.350 4.942 5.287 5.565 5.796 6.084 6.416 6.751 7.019 7.076 6.770 -Z3 6.106 5.009 3.781 2.783 2.139 1.698 1.350 1.066 .840 -A 85LAT 4M -T1 252.8 248.8 239.7 230.1 224.2 222.7 223.8 225.0 225.2 224.9 224.8 -T2 225.0 225.4 225.9 226.5 227.2 228.4 230.2 232.8 236.4 240.5 245.0 -T3 249.6 254.0 257.7 260.2 260.9 258.8 253.6 248.0 242.4 236.2 229.4 -T4 223.0 217.3 213.1 209.6 206.1 202.6 199.0 196.1 -Z1 .022 .028 .045 .083 .193 .437 .805 1.230 1.725 2.456 3.444 -Z2 4.350 4.942 5.287 5.565 5.796 6.084 6.416 6.751 7.019 7.076 6.770 -Z3 6.106 5.009 3.781 2.783 2.139 1.698 1.350 1.066 .840 -A-85LAT 5M -T1 247.3 243.4 235.8 226.8 218.6 213.7 211.7 210.2 207.2 203.0 199.7 -T2 198.0 197.8 198.6 200.1 201.6 202.8 203.6 205.3 210.6 218.9 227.8 -T3 236.1 243.3 249.3 253.8 257.0 259.3 254.9 249.5 244.1 237.6 231.7 -T4 225.1 220.0 216.6 214.0 211.5 209.0 206.7 205.0 -Z1 .024 .032 .040 .050 .078 .146 .281 .514 .900 1.564 2.547 -Z2 3.463 4.022 4.316 4.611 4.923 5.290 5.704 6.130 6.520 6.850 7.170 -Z3 7.296 6.888 5.977 4.781 3.528 2.491 1.805 1.355 1.026 -A-75LAT 5M -T1 252.2 248.1 239.4 229.1 220.0 214.7 212.8 211.7 209.3 205.8 202.9 -T2 201.2 200.7 201.0 201.8 202.8 203.8 204.8 207.0 212.1 219.7 227.8 -T3 235.6 242.5 248.2 252.2 255.1 257.7 253.5 248.4 243.2 235.8 231.7 -T4 226.5 221.3 217.9 214.9 212.0 209.0 206.2 204.5 -Z1 .024 .032 .040 .050 .078 .146 .281 .514 .900 1.564 2.547 -Z2 3.463 4.022 4.316 4.611 4.923 5.290 5.704 6.130 6.520 6.850 7.170 -Z3 7.296 6.888 5.977 4.781 3.528 2.491 1.805 1.355 1.026 -A-65LAT 5M -T1 261.5 256.1 245.0 233.0 223.2 217.7 216.1 215.4 213.8 211.6 209.5 -T2 208.0 207.0 206.6 206.6 206.7 207.2 208.5 210.9 215.2 221.1 227.5 -T3 233.8 239.8 245.0 248.9 252.0 254.7 250.8 245.9 241.1 233.4 230.4 -T4 227.3 224.2 220.2 216.4 212.5 208.8 204.9 203.6 -Z1 .024 .032 .040 .050 .078 .146 .281 .514 .900 1.564 2.547 -Z2 3.463 4.022 4.316 4.611 4.923 5.290 5.704 6.130 6.520 6.850 7.170 -Z3 7.296 6.888 5.977 4.781 3.528 2.491 1.805 1.355 1.026 -A-55LAT 5M -T1 269.7 263.0 250.2 237.3 226.5 220.0 218.1 217.7 217.1 216.2 215.2 -T2 214.3 213.5 213.0 212.7 212.6 213.1 214.6 217.1 220.6 224.9 229.4 -T3 234.3 239.1 243.5 246.9 249.5 251.2 247.7 243.4 239.0 232.5 229.4 -T4 226.6 223.2 219.3 215.3 211.5 207.6 203.9 201.9 -Z1 .024 .031 .041 .056 .086 .143 .257 .472 .851 1.523 2.546 -Z2 3.600 4.404 4.958 5.386 5.705 6.024 6.358 6.731 7.143 7.567 8.082 -Z3 8.326 7.509 5.951 4.420 3.262 2.416 1.826 1.409 1.092 -A-45LAT 5M -T1 276.3 269.2 255.8 242.1 229.9 221.5 217.8 216.7 216.3 216.2 216.4 -T2 216.7 217.1 217.6 218.1 218.8 220.1 222.3 225.2 228.7 232.5 236.5 -T3 240.5 244.4 247.5 249.6 250.4 249.8 246.1 241.9 237.7 231.9 228.3 -T4 224.7 219.5 215.8 212.3 208.9 205.3 202.0 200.5 -Z1 .025 .034 .038 .033 .039 .080 .182 .376 .727 1.396 2.467 -Z2 3.578 4.404 4.970 5.482 5.949 6.460 7.006 7.564 8.072 8.398 8.426 -Z3 7.987 6.705 5.046 3.665 2.797 2.220 1.766 1.396 1.102 -A-35LAT 5M -T1 283.1 275.8 262.2 247.9 234.5 223.9 217.1 213.4 211.7 212.1 213.8 -T2 216.0 218.1 220.1 221.9 223.8 226.1 229.1 232.8 236.9 241.4 245.8 -T3 249.8 252.9 254.8 255.0 253.7 250.9 247.1 243.2 239.3 233.5 229.6 -T4 223.5 217.8 213.7 210.2 206.8 203.5 200.0 198.6 -Z1 .026 .035 .038 .030 .030 .059 .132 .267 .511 1.010 1.873 -Z2 2.969 4.122 5.201 6.064 6.687 7.275 7.833 8.312 8.624 8.575 7.951 -Z3 6.909 5.548 4.176 3.098 2.413 1.948 1.570 1.253 .997 -A-25LAT 5M -T1 288.8 281.7 268.4 254.1 240.1 227.4 217.0 209.1 205.2 206.0 209.4 -T2 213.6 217.5 220.9 223.9 226.9 230.3 234.2 238.8 243.8 249.2 254.2 -T3 258.1 260.7 261.5 260.2 257.4 253.2 249.2 245.2 241.1 234.2 230.8 -T4 223.5 217.1 212.9 209.7 206.5 203.2 200.1 197.9 -Z1 .025 .034 .038 .033 .032 .046 .086 .160 .302 .630 1.261 -Z2 2.318 3.864 5.627 6.973 7.791 8.399 8.824 8.998 8.860 8.311 7.257 -Z3 5.984 4.739 3.658 2.820 2.240 1.818 1.472 1.184 .951 -A-15LAT 5M -T1 292.5 285.6 272.6 258.4 244.0 230.1 217.1 205.9 200.1 201.1 205.8 -T2 211.3 216.3 220.6 224.5 228.4 232.7 237.6 243.1 248.9 254.8 260.1 -T3 263.8 265.6 265.5 263.5 260.0 255.3 250.8 246.2 241.7 234.7 230.5 -T4 221.9 215.1 211.5 208.8 206.2 203.7 201.2 199.1 -Z1 .025 .034 .038 .034 .031 .037 .058 .098 .180 .398 .859 -Z2 1.848 3.638 5.929 7.750 8.855 9.471 9.645 9.397 8.787 7.864 6.661 -Z3 5.414 4.320 3.427 2.727 2.202 1.798 1.466 1.191 .966 -A -5LAT 5M -T1 293.8 286.9 274.0 259.9 245.4 231.0 217.1 204.8 198.2 199.3 204.7 -T2 210.6 216.0 220.6 224.7 229.0 233.7 239.4 245.7 251.8 257.8 263.0 -T3 266.3 267.5 266.8 264.5 260.9 256.3 251.2 246.1 240.9 233.3 228.4 -T4 219.3 212.4 209.0 207.0 205.0 203.0 201.0 199.3 -Z1 .026 .034 .038 .031 .025 .032 .056 .095 .169 .368 .795 -Z2 1.755 3.560 5.957 7.998 9.349 10.019 10.051 9.574 8.747 7.676 6.439 -Z3 5.226 4.195 3.369 2.716 2.210 1.810 1.480 1.208 .985 -A 5LAT 5M -T1 294.3 287.4 274.2 260.0 245.4 230.9 217.0 204.7 198.2 199.4 205.2 -T2 211.5 216.8 221.3 225.2 229.2 233.8 239.6 246.0 252.3 258.3 263.5 -T3 266.7 267.9 267.1 264.6 260.8 256.0 250.7 245.4 240.1 233.0 227.5 -T4 218.3 211.2 207.8 205.5 203.3 201.0 198.8 197.1 -Z1 .026 .034 .038 .032 .027 .036 .062 .103 .181 .393 .848 -Z2 1.850 3.700 6.114 8.115 9.393 10.040 10.102 9.649 8.809 7.709 6.446 -Z3 5.214 4.180 3.358 2.710 2.206 1.805 1.475 1.204 .981 -A 15LAT 5M -T1 294.9 287.4 273.6 259.1 244.4 230.1 216.7 205.4 199.4 200.7 206.3 -T2 212.5 217.7 222.0 225.8 229.6 234.0 239.4 245.4 251.5 257.4 262.7 -T3 266.2 267.7 267.2 264.8 260.7 255.0 249.9 244.8 239.7 232.8 227.6 -T4 219.3 212.6 208.8 205.8 202.9 200.0 197.3 195.3 -Z1 .025 .032 .040 .047 .057 .072 .100 .150 .252 .510 1.039 -Z2 2.111 3.963 6.250 7.979 8.957 9.564 9.836 9.630 8.929 7.874 6.587 -Z3 5.305 4.230 3.383 2.721 2.210 1.806 1.475 1.201 .978 -A 25LAT 5M -T1 292.8 285.3 271.1 256.2 241.5 228.0 216.6 208.1 203.7 204.5 208.7 -T2 213.8 218.4 222.4 226.1 229.9 234.1 239.3 245.1 251.0 256.8 262.0 -T3 265.7 267.5 267.4 265.2 261.0 255.0 249.9 245.0 240.1 233.4 228.5 -T4 220.9 214.7 210.5 206.9 203.4 200.0 196.6 193.9 -Z1 .025 .033 .040 .043 .057 .096 .171 .294 .491 .833 1.391 -Z2 2.414 4.117 6.177 7.715 8.588 9.186 9.535 9.452 8.875 7.909 6.647 -Z3 5.354 4.255 3.383 2.707 2.195 1.796 1.467 1.195 .972 -A 35LAT 5M -T1 288.4 280.8 266.5 251.6 237.2 225.2 217.2 212.8 210.5 210.5 212.6 -T2 215.7 219.2 222.6 226.1 229.7 233.9 239.2 245.2 251.2 256.8 262.0 -T3 265.8 267.9 268.2 266.4 262.5 256.4 251.2 246.2 241.2 234.3 229.3 -T4 222.0 215.7 210.8 206.4 202.0 197.5 193.2 189.7 -Z1 .025 .034 .038 .035 .051 .119 .261 .495 .845 1.300 1.867 -Z2 2.798 4.303 6.094 7.418 8.181 8.776 9.207 9.233 8.740 7.824 6.573 -Z3 5.276 4.171 3.298 2.625 2.122 1.734 1.414 1.148 .931 -A 45LAT 5M -T1 282.4 274.8 260.8 246.3 233.0 223.4 219.0 217.6 216.7 216.1 216.6 -T2 218.0 220.0 222.8 225.9 229.4 233.6 239.1 245.5 251.5 257.2 262.4 -T3 266.3 268.8 269.5 268.0 264.6 258.7 253.4 248.3 243.1 235.0 231.0 -T4 223.5 216.9 211.1 205.6 200.2 194.6 189.3 184.7 -Z1 .024 .032 .040 .049 .083 .175 .367 .713 1.239 1.819 2.399 -Z2 3.218 4.462 5.897 6.962 7.609 8.197 8.706 8.855 8.482 7.650 6.434 -Z3 5.145 4.042 3.172 2.508 2.019 1.646 1.339 1.083 .875 -A 55LAT 5M -T1 276.1 268.9 255.6 241.9 230.1 223.1 221.2 221.2 220.8 220.2 220.1 -T2 220.5 221.7 223.8 226.5 229.7 233.7 239.2 245.5 251.6 257.3 262.5 -T3 266.7 269.5 270.6 269.6 266.7 261.3 256.1 250.9 245.8 237.7 233.8 -T4 226.6 219.8 213.3 207.1 200.8 194.5 188.4 183.0 -Z1 .024 .031 .042 .060 .113 .237 .473 .870 1.446 2.099 2.779 -Z2 3.575 4.538 5.538 6.325 6.883 7.475 8.056 8.337 8.123 7.424 6.270 -Z3 5.003 3.905 3.037 2.379 1.904 1.548 1.254 1.011 .813 -A 65LAT 5M -T1 269.8 263.6 251.4 238.7 228.7 224.1 223.9 224.3 224.0 223.6 223.4 -T2 223.6 224.4 226.1 228.4 231.1 234.6 239.5 245.3 251.1 256.8 262.1 -T3 266.5 269.8 271.4 271.0 268.5 263.7 258.5 253.2 248.0 240.4 235.7 -T4 228.9 222.2 215.5 208.6 201.8 195.1 188.6 183.1 -Z1 .023 .030 .043 .067 .136 .292 .567 .986 1.566 2.266 3.052 -Z2 3.825 4.505 5.077 5.566 5.981 6.506 7.094 7.495 7.499 7.033 6.046 -Z3 4.874 3.810 2.944 2.286 1.825 1.486 1.207 .973 .783 -A 75LAT 5M -T1 263.7 258.5 247.7 236.3 228.5 226.0 226.7 227.2 227.0 226.6 226.6 -T2 226.8 227.5 228.8 230.6 232.6 235.5 239.6 244.7 250.2 255.8 261.2 -T3 265.9 269.6 271.8 272.0 270.1 266.0 260.7 255.2 249.7 243.7 236.7 -T4 229.8 222.8 215.9 209.0 202.0 195.1 188.3 183.1 -Z1 .023 .030 .043 .072 .164 .379 .719 1.138 1.642 2.303 3.111 -Z2 3.822 4.278 4.553 4.820 5.096 5.509 6.027 6.493 6.733 6.586 5.888 -Z3 4.903 3.868 2.944 2.234 1.763 1.433 1.161 .933 .748 -A 85LAT 5M -T1 260.8 256.0 245.6 234.9 228.2 226.5 227.5 228.3 228.1 227.6 227.5 -T2 228.0 228.9 230.0 231.4 232.9 235.3 238.9 243.6 248.8 254.4 259.8 -T3 264.8 268.9 271.6 272.4 271.4 268.1 262.5 256.6 250.8 244.1 237.2 -T4 230.2 223.1 216.2 209.2 202.2 195.2 188.4 183.1 -Z1 .023 .030 .043 .072 .164 .379 .719 1.138 1.642 2.303 3.111 -Z2 3.822 4.278 4.553 4.820 5.096 5.509 6.027 6.493 6.733 6.586 5.888 -Z3 4.903 3.868 2.944 2.234 1.763 1.433 1.161 .933 .748 -A-85LAT 6M -T1 245.1 241.3 233.6 224.3 215.5 209.5 206.2 203.7 200.2 195.9 192.6 -T2 191.1 191.3 192.7 194.9 197.1 199.0 200.2 202.6 209.0 218.6 228.9 -T3 238.3 246.3 252.7 257.3 261.0 264.9 259.1 251.9 244.6 233.6 228.7 -T4 222.7 218.1 216.5 216.0 215.4 214.8 214.2 214.2 -Z1 .025 .032 .040 .047 .071 .131 .256 .489 .891 1.589 2.620 -Z2 3.567 4.120 4.387 4.665 4.971 5.348 5.785 6.217 6.570 6.823 7.024 -Z3 7.036 6.636 5.827 4.713 3.472 2.430 1.743 1.295 .972 -A-75LAT 6M -T1 250.4 246.3 237.4 226.8 217.1 210.6 207.4 205.3 202.4 198.6 195.6 -T2 194.0 193.8 194.8 196.4 198.2 199.9 201.6 204.5 210.7 219.6 229.0 -T3 237.8 245.3 251.3 255.6 259.0 263.0 257.6 250.8 244.0 231.5 229.3 -T4 225.3 221.5 219.3 218.1 216.9 215.7 214.6 214.1 -Z1 .025 .032 .040 .047 .071 .131 .256 .489 .891 1.589 2.620 -Z2 3.567 4.120 4.387 4.665 4.971 5.348 5.785 6.217 6.570 6.823 7.024 -Z3 7.036 6.636 5.827 4.713 3.472 2.430 1.743 1.295 .972 -A-65LAT 6M -T1 260.2 254.7 243.4 231.1 220.7 214.2 211.5 210.1 208.0 205.4 203.0 -T2 201.4 200.6 200.5 200.9 201.6 202.6 204.3 207.3 212.6 219.7 227.2 -T3 234.4 241.1 246.7 251.0 254.7 259.0 254.4 248.4 242.4 230.9 229.7 -T4 229.0 227.7 225.0 222.5 220.1 217.6 215.1 214.3 -Z1 .025 .032 .040 .047 .071 .131 .256 .489 .891 1.589 2.620 -Z2 3.567 4.120 4.387 4.665 4.971 5.348 5.785 6.217 6.570 6.823 7.024 -Z3 7.036 6.636 5.827 4.713 3.472 2.430 1.743 1.295 .972 -A-55LAT 6M -T1 268.7 261.8 248.7 235.5 224.5 217.7 215.3 214.7 213.8 212.5 211.0 -T2 209.8 208.8 208.1 207.7 207.5 207.9 209.5 212.2 216.2 221.1 226.5 -T3 232.1 237.6 242.7 246.8 250.4 254.0 250.5 246.0 241.4 232.7 231.8 -T4 230.9 229.6 226.4 223.3 220.1 217.1 213.8 212.5 -Z1 .024 .031 .041 .056 .086 .145 .266 .506 .933 1.648 2.688 -Z2 3.702 4.408 4.846 5.202 5.491 5.770 6.049 6.338 6.642 6.978 7.532 -Z3 7.961 7.473 6.195 4.721 3.413 2.407 1.756 1.332 1.022 -A-45LAT 6M -T1 275.2 267.8 254.1 240.3 228.3 220.4 217.1 216.1 215.6 215.3 215.1 -T2 215.0 215.0 215.0 215.1 215.4 216.2 218.2 221.0 224.6 228.7 233.0 -T3 237.6 242.0 245.8 248.4 250.1 251.0 247.8 243.9 240.0 233.6 231.8 -T4 229.5 225.2 221.7 218.5 215.3 212.1 209.0 207.6 -Z1 .025 .034 .039 .036 .048 .096 .206 .411 .778 1.486 2.628 -Z2 3.807 4.674 5.237 5.659 5.969 6.336 6.783 7.283 7.780 8.192 8.503 -Z3 8.392 7.206 5.442 3.921 2.938 2.274 1.774 1.384 1.080 -A-35LAT 6M -T1 281.5 274.1 260.5 246.3 233.5 223.6 217.5 214.0 212.4 212.6 214.1 -T2 215.9 217.7 219.3 220.8 222.4 224.4 227.3 230.9 235.1 239.8 244.4 -T3 248.6 252.1 254.2 254.6 253.5 251.3 247.8 244.1 240.5 233.9 231.2 -T4 225.3 219.6 215.6 212.4 209.0 205.7 202.3 200.9 -Z1 .026 .035 .038 .031 .034 .070 .157 .309 .579 1.124 2.056 -Z2 3.198 4.333 5.338 6.108 6.636 7.149 7.660 8.118 8.436 8.436 7.930 -Z3 7.006 5.679 4.279 3.164 2.456 1.978 1.592 1.269 1.009 -A-25LAT 6M -T1 287.2 280.3 267.2 253.3 239.6 227.4 217.4 209.8 206.1 206.9 210.3 -T2 214.1 217.6 220.8 223.5 226.4 229.6 233.5 238.0 243.1 248.6 253.8 -T3 257.9 260.6 261.5 260.2 257.3 253.2 248.8 244.5 240.2 232.9 228.9 -T4 221.3 214.7 210.6 207.8 204.9 202.1 199.2 197.4 -Z1 .025 .034 .038 .035 .035 .050 .089 .164 .314 .667 1.349 -Z2 2.456 4.007 5.691 6.858 7.453 7.916 8.309 8.540 8.514 8.110 7.200 -Z3 6.033 4.821 3.726 2.867 2.282 1.861 1.515 1.225 .988 -A-15LAT 6M -T1 291.4 284.7 272.0 258.1 243.8 230.0 217.2 206.5 201.1 202.4 207.1 -T2 212.1 216.6 220.6 224.2 227.8 231.8 236.6 241.9 247.6 253.6 258.9 -T3 262.7 264.7 264.7 262.9 259.4 254.8 249.9 244.9 240.0 232.6 227.4 -T4 218.2 211.1 207.7 205.8 204.0 202.1 200.2 198.4 -Z1 .025 .034 .039 .037 .035 .041 .059 .096 .179 .411 .907 -Z2 1.948 3.782 6.028 7.621 8.409 8.867 9.086 9.019 8.646 7.934 6.840 -Z3 5.618 4.485 3.528 2.778 2.237 1.830 1.494 1.214 .985 -A -5LAT 6M -T1 292.9 286.2 273.4 259.5 245.0 230.8 217.3 205.6 199.5 200.9 206.1 -T2 211.6 216.4 220.5 224.3 228.2 232.5 237.9 243.9 249.9 255.9 261.1 -T3 264.5 265.9 265.4 263.3 259.9 255.6 250.5 245.2 240.0 232.5 226.9 -T4 217.1 209.9 206.8 205.4 204.1 202.8 201.5 199.8 -Z1 .025 .034 .038 .034 .030 .037 .058 .096 .172 .383 .837 -Z2 1.840 3.687 6.052 7.889 8.953 9.527 9.676 9.424 8.830 7.924 6.723 -Z3 5.468 4.364 3.461 2.754 2.227 1.820 1.486 1.209 .982 -A 5LAT 6M -T1 293.8 286.9 273.8 259.7 245.2 230.9 217.2 205.5 199.4 201.0 206.7 -T2 212.5 217.3 221.3 224.8 228.5 232.7 238.2 244.3 250.4 256.4 261.5 -T3 264.9 266.1 265.6 263.5 260.0 255.6 250.6 245.6 240.5 232.8 228.1 -T4 218.4 211.0 207.5 205.4 203.4 201.3 199.4 197.6 -Z1 .026 .034 .038 .032 .028 .039 .067 .111 .190 .410 .885 -Z2 1.920 3.804 6.208 8.089 9.195 9.793 9.941 9.641 8.952 7.951 6.694 -Z3 5.418 4.321 3.440 2.750 2.227 1.819 1.484 1.207 .981 -A 15LAT 6M -T1 295.3 287.8 273.9 259.5 245.0 230.6 217.1 205.9 200.3 201.9 207.5 -T2 213.3 218.1 222.0 225.4 228.9 233.0 238.2 244.0 250.0 255.9 261.1 -T3 264.6 266.2 266.0 263.9 260.3 255.2 250.4 245.7 240.9 233.8 229.3 -T4 220.2 213.0 208.8 205.7 202.6 199.4 196.5 194.2 -Z1 .025 .033 .040 .044 .052 .071 .106 .161 .261 .520 1.057 -Z2 2.147 4.030 6.338 8.044 8.968 9.540 9.812 9.648 9.017 8.022 6.750 -Z3 5.454 4.349 3.468 2.780 2.256 1.846 1.508 1.229 1.000 -A 25LAT 6M -T1 295.0 287.3 273.0 258.3 243.8 229.9 217.6 208.1 203.4 204.6 209.2 -T2 214.3 218.8 222.6 226.1 229.7 233.8 238.9 244.6 250.4 256.0 261.1 -T3 264.6 266.4 266.4 264.6 260.9 255.3 250.3 245.5 240.7 233.5 229.2 -T4 220.6 213.7 209.1 205.2 201.4 197.5 193.8 191.0 -Z1 .025 .033 .040 .043 .055 .090 .159 .275 .467 .799 1.343 -Z2 2.358 4.073 6.162 7.725 8.613 9.212 9.549 9.464 8.901 7.956 6.711 -Z3 5.427 4.328 3.451 2.767 2.250 1.846 1.513 1.235 1.007 -A 35LAT 6M -T1 292.1 284.3 269.9 255.1 240.7 228.1 218.7 212.6 209.6 209.9 212.7 -T2 216.4 220.1 223.7 227.1 230.6 234.8 240.1 245.9 251.7 257.1 262.0 -T3 265.6 267.6 267.8 266.1 262.5 256.6 251.3 246.1 240.9 233.3 228.6 -T4 220.2 212.8 207.5 202.5 197.5 192.5 187.8 183.9 -Z1 .025 .034 .039 .036 .049 .101 .216 .419 .741 1.168 1.710 -Z2 2.633 4.167 6.022 7.406 8.207 8.794 9.178 9.155 8.638 7.725 6.507 -Z3 5.247 4.173 3.319 2.657 2.158 1.771 1.450 1.183 .963 -A 45LAT 6M -T1 286.6 279.0 264.8 250.2 236.4 225.9 220.4 218.1 216.7 216.4 217.4 -T2 219.4 221.9 225.0 228.3 231.9 236.1 241.6 247.8 253.6 259.1 263.9 -T3 267.6 269.8 270.2 268.7 265.3 259.5 253.9 248.4 242.9 234.3 229.6 -T4 221.1 213.1 206.3 200.0 193.6 187.1 181.0 175.6 -Z1 .025 .033 .040 .043 .066 .136 .295 .605 1.098 1.637 2.167 -Z2 2.967 4.272 5.824 6.964 7.628 8.182 8.620 8.684 8.243 7.390 6.217 -Z3 4.997 3.958 3.136 2.503 2.029 1.664 1.361 1.108 .901 -A 55LAT 6M -T1 281.2 273.9 260.3 246.1 233.3 225.0 222.5 222.2 221.8 221.4 221.7 -T2 222.7 224.3 226.9 230.0 233.5 237.8 243.4 249.7 255.7 261.2 266.1 -T3 269.9 272.2 272.9 271.7 268.7 263.3 257.7 252.2 246.6 238.3 233.1 -T4 225.1 216.8 208.9 201.1 193.1 185.2 177.5 171.1 -Z1 .024 .032 .041 .051 .088 .184 .385 .759 1.329 1.937 2.515 -Z2 3.252 4.281 5.428 6.306 6.881 7.439 7.942 8.102 7.753 6.980 5.870 -Z3 4.702 3.710 2.932 2.335 1.890 1.548 1.265 1.029 .836 -A 65LAT 6M -T1 276.4 269.8 257.1 243.5 232.0 225.8 225.0 225.4 225.3 225.3 225.6 -T2 226.3 227.6 229.8 232.6 235.8 239.8 245.2 251.3 257.2 262.8 267.8 -T3 271.8 274.4 275.3 274.5 271.8 266.6 261.4 256.1 250.9 243.2 237.8 -T4 230.3 222.0 213.1 204.1 195.0 185.9 176.7 170.5 -Z1 .024 .032 .041 .055 .102 .218 .453 .869 1.476 2.113 2.703 -Z2 3.329 4.039 4.751 5.324 5.755 6.277 6.843 7.158 7.014 6.436 5.464 -Z3 4.387 3.460 2.729 2.171 1.760 1.446 1.185 .967 .787 -A 75LAT 6M -T1 270.9 265.3 253.9 241.4 232.0 228.0 228.2 228.8 228.8 228.8 229.2 -T2 229.9 231.0 232.9 235.3 238.0 241.4 246.3 252.0 257.8 263.5 268.7 -T3 273.0 275.9 277.3 276.8 274.4 269.5 264.6 259.7 254.8 250.3 242.8 -T4 235.2 226.8 217.2 207.2 197.1 187.0 177.6 170.1 -Z1 .023 .031 .042 .064 .131 .285 .560 .978 1.540 2.145 2.736 -Z2 3.290 3.788 4.218 4.592 4.922 5.401 5.993 6.447 6.539 6.186 5.332 -Z3 4.292 3.351 2.591 2.014 1.609 1.311 1.065 .859 .692 -A 85LAT 6M -T1 267.2 262.1 251.3 239.9 232.2 229.5 230.0 230.7 230.6 230.3 230.6 -T2 231.4 232.6 234.3 236.3 238.6 241.7 246.2 251.6 257.3 263.0 268.5 -T3 273.0 276.4 278.2 278.2 276.3 271.8 266.8 261.9 256.9 252.3 244.8 -T4 237.4 229.2 219.2 208.8 198.3 187.7 178.0 157.7 -Z1 .023 .031 .042 .064 .131 .285 .560 .978 1.540 2.145 2.736 -Z2 3.290 3.788 4.218 4.592 4.922 5.401 5.993 6.447 6.539 6.186 5.332 -Z3 4.292 3.351 2.591 2.014 1.609 1.311 1.065 .859 .692 -A-85LAT 7M -T1 246.2 242.2 234.0 224.1 214.2 206.5 201.6 198.1 194.3 190.1 187.1 -T2 186.0 186.8 189.3 192.7 196.2 199.3 201.7 205.2 212.9 223.9 235.3 -T3 245.5 253.7 260.1 264.2 267.3 270.8 263.5 254.7 245.8 232.0 226.3 -T4 220.5 215.6 214.3 214.0 213.6 213.2 212.8 212.5 -Z1 .024 .032 .041 .050 .077 .141 .274 .520 .943 1.657 2.691 -Z2 3.612 4.112 4.329 4.601 4.939 5.352 5.813 6.235 6.530 6.678 6.735 -Z3 6.564 5.880 4.831 3.741 2.794 2.050 1.531 1.169 .898 -A-75LAT 7M -T1 250.2 246.1 237.1 226.1 215.4 207.4 202.8 200.0 196.7 193.0 190.1 -T2 188.9 189.3 191.3 194.2 197.3 200.4 203.5 207.8 215.5 225.9 236.6 -T3 246.1 253.8 259.6 263.1 265.5 268.3 261.6 253.5 245.4 231.1 227.7 -T4 223.4 219.2 217.3 216.3 215.2 214.2 213.1 212.5 -Z1 .024 .032 .041 .050 .077 .141 .274 .520 .943 1.657 2.691 -Z2 3.612 4.112 4.329 4.601 4.939 5.352 5.813 6.235 6.530 6.678 6.735 -Z3 6.564 5.880 4.831 3.741 2.794 2.050 1.531 1.169 .898 -A-65LAT 7M -T1 259.3 253.8 242.5 230.1 219.0 211.5 207.9 205.8 203.5 200.7 198.4 -T2 197.0 196.7 197.5 199.0 200.8 203.1 206.4 211.0 218.0 226.7 235.5 -T3 243.5 250.2 255.3 258.6 260.9 263.5 257.9 251.2 244.4 232.0 230.1 -T4 228.1 225.9 223.4 221.0 218.6 216.3 214.0 212.5 -Z1 .024 .032 .041 .050 .077 .141 .274 .520 .943 1.657 2.691 -Z2 3.612 4.112 4.329 4.601 4.939 5.352 5.813 6.235 6.530 6.678 6.735 -Z3 6.564 5.880 4.831 3.741 2.794 2.050 1.531 1.169 .898 -A-55LAT 7M -T1 267.9 261.1 248.0 234.7 223.4 216.2 213.5 212.6 211.5 210.1 208.7 -T2 207.5 206.8 206.7 206.9 207.5 208.9 211.8 215.9 221.3 227.6 234.0 -T3 240.1 245.5 249.9 252.9 255.0 256.6 252.6 247.8 243.0 234.1 232.6 -T4 230.5 228.3 225.0 222.0 218.8 215.7 212.6 211.0 -Z1 .024 .031 .042 .059 .092 .152 .279 .544 1.020 1.781 2.843 -Z2 3.851 4.531 4.928 5.222 5.440 5.708 6.041 6.421 6.811 7.179 7.597 -Z3 7.730 6.872 5.367 3.936 2.885 2.128 1.601 1.227 .944 -A-45LAT 7M -T1 274.6 267.2 253.5 239.7 227.8 220.1 216.9 216.0 215.3 214.8 214.6 -T2 214.6 214.8 215.2 215.7 216.4 217.9 220.6 224.3 228.6 233.4 238.3 -T3 242.9 247.1 250.2 251.9 252.4 251.4 248.0 244.3 240.5 234.2 232.3 -T4 229.0 224.9 221.3 218.0 214.6 211.3 208.1 205.9 -Z1 .025 .033 .040 .043 .061 .116 .237 .468 .880 1.627 2.779 -Z2 3.941 4.777 5.306 5.701 5.993 6.363 6.827 7.353 7.868 8.234 8.328 -Z3 7.953 6.700 5.041 3.652 2.775 2.189 1.734 1.367 1.077 -A-35LAT 7M -T1 280.7 273.3 259.7 245.7 233.2 223.8 218.0 214.6 213.0 213.1 214.5 -T2 216.2 218.1 219.8 221.5 223.3 225.7 228.9 232.9 237.4 242.2 246.9 -T3 251.0 254.2 256.0 256.0 254.2 250.6 247.0 243.5 239.9 234.3 231.1 -T4 225.4 220.1 216.3 212.9 209.6 206.3 202.8 201.1 -Z1 .025 .034 .038 .034 .041 .086 .186 .354 .646 1.222 2.192 -Z2 3.345 4.442 5.382 6.104 6.609 7.113 7.623 8.068 8.347 8.294 7.729 -Z3 6.778 5.514 4.212 3.169 2.493 2.028 1.649 1.329 1.070 -A-25LAT 7M -T1 286.4 279.6 266.7 252.8 239.3 227.3 217.6 210.4 207.0 207.9 211.1 -T2 214.6 217.9 220.9 223.6 226.4 229.6 233.6 238.2 243.4 249.0 254.2 -T3 258.2 260.9 261.7 260.4 257.3 252.6 248.2 243.8 239.4 232.9 228.4 -T4 221.4 215.3 211.5 208.6 205.8 203.0 200.1 198.3 -Z1 .025 .034 .039 .036 .039 .057 .102 .185 .344 .719 1.437 -Z2 2.566 4.095 5.717 6.819 7.365 7.828 8.268 8.547 8.539 8.132 7.210 -Z3 6.034 4.828 3.746 2.897 2.314 1.893 1.546 1.253 1.014 -A-15LAT 7M -T1 290.6 284.1 271.5 257.6 243.2 229.5 217.0 206.8 202.1 203.8 208.3 -T2 212.8 216.8 220.4 223.7 227.0 230.8 235.5 240.8 246.6 252.6 258.1 -T3 262.1 264.3 264.5 262.7 259.3 254.8 249.7 244.4 239.2 232.0 226.4 -T4 218.0 211.5 208.0 205.9 203.9 201.9 199.9 198.1 -Z1 .025 .033 .039 .039 .040 .045 .062 .099 .186 .427 .942 -Z2 2.003 3.845 6.071 7.606 8.327 8.792 9.090 9.118 8.804 8.107 6.978 -Z3 5.702 4.525 3.537 2.769 2.220 1.810 1.473 1.192 .964 -A -5LAT 7M -T1 292.0 285.4 272.8 258.8 244.2 230.1 217.0 205.9 200.6 202.5 207.5 -T2 212.4 216.6 220.3 223.7 227.2 231.2 236.4 242.2 248.3 254.5 259.9 -T3 263.6 265.3 265.1 263.2 260.1 256.2 250.9 245.4 239.9 232.5 226.5 -T4 217.5 210.7 207.3 205.5 203.7 201.9 200.2 198.6 -Z1 .025 .034 .039 .037 .035 .043 .063 .101 .180 .396 .861 -Z2 1.872 3.716 6.062 7.866 8.903 9.520 9.771 9.613 9.059 8.139 6.877 -Z3 5.550 4.390 3.452 2.726 2.189 1.780 1.444 1.167 .942 -A 5LAT 7M -T1 293.1 286.1 273.1 259.0 244.5 230.2 216.9 205.9 200.6 202.6 207.9 -T2 213.2 217.5 221.0 224.3 227.6 231.5 236.6 242.5 248.6 254.8 260.2 -T3 263.9 265.5 265.3 263.4 260.2 256.5 251.6 246.5 241.4 233.4 229.1 -T4 220.2 213.2 209.6 207.0 204.5 202.0 199.6 197.8 -Z1 .025 .034 .038 .034 .032 .045 .076 .122 .204 .431 .919 -Z2 1.967 3.858 6.261 8.135 9.239 9.875 10.091 9.845 9.171 8.146 6.834 -Z3 5.497 4.354 3.442 2.734 2.201 1.789 1.453 1.175 .950 -A 15LAT 7M -T1 295.1 287.4 273.6 259.3 244.8 230.5 217.2 206.4 201.3 203.2 208.6 -T2 213.9 218.2 221.7 224.9 228.1 232.0 236.8 242.4 248.2 254.2 259.6 -T3 263.3 265.2 265.3 263.4 260.1 255.5 251.1 246.7 242.3 235.5 231.5 -T4 223.3 216.5 212.2 208.8 205.3 201.8 198.6 196.4 -Z1 .025 .033 .039 .042 .049 .070 .109 .167 .267 .522 1.050 -Z2 2.133 4.020 6.355 8.108 9.087 9.690 9.970 9.819 9.217 8.237 6.939 -Z3 5.597 4.441 3.516 2.797 2.259 1.842 1.501 1.218 .987 -A 25LAT 7M -T1 295.7 287.8 273.4 259.0 244.7 230.8 218.2 208.4 203.9 205.2 209.8 -T2 214.6 218.8 222.4 225.6 229.0 232.8 237.6 243.0 248.5 254.1 259.1 -T3 262.7 264.7 264.9 263.2 259.8 254.5 250.0 245.7 241.3 234.7 231.1 -T4 223.1 216.3 211.9 208.0 204.1 200.2 196.6 193.8 -Z1 .025 .033 .039 .042 .052 .080 .140 .246 .429 .747 1.267 -Z2 2.264 3.991 6.125 7.728 8.640 9.248 9.592 9.547 9.066 8.191 6.957 -Z3 5.644 4.493 3.561 2.836 2.299 1.887 1.545 1.260 1.027 -A 35LAT 7M -T1 294.2 286.3 271.8 257.3 243.2 230.3 219.8 212.5 209.1 209.7 212.8 -T2 216.6 220.3 223.7 226.9 230.3 234.2 239.0 244.4 249.8 254.9 259.6 -T3 263.1 265.2 265.6 264.1 260.7 254.9 249.7 244.7 239.7 233.1 227.7 -T4 220.2 213.2 208.2 203.7 199.2 194.7 190.5 187.2 -Z1 .025 .034 .039 .037 .045 .082 .170 .344 .635 1.032 1.548 -Z2 2.463 4.032 5.953 7.379 8.186 8.758 9.123 9.129 8.702 7.883 6.708 -Z3 5.450 4.345 3.450 2.754 2.239 1.843 1.514 1.238 1.011 -A 45LAT 7M -T1 289.7 282.0 267.8 253.3 239.5 228.3 221.5 217.9 216.0 216.0 217.4 -T2 219.8 222.5 225.5 228.7 232.1 236.1 241.1 246.6 252.0 257.1 261.7 -T3 265.3 267.5 268.0 266.6 263.2 257.4 251.7 246.0 240.3 232.3 226.7 -T4 219.0 211.6 205.6 200.0 194.3 188.6 183.2 179.1 -Z1 .025 .033 .039 .040 .055 .104 .229 .495 .939 1.440 1.950 -Z2 2.760 4.117 5.747 6.922 7.572 8.098 8.514 8.601 8.236 7.465 6.335 -Z3 5.123 4.068 3.221 2.566 2.083 1.713 1.406 1.148 .936 -A 55LAT 7M -T1 284.4 277.0 263.5 249.2 235.8 226.6 223.2 222.5 221.9 221.6 222.1 -T2 223.3 225.1 227.7 230.8 234.2 238.2 243.5 249.3 254.9 260.1 264.8 -T3 268.4 270.6 271.3 270.1 267.1 261.6 255.8 250.0 244.3 236.3 230.2 -T4 222.6 214.8 207.6 200.5 193.4 186.4 179.2 174.8 -Z1 .025 .033 .040 .045 .071 .147 .320 .663 1.203 1.772 2.298 -Z2 3.010 4.084 5.313 6.216 6.762 7.287 7.776 7.959 7.669 6.958 5.886 -Z3 4.734 3.741 2.954 2.350 1.904 1.562 1.279 1.042 .848 -A 65LAT 7M -T1 279.9 273.1 260.2 246.3 233.9 226.7 225.4 225.9 225.9 225.9 226.2 -T2 226.9 228.3 230.6 233.4 236.6 240.5 245.6 251.4 257.0 262.4 267.2 -T3 270.9 273.3 274.2 273.5 270.9 265.9 260.4 254.8 249.2 242.0 236.0 -T4 228.1 220.4 212.2 204.0 195.8 187.5 179.8 165.1 -Z1 .025 .033 .040 .044 .074 .164 .368 .760 1.353 1.935 2.417 -Z2 2.978 3.739 4.573 5.203 5.626 6.119 6.660 6.977 6.871 6.345 5.418 -Z3 4.372 3.455 2.724 2.164 1.755 1.445 1.187 .970 .791 -A 75LAT 7M -T1 274.7 269.0 257.2 244.2 233.5 228.4 228.3 229.2 229.3 229.4 229.7 -T2 230.3 231.4 233.3 235.8 238.5 242.0 246.7 252.3 257.8 263.3 268.4 -T3 272.4 275.2 276.5 276.1 273.9 269.2 264.0 258.6 253.3 248.2 240.5 -T4 232.9 225.0 216.3 207.5 198.6 189.8 181.1 167.6 -Z1 .025 .033 .040 .044 .081 .189 .421 .841 1.442 1.990 2.398 -Z2 2.822 3.364 3.945 4.394 4.720 5.167 5.723 6.165 6.285 5.991 5.206 -Z3 4.225 3.310 2.555 1.980 1.581 1.291 1.051 .850 .686 -A 85LAT 7M -T1 270.8 265.7 254.7 242.7 233.8 230.1 230.2 231.0 231.0 230.6 230.8 -T2 231.6 232.8 234.5 236.7 239.1 242.2 246.7 252.0 257.6 263.2 268.5 -T3 272.8 275.9 277.6 277.7 276.0 271.8 266.4 261.0 255.6 249.9 242.5 -T4 235.0 227.0 218.2 209.1 200.0 190.9 181.6 169.1 -Z1 .025 .033 .040 .044 .081 .189 .421 .841 1.442 1.990 2.398 -Z2 2.822 3.364 3.945 4.394 4.720 5.167 5.723 6.165 6.285 5.991 5.206 -Z3 4.225 3.310 2.555 1.980 1.581 1.291 1.051 .850 .686 -A-85LAT 8M -T1 244.5 240.7 232.7 223.0 213.2 205.2 199.7 196.0 192.4 188.5 186.1 -T2 185.9 187.7 191.2 195.9 200.8 205.4 209.5 214.8 223.7 235.7 247.9 -T3 258.1 265.9 271.4 274.4 275.9 277.4 268.3 257.7 247.1 229.8 224.1 -T4 218.1 213.2 212.2 211.9 211.8 211.6 211.3 210.7 -Z1 .025 .034 .038 .037 .056 .129 .292 .584 1.026 1.532 2.055 -Z2 2.564 3.033 3.511 4.134 4.856 5.458 5.849 6.021 5.988 5.806 5.610 -Z3 5.325 4.759 3.985 3.195 2.505 1.935 1.488 1.144 .878 -A-75LAT 8M -T1 249.4 245.4 236.4 225.4 214.5 206.1 200.9 197.8 194.6 191.2 189.1 -T2 188.9 190.5 193.9 198.4 203.2 208.0 212.9 218.9 227.8 238.9 250.0 -T3 259.1 266.0 270.4 272.4 272.6 271.9 263.9 254.8 245.8 230.5 226.1 -T4 221.4 216.9 215.3 214.4 213.5 212.6 211.7 210.7 -Z1 .025 .034 .038 .037 .056 .129 .292 .584 1.026 1.532 2.055 -Z2 2.564 3.033 3.511 4.134 4.856 5.458 5.849 6.021 5.988 5.806 5.610 -Z3 5.325 4.759 3.985 3.195 2.505 1.935 1.488 1.144 .878 -A-65LAT 8M -T1 258.8 253.3 242.1 229.5 218.1 210.1 206.1 204.0 201.9 199.6 198.1 -T2 197.8 198.8 201.1 204.3 207.9 212.0 216.9 223.0 230.8 239.8 248.5 -T3 255.7 261.0 264.5 266.0 265.7 263.8 257.7 251.1 244.5 233.3 230.3 -T4 227.2 224.2 221.6 219.4 217.2 214.9 212.7 210.9 -Z1 .024 .032 .041 .051 .080 .150 .296 .570 1.024 1.688 2.556 -Z2 3.361 3.907 4.254 4.584 4.905 5.279 5.687 6.050 6.284 6.342 6.214 -Z3 5.836 5.034 4.005 3.070 2.374 1.851 1.444 1.126 .878 -A-55LAT 8M -T1 267.7 260.7 247.6 234.3 222.9 215.6 212.9 212.2 211.4 210.4 209.7 -T2 209.5 209.8 210.9 212.5 214.4 217.1 221.2 226.2 232.0 238.1 244.1 -T3 249.2 253.3 256.0 257.3 256.9 254.1 250.2 246.2 242.2 235.3 233.2 -T4 230.2 227.0 223.7 220.6 217.4 214.3 211.3 208.9 -Z1 .024 .032 .041 .053 .085 .156 .306 .592 1.081 1.864 2.955 -Z2 3.964 4.603 4.932 5.156 5.321 5.678 6.254 6.919 7.490 7.784 7.599 -Z3 6.937 5.742 4.367 3.223 2.453 1.915 1.502 1.177 .922 -A-45LAT 8M -T1 274.4 267.0 253.3 239.6 227.9 220.4 217.5 216.7 216.3 216.1 216.2 -T2 216.7 217.5 218.5 219.7 221.2 223.3 226.6 230.7 235.0 239.5 243.9 -T3 247.8 251.0 253.1 253.7 252.4 248.4 245.3 242.4 239.5 235.1 232.8 -T4 229.0 224.4 220.9 217.4 213.8 210.4 207.1 204.8 -Z1 .025 .033 .040 .047 .072 .140 .277 .513 .909 1.625 2.734 -Z2 3.869 4.709 5.275 5.738 6.127 6.648 7.305 7.982 8.517 8.686 8.241 -Z3 7.303 5.973 4.572 3.414 2.608 2.030 1.593 1.254 .989 -A-35LAT 8M -T1 280.6 273.3 259.7 245.8 233.5 224.4 218.7 215.4 213.9 214.2 215.6 -T2 217.5 219.5 221.4 223.4 225.5 228.1 231.5 235.6 240.1 244.7 249.0 -T3 252.8 255.5 256.9 256.4 254.0 248.9 245.4 242.2 239.0 234.9 231.0 -T4 225.7 220.8 216.9 213.5 210.2 206.7 203.4 201.1 -Z1 .025 .033 .040 .044 .061 .113 .211 .367 .636 1.224 2.267 -Z2 3.476 4.540 5.401 6.113 6.677 7.291 7.939 8.474 8.736 8.573 7.832 -Z3 6.727 5.453 4.226 3.220 2.490 1.952 1.541 1.223 .971 -A-25LAT 8M -T1 286.5 279.7 266.7 253.0 239.6 227.8 218.1 210.9 207.6 208.6 211.7 -T2 215.1 218.3 221.2 224.0 226.9 230.2 234.3 239.1 244.3 249.9 255.0 -T3 259.0 261.4 262.1 260.7 257.4 252.0 247.5 243.0 238.6 232.8 227.9 -T4 221.4 216.0 212.3 209.5 206.7 203.9 201.2 199.1 -Z1 .025 .032 .040 .047 .058 .080 .118 .185 .325 .745 1.624 -Z2 2.838 4.181 5.480 6.527 7.272 7.962 8.575 8.932 8.887 8.375 7.343 -Z3 6.083 4.861 3.800 2.950 2.313 1.830 1.455 1.160 .926 -A-15LAT 8M -T1 290.7 284.2 271.7 257.8 243.5 229.8 217.3 207.2 202.6 204.3 208.7 -T2 213.0 216.8 220.3 223.5 226.8 230.7 235.5 241.1 247.1 253.3 258.9 -T3 262.9 265.0 265.2 263.4 259.8 254.9 249.5 244.0 238.5 231.5 225.4 -T4 217.7 211.7 208.3 206.0 203.8 201.6 199.4 197.7 -Z1 .024 .032 .040 .048 .056 .063 .073 .094 .161 .449 1.137 -Z2 2.282 3.858 5.647 7.171 8.268 9.059 9.510 9.524 9.079 8.213 6.959 -Z3 5.619 4.466 3.545 2.815 2.239 1.785 1.426 1.141 .914 -A -5LAT 8M -T1 291.9 285.5 273.0 259.0 244.5 230.3 217.2 206.2 201.1 203.0 207.9 -T2 212.5 216.5 220.0 223.3 226.8 230.9 236.2 242.4 248.7 255.1 260.7 -T3 264.5 266.2 266.0 264.1 260.8 256.7 251.2 245.5 239.8 232.8 226.1 -T4 217.8 211.3 207.9 205.5 203.3 201.1 198.9 197.4 -Z1 .025 .033 .040 .045 .051 .056 .066 .089 .160 .436 1.079 -Z2 2.187 3.787 5.700 7.463 8.838 9.739 10.096 9.882 9.169 8.084 6.731 -Z3 5.381 4.277 3.429 2.761 2.221 1.784 1.431 1.147 .919 -A 5LAT 8M -T1 293.1 286.3 273.4 259.3 244.7 230.4 217.1 206.1 201.0 203.0 208.3 -T2 213.3 217.3 220.7 223.8 227.1 231.1 236.4 242.6 249.0 255.4 261.0 -T3 264.8 266.5 266.2 264.2 260.9 256.9 252.0 247.0 242.1 234.0 230.2 -T4 221.9 215.4 211.5 208.5 205.6 202.6 200.0 198.0 -Z1 .025 .033 .039 .041 .043 .052 .071 .104 .184 .471 1.130 -Z2 2.265 3.913 5.894 7.737 9.181 10.091 10.394 10.081 9.256 8.082 6.694 -Z3 5.342 4.251 3.418 2.762 2.227 1.792 1.438 1.153 .924 -A 15LAT 8M -T1 295.3 287.7 274.0 259.7 245.1 230.7 217.3 206.4 201.5 203.6 208.9 -T2 213.9 217.9 221.3 224.3 227.5 231.4 236.3 242.1 248.1 254.3 259.9 -T3 263.8 265.7 265.8 263.9 260.4 255.7 251.6 247.6 243.6 237.3 234.0 -T4 226.3 219.9 215.5 211.8 208.0 204.3 200.8 198.5 -Z1 .024 .032 .040 .048 .057 .069 .090 .131 .229 .540 1.224 -Z2 2.374 4.013 5.944 7.681 9.001 9.867 10.219 10.019 9.324 8.249 6.893 -Z3 5.528 4.393 3.507 2.808 2.250 1.805 1.448 1.162 .932 -A 25LAT 8M -T1 295.8 288.0 273.8 259.3 244.9 230.9 218.2 208.5 204.1 205.6 210.1 -T2 214.7 218.5 221.9 224.9 228.1 231.8 236.4 241.8 247.3 253.0 258.1 -T3 261.8 264.0 264.3 262.7 259.3 254.0 249.9 246.0 242.1 235.9 232.7 -T4 225.4 219.1 214.7 210.7 206.8 202.9 199.2 196.6 -Z1 .024 .032 .041 .049 .062 .082 .120 .198 .353 .707 1.381 -Z2 2.462 3.979 5.739 7.276 8.421 9.256 9.730 9.740 9.264 8.360 7.078 -Z3 5.719 4.547 3.609 2.867 2.285 1.826 1.462 1.173 .941 -A 35LAT 8M -T1 294.3 286.4 272.0 257.4 243.1 230.1 219.5 212.3 209.1 209.8 212.9 -T2 216.6 220.0 223.1 226.0 229.0 232.6 237.0 242.1 247.2 252.3 256.9 -T3 260.6 262.9 263.5 262.2 258.9 253.3 248.3 243.5 238.6 233.3 227.1 -T4 220.0 213.6 209.1 204.9 200.9 196.9 193.1 190.4 -Z1 .025 .033 .040 .044 .056 .088 .157 .286 .514 .925 1.600 -Z2 2.623 4.029 5.622 6.960 7.923 8.690 9.218 9.332 8.948 8.123 6.916 -Z3 5.616 4.489 3.583 2.859 2.286 1.830 1.467 1.176 .944 -A 45LAT 8M -T1 289.6 281.9 267.9 253.4 239.3 227.9 220.9 217.2 215.5 215.6 217.1 -T2 219.3 221.8 224.5 227.3 230.3 233.8 238.3 243.3 248.3 253.2 257.6 -T3 261.3 263.7 264.6 263.4 260.2 254.4 248.7 243.1 237.4 230.3 224.2 -T4 216.7 209.9 204.7 199.9 195.1 190.2 185.6 182.6 -Z1 .025 .033 .040 .044 .062 .108 .210 .404 .733 1.220 1.896 -Z2 2.837 4.078 5.428 6.483 7.190 7.863 8.473 8.737 8.475 7.739 6.588 -Z3 5.330 4.246 3.383 2.700 2.161 1.732 1.389 1.112 .891 -A 55LAT 8M -T1 283.5 276.3 262.9 248.7 235.2 225.9 222.3 221.5 221.0 220.8 221.2 -T2 222.1 223.7 225.9 228.6 231.6 235.1 239.7 244.9 250.0 254.9 259.4 -T3 263.1 265.7 266.7 265.9 263.0 257.4 251.9 246.3 240.8 234.1 227.6 -T4 220.0 212.7 206.3 200.0 193.8 187.5 181.8 177.4 -Z1 .025 .033 .040 .044 .068 .138 .291 .574 1.021 1.569 2.191 -Z2 2.970 3.954 4.994 5.788 6.322 6.932 7.598 8.004 7.916 7.328 6.257 -Z3 5.039 3.987 3.155 2.505 2.002 1.606 1.287 1.028 .821 -A 65LAT 8M -T1 278.2 271.6 258.8 245.0 232.6 225.4 224.1 224.7 224.7 224.6 224.7 -T2 225.0 226.0 227.8 230.2 232.9 236.2 240.6 245.7 250.8 255.8 260.4 -T3 264.3 267.1 268.6 268.3 266.0 261.3 256.2 251.1 246.0 240.2 233.7 -T4 226.2 218.7 211.3 204.1 196.7 189.4 182.5 177.5 -Z1 .025 .033 .039 .040 .064 .143 .325 .675 1.211 1.772 2.284 -Z2 2.859 3.575 4.325 4.896 5.293 5.816 6.463 6.981 7.137 6.820 5.934 -Z3 4.822 3.817 3.004 2.368 1.887 1.515 1.214 .969 .773 -A 75LAT 8M -T1 272.8 267.0 255.2 242.3 231.7 226.6 226.6 227.6 227.8 227.6 227.6 -T2 227.8 228.5 229.9 231.8 233.9 236.7 240.6 245.2 250.1 255.2 260.1 -T3 264.4 267.8 269.8 270.0 268.5 264.6 259.8 255.0 250.1 245.8 238.4 -T4 230.8 223.3 215.6 207.9 200.3 192.6 184.9 180.3 -Z1 .025 .034 .038 .036 .056 .134 .335 .750 1.383 1.963 2.383 -Z2 2.789 3.276 3.763 4.099 4.306 4.650 5.154 5.678 6.044 6.059 5.498 -Z3 4.621 3.714 2.911 2.267 1.792 1.433 1.145 .911 .725 -A 85LAT 8M -T1 269.3 263.8 252.5 240.5 231.5 227.9 228.2 229.2 229.2 228.6 228.4 -T2 228.7 229.5 230.8 232.3 234.0 236.4 239.9 244.2 249.1 254.4 259.5 -T3 264.0 267.8 270.3 271.2 270.4 267.4 262.6 257.5 252.4 247.6 240.2 -T4 232.7 225.1 217.4 209.6 201.8 194.1 186.3 181.7 -Z1 .025 .034 .038 .036 .056 .134 .335 .750 1.383 1.963 2.383 -Z2 2.789 3.276 3.763 4.099 4.306 4.650 5.154 5.678 6.044 6.059 5.498 -Z3 4.621 3.714 2.911 2.267 1.792 1.433 1.145 .911 .725 -A-85LAT 9M -T1 244.9 240.8 232.8 223.4 213.7 205.8 200.3 196.9 194.1 191.7 190.7 -T2 191.7 194.6 199.5 205.7 212.1 218.1 223.6 229.7 238.6 249.6 260.3 -T3 268.8 274.7 278.5 280.3 280.7 279.3 269.2 257.8 246.5 227.5 221.9 -T4 215.7 211.3 210.1 210.0 210.0 210.0 209.8 209.1 -Z1 .026 .035 .037 .028 .039 .110 .269 .538 .937 1.429 1.986 -Z2 2.527 2.985 3.421 4.009 4.709 5.286 5.652 5.889 6.056 6.073 5.857 -Z3 5.392 4.609 3.676 2.834 2.193 1.704 1.328 1.037 .810 -A-75LAT 9M -T1 250.1 245.9 236.8 226.0 215.2 206.7 201.7 199.1 196.9 194.9 194.2 -T2 195.2 198.2 203.0 209.0 215.3 221.3 227.2 233.7 241.8 251.3 260.4 -T3 267.4 272.0 274.6 275.6 274.7 271.0 262.6 253.5 244.4 229.7 224.7 -T4 219.2 214.7 213.3 212.6 211.9 211.1 210.2 208.9 -Z1 .026 .035 .037 .028 .039 .110 .269 .538 .937 1.429 1.986 -Z2 2.527 2.985 3.421 4.009 4.709 5.286 5.652 5.889 6.056 6.073 5.857 -Z3 5.392 4.609 3.676 2.834 2.193 1.704 1.328 1.037 .810 -A-65LAT 9M -T1 260.0 254.3 242.9 230.3 219.0 211.2 207.6 206.2 205.0 203.9 203.8 -T2 204.8 207.1 210.7 215.2 219.9 224.8 230.1 236.0 242.5 249.7 256.3 -T3 261.4 264.8 266.6 267.1 265.7 261.2 255.4 249.5 243.6 234.8 230.5 -T4 226.2 222.3 219.8 217.8 215.6 213.6 211.4 209.2 -Z1 .025 .033 .040 .046 .070 .133 .280 .583 1.092 1.780 2.612 -Z2 3.383 3.942 4.340 4.743 5.159 5.679 6.269 6.802 7.129 7.111 6.604 -Z3 5.757 4.692 3.624 2.755 2.160 1.731 1.379 1.088 .856 -A-55LAT 9M -T1 268.6 261.6 248.4 235.2 224.0 217.0 214.7 214.3 214.2 214.1 214.4 -T2 215.3 216.7 218.7 221.1 223.8 226.9 230.9 235.6 240.4 245.3 249.9 -T3 253.7 256.5 258.2 258.6 257.3 253.0 249.3 245.7 242.2 236.6 233.9 -T4 229.7 225.6 222.3 219.2 216.1 213.0 209.9 207.1 -Z1 .024 .032 .041 .054 .087 .164 .327 .645 1.178 1.945 2.937 -Z2 3.896 4.619 5.131 5.576 5.978 6.541 7.247 7.890 8.246 8.148 7.435 -Z3 6.347 5.105 3.929 2.987 2.335 1.861 1.480 1.168 .920 -A-45LAT 9M -T1 275.0 267.6 254.0 240.4 228.9 221.4 218.6 217.9 217.7 218.0 218.7 -T2 219.8 221.1 222.6 224.2 226.0 228.4 231.7 235.7 239.8 243.9 247.7 -T3 251.2 254.0 255.6 255.8 254.3 250.0 246.7 243.7 240.6 235.7 233.1 -T4 228.6 224.2 220.3 216.7 213.2 209.6 206.0 203.2 -Z1 .024 .032 .040 .049 .078 .151 .297 .552 .977 1.683 2.723 -Z2 3.818 4.714 5.408 6.021 6.564 7.213 7.938 8.554 8.861 8.682 7.844 -Z3 6.631 5.316 4.106 3.134 2.437 1.924 1.523 1.206 .954 -A-35LAT 9M -T1 281.0 273.8 260.3 246.4 234.0 224.7 219.0 215.8 214.4 214.9 216.5 -T2 218.5 220.6 222.7 224.7 226.9 229.7 233.3 237.6 242.2 246.8 251.3 -T3 255.0 257.7 259.0 258.4 255.8 250.9 247.0 243.3 239.6 235.5 231.0 -T4 225.8 221.3 217.5 214.2 210.8 207.3 204.0 201.2 -Z1 .025 .033 .040 .045 .066 .123 .232 .404 .692 1.278 2.281 -Z2 3.458 4.543 5.475 6.284 6.959 7.693 8.442 8.986 9.122 8.728 7.698 -Z3 6.371 5.061 3.921 3.015 2.350 1.853 1.470 1.169 .930 -A-25LAT 9M -T1 287.1 280.2 267.1 253.1 239.6 227.6 217.9 210.8 207.6 208.7 211.9 -T2 215.3 218.4 221.4 224.2 227.2 230.7 235.0 240.1 245.5 251.2 256.5 -T3 260.6 263.0 263.6 262.0 258.4 252.8 247.9 243.2 238.4 232.9 227.4 -T4 221.5 216.6 213.2 210.4 207.7 204.9 202.1 199.8 -Z1 .024 .032 .040 .048 .063 .093 .146 .229 .387 .815 1.678 -Z2 2.870 4.209 5.546 6.688 7.570 8.395 9.103 9.451 9.272 8.557 7.318 -Z3 5.914 4.660 3.638 2.838 2.233 1.770 1.410 1.127 .902 -A-15LAT 9M -T1 291.3 284.6 271.8 257.8 243.4 229.6 217.1 207.0 202.4 204.1 208.5 -T2 212.8 216.7 220.3 223.7 227.2 231.3 236.3 242.2 248.3 254.6 260.3 -T3 264.3 266.4 266.4 264.2 260.2 254.6 248.9 243.2 237.5 231.0 224.3 -T4 217.4 211.9 208.6 206.2 203.8 201.3 199.0 197.3 -Z1 .024 .032 .041 .051 .062 .072 .085 .115 .197 .496 1.182 -Z2 2.321 3.902 5.724 7.323 8.520 9.409 9.922 9.901 9.316 8.283 6.913 -Z3 5.516 4.359 3.464 2.763 2.205 1.763 1.412 1.133 .909 -A -5LAT 9M -T1 292.4 285.8 273.1 259.1 244.5 230.2 217.0 206.0 200.8 202.7 207.5 -T2 212.3 216.4 220.1 223.6 227.2 231.6 237.2 243.6 250.1 256.5 262.2 -T3 265.9 267.5 267.1 264.7 260.8 255.8 250.3 244.6 239.0 233.2 225.7 -T4 218.1 211.9 208.3 205.6 202.9 200.2 197.8 196.2 -Z1 .025 .032 .040 .047 .054 .060 .070 .096 .173 .449 1.080 -Z2 2.175 3.783 5.735 7.569 9.026 9.990 10.368 10.092 9.243 8.031 6.628 -Z3 5.280 4.203 3.390 2.749 2.220 1.787 1.436 1.153 .925 -A 5LAT 9M -T1 293.3 286.4 273.4 259.3 244.7 230.3 216.8 205.8 200.7 202.7 207.9 -T2 213.0 217.1 220.7 224.0 227.4 231.7 237.3 243.7 250.3 256.7 262.4 -T3 266.1 267.7 267.2 264.9 261.0 255.9 251.3 246.7 242.2 234.9 231.3 -T4 223.8 217.6 213.6 210.1 206.7 203.3 200.2 198.4 -Z1 .025 .033 .039 .042 .045 .052 .069 .101 .182 .461 1.095 -Z2 2.203 3.842 5.850 7.762 9.297 10.265 10.576 10.206 9.277 8.016 6.604 -Z3 5.267 4.201 3.394 2.756 2.229 1.796 1.443 1.158 .929 -A 15LAT 9M -T1 295.2 287.5 273.7 259.4 244.7 230.1 216.8 206.1 201.2 203.2 208.5 -T2 213.6 217.7 221.2 224.3 227.6 231.5 236.7 242.6 248.9 255.2 260.9 -T3 264.9 266.9 266.9 264.6 260.6 255.1 251.4 248.0 244.6 239.0 236.4 -T4 229.3 223.3 218.9 214.8 210.8 206.8 202.9 200.7 -Z1 .025 .033 .040 .046 .053 .064 .085 .123 .213 .510 1.170 -Z2 2.299 3.935 5.889 7.674 9.050 9.954 10.317 10.091 9.340 8.213 6.837 -Z3 5.473 4.342 3.460 2.766 2.216 1.777 1.425 1.142 .916 -A 25LAT 9M -T1 295.0 287.1 272.9 258.4 243.8 229.7 217.2 207.9 203.8 205.3 209.7 -T2 214.3 218.2 221.5 224.5 227.5 231.2 235.8 241.2 246.9 252.8 258.3 -T3 262.3 264.7 265.1 263.3 259.4 253.8 250.1 246.6 243.1 237.1 234.4 -T4 227.7 222.0 217.5 213.4 209.5 205.6 201.9 199.3 -Z1 .025 .032 .040 .046 .056 .072 .105 .175 .318 .656 1.309 -Z2 2.373 3.888 5.663 7.228 8.407 9.282 9.792 9.814 9.322 8.387 7.085 -Z3 5.711 4.515 3.551 2.793 2.213 1.763 1.408 1.125 .899 -A 35LAT 9M -T1 292.2 284.3 270.0 255.4 241.0 228.2 218.2 211.7 208.9 209.6 212.5 -T2 215.9 219.1 222.0 224.6 227.4 230.7 235.0 240.0 245.2 250.5 255.4 -T3 259.4 262.1 262.9 261.6 258.3 252.7 247.7 242.9 238.0 232.8 226.5 -T4 219.8 214.2 209.9 206.3 202.7 199.1 195.6 193.8 -Z1 .025 .033 .039 .040 .047 .075 .137 .254 .465 .860 1.528 -Z2 2.550 3.959 5.551 6.868 7.797 8.547 9.088 9.266 8.989 8.262 7.101 -Z3 5.795 4.598 3.596 2.804 2.210 1.758 1.400 1.115 .888 -A 45LAT 9M -T1 285.9 278.4 264.5 250.2 236.5 225.7 219.4 216.4 215.0 214.9 216.0 -T2 217.8 219.8 222.1 224.6 227.2 230.3 234.4 239.1 243.9 248.7 253.3 -T3 257.1 260.0 261.3 260.6 257.8 252.4 246.6 240.8 235.0 228.2 221.5 -T4 214.6 208.6 203.9 199.8 195.8 191.8 187.7 186.4 -Z1 .025 .033 .039 .042 .055 .094 .184 .363 .674 1.153 1.838 -Z2 2.790 4.028 5.344 6.317 6.916 7.519 8.133 8.531 8.524 8.047 7.054 -Z3 5.833 4.638 3.600 2.777 2.177 1.728 1.373 1.090 .866 -A 55LAT 9M -T1 278.7 271.7 258.7 244.8 232.1 223.7 220.7 220.1 219.6 219.1 219.0 -T2 219.4 220.4 222.0 224.1 226.4 229.3 233.2 237.8 242.4 247.0 251.3 -T3 255.2 258.3 260.1 260.0 257.9 253.0 247.8 242.5 237.3 232.0 224.8 -T4 217.5 210.8 205.0 199.6 194.1 188.8 183.4 181.2 -Z1 .025 .033 .039 .040 .057 .115 .251 .517 .951 1.499 2.138 -Z2 2.937 3.932 4.947 5.642 6.029 6.530 7.181 7.748 7.997 7.793 7.019 -Z3 5.923 4.736 3.642 2.769 2.150 1.697 1.342 1.059 .836 -A 65LAT 9M -T1 273.1 266.6 254.1 240.8 229.3 223.0 222.0 222.4 222.2 221.6 221.0 -T2 220.7 220.9 222.0 223.5 225.3 227.7 231.0 235.0 239.4 243.8 248.3 -T3 252.4 256.0 258.4 259.3 258.2 254.3 250.1 246.0 241.8 238.1 231.7 -T4 224.2 217.1 210.5 204.1 197.6 191.3 184.7 181.8 -Z1 .025 .034 .039 .036 .053 .118 .280 .614 1.145 1.714 2.247 -Z2 2.852 3.598 4.349 4.834 5.080 5.476 6.078 6.712 7.170 7.277 6.855 -Z3 6.030 4.915 3.763 2.819 2.163 1.693 1.329 1.043 .818 -A 75LAT 9M -T1 267.5 261.8 250.4 238.0 228.1 223.6 223.6 224.3 224.0 223.1 222.3 -T2 221.7 221.6 222.1 222.9 224.0 225.6 228.1 231.3 235.2 239.6 244.0 -T3 248.5 252.7 256.0 258.0 258.3 256.1 252.6 249.0 245.4 243.3 236.4 -T4 228.8 221.6 214.9 208.4 201.9 195.5 188.8 185.4 -Z1 .025 .034 .038 .034 .048 .115 .297 .693 1.312 1.875 2.274 -Z2 2.684 3.221 3.773 4.113 4.269 4.535 4.962 5.447 5.858 6.087 6.025 -Z3 5.631 4.793 3.750 2.825 2.150 1.655 1.285 1.004 .786 -A 85LAT 9M -T1 264.0 258.6 247.7 236.1 227.7 224.4 224.6 225.1 224.5 223.1 222.1 -T2 221.7 221.6 221.9 222.3 222.8 223.8 225.7 228.5 232.0 236.2 240.6 -T3 245.3 249.8 253.9 256.9 258.7 258.1 254.7 251.0 247.3 245.4 238.0 -T4 230.4 223.1 216.5 210.1 203.6 197.3 190.8 187.2 -Z1 .025 .034 .038 .034 .048 .115 .297 .693 1.312 1.875 2.274 -Z2 2.684 3.221 3.773 4.113 4.269 4.535 4.962 5.447 5.858 6.087 6.025 -Z3 5.631 4.793 3.750 2.825 2.150 1.655 1.285 1.004 .786 -A-85LAT10M -T1 246.0 241.9 233.8 224.2 214.8 207.7 204.0 202.5 202.0 202.2 204.1 -T2 207.8 213.1 219.7 227.2 234.7 241.4 246.8 252.0 258.5 266.3 273.5 -T3 278.6 281.3 282.4 282.2 279.8 273.3 265.0 256.6 248.3 235.9 229.5 -T4 222.9 217.2 213.2 209.7 206.2 202.6 199.2 196.0 -Z1 .026 .034 .038 .032 .041 .096 .243 .556 1.067 1.652 2.244 -Z2 2.850 3.466 4.120 4.901 5.734 6.352 6.670 6.811 6.854 6.638 5.967 -Z3 5.047 4.093 3.229 2.534 2.034 1.656 1.332 1.057 .835 -A-75LAT10M -T1 252.0 247.4 238.0 227.1 216.7 209.5 206.5 205.9 205.9 206.4 208.2 -T2 211.5 216.0 221.8 228.3 235.0 240.9 246.0 251.0 256.8 263.3 269.4 -T3 273.6 275.8 276.6 276.3 274.1 267.8 260.7 253.7 246.6 236.7 230.7 -T4 224.5 218.8 214.6 210.8 206.9 203.1 199.3 196.0 -Z1 .026 .034 .038 .032 .041 .096 .243 .556 1.067 1.652 2.244 -Z2 2.850 3.466 4.120 4.901 5.734 6.352 6.670 6.811 6.854 6.638 5.967 -Z3 5.047 4.093 3.229 2.534 2.034 1.656 1.332 1.057 .835 -A-65LAT10M -T1 261.6 255.7 244.1 231.8 221.3 214.9 213.1 213.4 213.8 214.5 215.8 -T2 218.1 221.1 225.0 229.3 233.7 238.0 242.3 246.7 251.6 256.7 261.5 -T3 265.1 267.4 268.4 268.3 266.4 261.3 255.9 250.6 245.3 237.7 233.2 -T4 227.5 222.2 217.6 213.2 208.7 204.3 200.0 196.2 -Z1 .024 .031 .042 .058 .092 .157 .315 .680 1.315 2.110 3.000 -Z2 3.864 4.605 5.222 5.783 6.277 6.792 7.278 7.610 7.664 7.319 6.451 -Z3 5.343 4.272 3.351 2.624 2.094 1.692 1.359 1.081 .858 -A-55LAT10M -T1 269.9 262.9 249.9 237.0 226.4 220.2 218.7 219.1 219.6 220.2 221.1 -T2 222.4 224.1 226.2 228.5 231.0 233.9 237.6 241.7 246.1 250.5 254.6 -T3 258.1 260.7 262.1 262.2 260.6 256.4 252.2 247.9 243.7 237.4 233.8 -T4 228.1 222.7 217.8 213.2 208.4 203.7 199.1 195.1 -Z1 .024 .031 .042 .062 .101 .178 .347 .705 1.319 2.143 3.140 -Z2 4.126 4.946 5.601 6.177 6.677 7.257 7.869 8.304 8.372 7.959 6.957 -Z3 5.706 4.527 3.536 2.755 2.177 1.739 1.389 1.107 .882 -A-45LAT10M -T1 276.2 269.0 255.7 242.3 230.7 223.2 220.1 219.3 219.2 219.7 220.6 -T2 221.8 223.3 224.9 226.7 228.7 231.4 235.1 239.5 244.1 248.7 253.0 -T3 256.7 259.6 261.1 260.8 258.8 254.6 250.3 246.1 242.0 235.4 231.9 -T4 226.0 220.5 215.7 211.2 206.6 202.1 197.7 193.9 -Z1 .024 .032 .041 .051 .081 .153 .298 .560 .997 1.702 2.720 -Z2 3.802 4.721 5.478 6.204 6.885 7.634 8.374 8.863 8.896 8.375 7.220 -Z3 5.832 4.582 3.568 2.777 2.185 1.733 1.381 1.102 .880 -A-35LAT10M -T1 282.3 275.3 261.9 247.9 235.1 225.2 218.9 215.4 213.9 214.5 216.2 -T2 218.3 220.5 222.9 225.3 227.9 231.0 235.3 240.2 245.4 250.7 255.7 -T3 259.7 262.4 263.4 262.4 259.4 254.2 249.6 245.1 240.7 235.0 230.0 -T4 224.0 218.5 214.2 210.3 206.4 202.4 198.6 195.4 -Z1 .025 .033 .040 .045 .065 .120 .225 .394 .677 1.238 2.190 -Z2 3.328 4.424 5.429 6.391 7.269 8.164 8.972 9.402 9.252 8.509 7.192 -Z3 5.721 4.462 3.478 2.721 2.146 1.705 1.359 1.086 .869 -A-25LAT10M -T1 288.1 281.3 268.1 253.8 240.0 227.7 217.6 210.1 206.7 207.7 210.9 -T2 214.5 218.0 221.3 224.5 227.9 231.8 236.6 242.1 248.0 253.9 259.4 -T3 263.4 265.8 266.1 264.2 260.2 254.2 249.1 244.2 239.4 233.2 227.8 -T4 221.2 215.6 211.8 208.7 205.6 202.5 199.5 196.9 -Z1 .024 .032 .041 .050 .065 .094 .144 .229 .390 .800 1.608 -Z2 2.755 4.112 5.544 6.851 7.927 8.887 9.623 9.846 9.414 8.431 7.013 -Z3 5.538 4.325 3.402 2.691 2.139 1.707 1.365 1.094 .877 -A-15LAT10M -T1 292.0 285.2 272.2 258.0 243.6 229.6 216.8 206.3 201.3 202.8 207.3 -T2 212.0 216.3 220.3 224.1 228.0 232.5 237.9 244.0 250.2 256.5 262.1 -T3 266.0 267.8 267.5 265.1 260.8 254.7 249.3 243.9 238.6 231.9 225.9 -T4 218.3 212.3 208.7 206.0 203.4 200.7 198.2 196.2 -Z1 .024 .032 .041 .053 .065 .073 .084 .115 .204 .504 1.171 -Z2 2.288 3.864 5.707 7.356 8.619 9.573 10.128 10.077 9.383 8.233 6.796 -Z3 5.377 4.236 3.375 2.705 2.169 1.739 1.396 1.121 .901 -A -5LAT10M -T1 292.7 286.1 273.4 259.4 244.8 230.3 216.7 205.1 199.5 201.1 206.2 -T2 211.3 215.9 220.1 224.0 228.1 232.9 238.7 245.3 251.8 258.1 263.5 -T3 267.0 268.3 267.7 265.2 261.1 255.7 250.2 244.8 239.4 233.1 226.5 -T4 218.2 211.6 208.1 205.6 203.1 200.7 198.3 196.7 -Z1 .025 .033 .040 .046 .050 .054 .062 .086 .158 .414 1.000 -Z2 2.044 3.624 5.597 7.510 9.077 10.085 10.431 10.099 9.208 7.975 6.572 -Z3 5.235 4.168 3.362 2.727 2.203 1.774 1.427 1.147 .922 -A 5LAT10M -T1 293.4 286.6 273.6 259.5 244.9 230.3 216.5 205.0 199.4 201.2 206.6 -T2 212.1 216.6 220.6 224.3 228.2 232.7 238.6 245.2 251.7 258.0 263.5 -T3 267.0 268.3 267.7 265.2 261.2 255.8 250.9 246.2 241.4 234.0 230.0 -T4 221.5 214.8 211.3 208.5 205.8 203.1 200.6 198.8 -Z1 .025 .034 .039 .037 .036 .042 .059 .086 .152 .397 .971 -Z2 2.010 3.599 5.612 7.612 9.278 10.276 10.510 10.064 9.122 7.886 6.515 -Z3 5.216 4.172 3.373 2.739 2.217 1.788 1.439 1.157 .930 -A 15LAT10M -T1 294.5 287.0 273.3 259.0 244.2 229.7 216.2 205.3 200.1 201.9 207.3 -T2 212.7 217.1 220.9 224.3 227.8 232.0 237.3 243.4 249.6 255.9 261.5 -T3 265.4 267.3 267.2 264.9 260.9 255.3 251.1 247.1 243.2 237.0 233.5 -T4 225.6 219.1 215.2 211.8 208.5 205.2 202.1 199.8 -Z1 .025 .033 .040 .043 .047 .053 .065 .093 .168 .435 1.048 -Z2 2.125 3.723 5.668 7.476 8.891 9.800 10.132 9.885 9.148 8.059 6.730 -Z3 5.407 4.298 3.424 2.734 2.192 1.762 1.416 1.137 .913 -A 25LAT10M -T1 293.0 285.3 271.3 256.7 242.1 228.3 216.4 207.4 203.3 204.5 208.8 -T2 213.4 217.3 220.6 223.7 226.8 230.4 235.1 240.5 246.3 252.3 257.9 -T3 262.1 264.6 265.1 263.4 259.7 254.3 250.2 246.3 242.4 235.8 235.6 -T4 231.6 223.7 217.8 213.9 209.9 206.0 201.8 198.8 -Z1 .025 .033 .040 .044 .050 .060 .086 .143 .270 .592 1.233 -Z2 2.286 3.782 5.532 7.068 8.219 9.063 9.551 9.588 9.156 8.292 7.043 -Z3 5.697 4.490 3.495 2.719 2.144 1.708 1.363 1.087 .867 -A 35LAT10M -T1 288.4 280.8 266.8 252.2 238.1 226.0 217.0 211.5 208.9 209.2 211.5 -T2 214.4 217.3 220.0 222.5 225.2 228.3 232.4 237.2 242.5 247.9 253.1 -T3 257.3 260.4 261.6 260.8 258.0 253.3 248.6 243.9 239.2 233.0 228.0 -T4 221.6 216.0 211.7 208.2 204.8 201.3 197.7 196.3 -Z1 .025 .034 .039 .037 .041 .063 .117 .222 .418 .814 1.510 -Z2 2.553 3.933 5.432 6.600 7.362 8.009 8.547 8.852 8.816 8.341 7.342 -Z3 6.092 4.818 3.684 2.794 2.169 1.713 1.358 1.075 .851 -A 45LAT10M -T1 280.8 273.6 260.4 246.4 233.3 223.5 218.1 215.7 214.4 213.9 214.4 -T2 215.5 217.0 218.9 220.9 223.1 225.8 229.4 233.7 238.3 243.1 247.7 -T3 251.8 255.2 257.2 257.5 255.9 252.3 247.3 242.0 236.8 230.0 225.0 -T4 219.7 214.0 209.8 206.1 202.3 198.5 194.9 193.4 -Z1 .025 .034 .039 .039 .048 .084 .172 .348 .658 1.159 1.900 -Z2 2.896 4.114 5.322 6.101 6.467 6.880 7.403 7.902 8.214 8.161 7.560 -Z3 6.565 5.295 4.021 2.994 2.292 1.794 1.411 1.109 .872 -A 55LAT10M -T1 272.8 266.4 254.1 240.9 229.3 221.8 219.2 218.5 217.8 216.9 216.3 -T2 216.1 216.4 217.3 218.7 220.2 222.3 225.4 229.1 233.2 237.6 242.0 -T3 246.2 250.0 252.8 254.1 253.9 251.4 247.0 242.4 237.8 232.4 227.2 -T4 222.0 217.0 212.2 207.5 202.8 198.2 193.9 191.3 -Z1 .025 .034 .039 .039 .054 .109 .241 .503 .936 1.509 2.208 -Z2 3.075 4.112 5.105 5.671 5.857 6.141 6.605 7.126 7.550 7.730 7.520 -Z3 6.893 5.741 4.391 3.250 2.463 1.904 1.481 1.154 .899 -A 65LAT10M -T1 266.4 260.7 249.2 236.7 226.3 220.8 219.8 219.8 219.0 217.8 216.6 -T2 215.6 215.1 215.2 215.8 216.6 218.0 220.2 223.3 227.1 231.4 235.8 -T3 240.5 245.0 248.8 251.4 252.5 251.5 248.0 244.1 240.2 235.9 231.0 -T4 225.8 220.6 215.3 210.2 205.1 199.9 195.1 192.1 -Z1 .025 .033 .040 .043 .065 .129 .281 .591 1.090 1.650 2.212 -Z2 2.889 3.753 4.617 5.115 5.285 5.529 5.924 6.384 6.798 7.073 7.150 -Z3 6.871 5.917 4.600 3.412 2.551 1.928 1.473 1.136 .878 -A 75LAT10M -T1 260.7 255.7 245.3 233.8 224.6 220.3 220.1 220.2 219.1 217.5 215.7 -T2 214.2 213.2 212.6 212.5 212.6 213.2 214.8 217.3 220.8 225.1 229.8 -T3 234.8 240.0 244.9 248.9 251.9 253.0 250.0 246.4 242.8 239.3 234.0 -T4 227.7 221.6 216.4 211.6 206.9 202.1 197.3 195.1 -Z1 .025 .034 .039 .038 .056 .122 .290 .643 1.194 1.706 2.088 -Z2 2.541 3.210 3.946 4.415 4.631 4.880 5.220 5.594 5.928 6.169 6.287 -Z3 6.167 5.611 4.721 3.723 2.779 2.013 1.484 1.121 .853 -A 85LAT10M -T1 256.8 252.2 242.6 232.1 224.1 220.4 220.1 220.0 218.5 216.2 214.1 -T2 212.5 211.3 210.5 209.9 209.5 209.7 210.8 213.0 216.3 220.5 225.2 -T3 230.5 236.1 241.8 247.1 251.8 255.0 252.0 248.1 244.3 241.8 234.8 -T4 228.0 221.5 216.5 212.1 207.6 203.1 198.7 196.2 -Z1 .025 .034 .039 .038 .056 .122 .290 .643 1.194 1.706 2.088 -Z2 2.541 3.210 3.946 4.415 4.631 4.880 5.220 5.594 5.928 6.169 6.287 -Z3 6.167 5.611 4.721 3.723 2.779 2.013 1.484 1.121 .853 -A-85LAT11M -T1 251.5 246.9 238.1 228.3 219.7 214.7 213.8 215.4 218.4 222.3 226.5 -T2 230.8 235.2 239.9 244.8 249.7 253.6 256.3 259.0 263.5 269.6 275.6 -T3 280.0 282.7 283.6 282.8 279.7 272.7 265.9 259.2 252.5 244.2 237.2 -T4 230.2 223.2 216.2 209.2 202.2 195.2 188.2 183.3 -Z1 .025 .034 .039 .039 .056 .118 .268 .569 1.096 1.926 3.059 -Z2 4.050 4.597 4.856 5.197 5.610 6.067 6.493 6.770 6.788 6.448 5.653 -Z3 4.656 3.680 2.839 2.189 1.740 1.413 1.145 .921 .739 -A-75LAT11M -T1 256.6 251.5 241.6 230.8 221.5 216.2 215.7 217.7 220.4 223.4 226.7 -T2 230.4 234.2 238.3 242.6 246.9 250.6 253.6 256.6 261.1 266.8 272.2 -T3 276.3 278.7 279.4 278.4 275.3 268.8 262.7 256.7 250.7 243.6 236.8 -T4 229.8 222.9 215.9 209.0 202.0 195.1 188.1 183.3 -Z1 .025 .034 .039 .039 .056 .118 .268 .569 1.096 1.926 3.059 -Z2 4.050 4.597 4.856 5.197 5.610 6.067 6.493 6.770 6.788 6.448 5.653 -Z3 4.656 3.680 2.839 2.189 1.740 1.413 1.145 .921 .739 -A-65LAT11M -T1 264.7 258.5 246.7 234.7 225.2 220.3 220.0 221.7 223.4 225.1 227.0 -T2 229.1 231.7 234.7 237.9 241.3 244.7 248.3 252.3 256.9 262.0 266.9 -T3 270.6 272.9 273.7 272.9 270.1 264.5 259.0 253.6 248.2 240.3 235.5 -T4 228.9 222.1 215.4 208.6 201.9 195.2 188.3 183.4 -Z1 .024 .031 .042 .061 .092 .142 .273 .608 1.239 2.151 3.300 -Z2 4.293 4.868 5.177 5.580 6.065 6.618 7.143 7.438 7.348 6.835 5.871 -Z3 4.753 3.743 2.918 2.285 1.834 1.497 1.219 .987 .798 -A-55LAT11M -T1 271.3 264.5 251.8 239.2 229.0 223.2 221.8 222.3 223.0 223.8 224.8 -T2 226.1 227.8 230.1 232.7 235.6 238.9 243.2 248.0 253.0 257.9 262.4 -T3 265.9 268.2 269.1 268.4 266.0 261.0 255.9 250.8 245.7 237.6 233.5 -T4 226.6 219.8 213.3 207.1 200.8 194.5 188.2 183.2 -Z1 .024 .031 .042 .062 .095 .151 .285 .597 1.172 2.022 3.133 -Z2 4.155 4.831 5.290 5.892 6.606 7.343 7.966 8.247 8.039 7.357 6.232 -Z3 4.991 3.913 3.058 2.405 1.930 1.569 1.274 1.029 .830 -A-45LAT11M -T1 277.6 270.7 257.7 244.3 232.4 224.1 220.3 218.9 218.6 219.0 220.1 -T2 221.6 223.6 226.0 228.7 231.6 235.2 240.0 245.5 250.9 256.1 260.9 -T3 264.6 267.0 267.8 266.8 264.0 258.9 253.7 248.4 243.2 234.9 231.0 -T4 223.6 216.7 211.1 205.6 200.2 194.7 189.4 184.8 -Z1 .025 .033 .040 .044 .064 .121 .248 .487 .902 1.609 2.661 -Z2 3.715 4.477 5.082 5.961 7.053 8.069 8.797 9.013 8.627 7.739 6.461 -Z3 5.127 4.011 3.147 2.488 1.995 1.615 1.305 1.051 .845 -A-35LAT11M -T1 283.9 277.0 263.8 249.7 236.3 225.5 218.3 214.0 212.1 212.5 214.5 -T2 217.0 219.9 222.9 226.2 229.6 233.6 238.7 244.6 250.4 256.1 261.3 -T3 265.2 267.5 268.0 266.5 263.1 257.5 252.1 246.9 241.6 234.3 229.3 -T4 222.1 215.7 210.8 206.4 202.0 197.5 193.3 189.7 -Z1 .025 .034 .039 .038 .050 .100 .202 .368 .643 1.170 2.052 -Z2 3.124 4.193 5.266 6.487 7.744 8.811 9.494 9.573 8.999 7.944 6.574 -Z3 5.201 4.077 3.216 2.557 2.052 1.658 1.338 1.077 .866 -A-25LAT11M -T1 289.4 282.5 269.2 254.9 240.7 227.8 217.0 209.0 205.1 206.0 209.4 -T2 213.5 217.4 221.2 224.9 228.8 233.2 238.5 244.5 250.6 256.6 262.1 -T3 266.0 268.1 268.2 266.2 262.2 256.2 250.9 245.8 240.6 233.4 228.4 -T4 221.0 214.8 210.5 207.0 203.5 200.0 196.6 193.9 -Z1 .025 .033 .039 .042 .052 .085 .147 .244 .410 .774 1.454 -Z2 2.523 3.995 5.704 7.248 8.456 9.372 9.901 9.845 9.171 8.057 6.667 -Z3 5.290 4.159 3.289 2.619 2.105 1.702 1.374 1.107 .891 -A-15LAT11M -T1 292.6 285.7 272.6 258.3 243.8 229.6 216.5 205.4 199.9 201.3 206.0 -T2 211.2 215.9 220.2 224.3 228.4 233.1 238.6 244.7 251.0 257.3 262.8 -T3 266.6 268.4 268.1 265.8 261.7 256.1 250.8 245.5 240.2 232.8 227.5 -T4 219.3 212.7 208.8 205.8 202.9 200.0 197.3 195.3 -Z1 .025 .033 .040 .043 .048 .060 .085 .132 .227 .479 1.004 -Z2 2.054 3.849 6.090 7.870 8.977 9.720 10.099 9.941 9.222 8.102 6.723 -Z3 5.356 4.224 3.345 2.665 2.145 1.738 1.406 1.135 .915 -A -5LAT11M -T1 293.0 286.3 273.5 259.5 244.8 230.3 216.3 204.3 198.1 199.7 205.0 -T2 210.6 215.5 219.9 224.0 228.2 233.0 238.8 245.3 251.6 257.8 263.2 -T3 266.7 268.0 267.5 265.2 261.5 256.8 251.4 246.0 240.5 232.8 227.2 -T4 218.4 211.5 207.8 205.4 203.2 201.0 198.8 197.1 -Z1 .025 .034 .039 .037 .036 .043 .062 .100 .179 .394 .850 -Z2 1.837 3.635 5.977 7.929 9.206 9.950 10.173 9.853 9.064 7.949 6.625 -Z3 5.322 4.233 3.375 2.706 2.189 1.783 1.450 1.176 .953 -A 5LAT11M -T1 293.4 286.5 273.6 259.5 244.8 230.2 216.2 204.2 198.1 199.7 205.4 -T2 211.3 216.2 220.4 224.1 228.1 232.6 238.4 244.9 251.3 257.5 262.9 -T3 266.4 267.8 267.3 265.0 261.5 256.9 251.7 246.4 241.2 233.3 228.3 -T4 219.3 212.4 209.1 207.0 205.0 202.9 201.0 199.3 -Z1 .026 .034 .038 .032 .028 .034 .056 .093 .167 .369 .803 -Z2 1.763 3.543 5.893 7.895 9.232 9.944 10.057 9.655 8.868 7.804 6.542 -Z3 5.293 4.231 3.381 2.713 2.200 1.797 1.465 1.192 .969 -A 15LAT11M -T1 293.5 286.2 272.8 258.5 243.7 229.2 215.8 204.7 199.0 200.5 206.1 -T2 211.8 216.5 220.5 224.0 227.5 231.7 237.0 243.0 249.3 255.5 261.1 -T3 265.0 266.9 266.9 264.8 261.0 256.0 251.2 246.6 241.9 234.8 230.3 -T4 221.9 215.2 211.5 208.8 206.2 203.7 201.2 199.1 -Z1 .025 .034 .039 .037 .036 .041 .057 .095 .180 .403 .868 -Z2 1.862 3.657 5.941 7.724 8.775 9.363 9.543 9.321 8.743 7.843 6.643 -Z3 5.389 4.282 3.377 2.672 2.150 1.750 1.423 1.153 .932 -A 25LAT11M -T1 290.2 283.0 269.5 255.1 240.7 227.3 215.8 207.1 202.7 203.6 207.7 -T2 212.3 216.4 219.8 222.9 226.1 229.8 234.3 239.6 245.4 251.4 256.9 -T3 261.1 263.7 264.3 262.7 259.3 254.3 250.0 245.8 241.5 234.2 230.7 -T4 223.5 217.1 212.9 209.6 206.4 203.2 200.1 198.0 -Z1 .025 .034 .039 .036 .035 .041 .070 .145 .304 .604 1.120 -Z2 2.111 3.804 5.848 7.289 8.009 8.481 8.783 8.855 8.641 8.048 6.983 -Z3 5.726 4.512 3.469 2.665 2.111 1.710 1.383 1.110 .890 -A 35LAT11M -T1 284.1 276.9 263.3 249.1 235.5 224.3 216.5 211.6 209.1 209.0 210.8 -T2 213.4 216.1 218.6 221.0 223.4 226.4 230.1 234.5 239.5 244.8 249.9 -T3 254.3 257.5 259.1 258.7 256.4 252.6 248.4 244.2 240.0 233.4 229.6 -T4 223.5 217.8 213.7 210.3 206.9 203.5 200.0 198.6 -Z1 .026 .035 .038 .029 .025 .043 .107 .253 .523 .927 1.496 -Z2 2.470 4.040 5.805 6.834 7.137 7.402 7.751 8.107 8.349 8.249 7.556 -Z3 6.464 5.128 3.831 2.831 2.199 1.774 1.428 1.137 .903 -A 45LAT11M -T1 275.3 268.7 255.9 242.4 230.1 221.5 217.3 215.7 214.5 213.7 213.6 -T2 214.2 215.2 216.5 218.0 219.6 221.7 224.7 228.5 232.7 237.3 241.9 -T3 246.4 250.2 252.9 254.1 253.8 251.9 247.6 243.1 238.5 231.7 228.3 -T4 224.6 219.6 215.8 212.3 208.8 205.4 201.9 200.6 -Z1 .026 .034 .038 .032 .035 .069 .174 .413 .833 1.350 1.936 -Z2 2.858 4.312 5.846 6.525 6.465 6.481 6.734 7.164 7.661 8.006 7.932 -Z3 7.342 6.021 4.444 3.185 2.425 1.933 1.540 1.214 .955 -A 55LAT11M -T1 267.0 261.3 249.7 237.0 226.1 219.6 217.6 217.2 216.4 215.2 214.2 -T2 213.5 213.2 213.4 214.0 214.8 216.3 218.8 222.3 226.4 230.9 235.5 -T3 240.3 244.8 248.6 251.1 252.4 252.3 248.3 243.8 239.4 232.6 229.4 -T4 226.5 223.4 219.3 215.3 211.4 207.5 203.9 202.1 -Z1 .025 .033 .040 .045 .066 .125 .266 .561 1.044 1.583 2.121 -Z2 2.929 4.202 5.549 6.164 6.142 6.139 6.296 6.596 6.990 7.364 7.617 -Z3 7.478 6.424 4.881 3.535 2.637 2.019 1.560 1.210 .939 -A 65LAT11M -T1 260.7 255.7 245.1 233.1 223.3 218.0 217.0 216.8 215.7 214.1 212.5 -T2 211.1 210.1 209.8 209.8 210.0 211.0 213.2 216.5 220.7 225.5 230.6 -T3 236.1 241.4 246.2 249.9 252.6 254.1 250.2 245.5 240.8 233.2 230.5 -T4 227.4 224.1 220.2 216.4 212.6 208.7 205.2 203.1 -Z1 .025 .033 .040 .045 .073 .150 .326 .670 1.203 1.753 2.249 -Z2 2.894 3.834 4.839 5.422 5.612 5.806 6.085 6.404 6.700 6.908 6.992 -Z3 6.804 6.070 4.961 3.811 2.814 2.037 1.501 1.131 .857 -A 75LAT11M -T1 255.4 251.0 241.3 230.1 221.3 217.0 216.3 215.9 214.3 212.1 210.0 -T2 208.2 207.0 206.3 206.0 206.0 206.6 208.5 211.5 215.7 220.7 226.2 -T3 232.2 238.2 244.0 248.8 253.0 256.2 252.4 247.5 242.7 235.6 231.6 -T4 226.6 221.3 217.9 214.9 211.9 209.0 205.9 204.7 -Z1 .025 .033 .040 .045 .073 .150 .326 .670 1.203 1.753 2.249 -Z2 2.894 3.834 4.839 5.422 5.612 5.806 6.085 6.404 6.700 6.908 6.992 -Z3 6.804 6.070 4.961 3.811 2.814 2.037 1.501 1.131 .857 -A 85LAT11M -T1 252.5 248.1 238.6 228.0 219.8 216.0 215.3 214.8 212.8 209.8 207.3 -T2 205.6 204.6 203.9 203.5 203.3 203.7 205.3 207.9 212.0 217.1 222.7 -T3 228.9 235.3 241.7 247.7 253.2 257.7 253.8 248.7 243.5 238.2 231.5 -T4 225.3 219.5 216.6 213.9 211.4 209.0 206.5 205.2 -Z1 .025 .033 .040 .045 .073 .150 .326 .670 1.203 1.753 2.249 -Z2 2.894 3.834 4.839 5.422 5.612 5.806 6.085 6.404 6.700 6.908 6.992 -Z3 6.804 6.070 4.961 3.811 2.814 2.037 1.501 1.131 .857 -A-85LAT12M -T1 252.7 248.7 240.4 231.5 225.5 224.8 227.3 230.4 233.2 235.3 236.6 -T2 237.7 239.2 241.6 244.8 248.2 251.2 253.9 257.3 263.2 271.2 279.1 -T3 285.2 289.1 290.4 288.9 284.5 276.4 270.2 264.4 258.6 252.5 244.8 -T4 237.3 229.2 219.2 208.7 198.3 187.9 177.6 160.0 -Z1 .024 .032 .041 .051 .078 .140 .297 .650 1.278 2.177 3.285 -Z2 4.145 4.500 4.553 4.691 4.930 5.393 6.012 6.477 6.525 6.111 5.220 -Z3 4.174 3.257 2.533 1.984 1.590 1.295 1.052 .850 .686 -A-75LAT12M -T1 259.4 254.4 244.4 234.1 226.5 224.2 226.1 229.0 231.4 233.2 234.5 -T2 235.8 237.6 240.1 243.1 246.3 249.5 252.6 256.4 262.2 269.5 276.6 -T3 282.1 285.5 286.5 284.8 280.4 272.8 267.0 261.5 256.0 250.7 242.7 -T4 235.1 226.9 217.2 207.2 197.2 187.2 177.7 159.0 -Z1 .024 .032 .041 .051 .078 .140 .297 .650 1.278 2.177 3.285 -Z2 4.145 4.500 4.553 4.691 4.930 5.393 6.012 6.477 6.525 6.111 5.220 -Z3 4.174 3.257 2.533 1.984 1.590 1.295 1.052 .850 .686 -A-65LAT12M -T1 266.8 260.7 248.9 237.1 228.4 225.0 225.9 227.9 229.3 230.3 231.3 -T2 232.6 234.4 236.9 239.8 242.9 246.3 250.3 254.9 260.5 266.7 272.5 -T3 276.9 279.6 280.2 278.7 274.9 268.6 262.8 257.2 251.6 243.4 238.1 -T4 230.2 222.0 213.1 204.1 195.0 185.8 177.0 170.2 -Z1 .024 .031 .042 .059 .090 .146 .285 .617 1.225 2.110 3.227 -Z2 4.143 4.588 4.762 5.086 5.555 6.154 6.765 7.084 6.911 6.299 5.320 -Z3 4.257 3.359 2.661 2.127 1.728 1.419 1.163 .949 .774 -A-55LAT12M -T1 272.3 265.7 253.2 240.6 230.5 224.9 223.8 224.4 224.9 225.5 226.6 -T2 228.1 230.1 232.7 235.6 238.8 242.5 247.2 252.6 258.0 263.3 268.1 -T3 271.7 273.8 274.2 272.9 269.9 264.6 258.8 253.0 247.2 238.5 233.0 -T4 225.1 216.9 208.9 201.0 193.0 185.3 177.3 171.3 -Z1 .024 .032 .041 .052 .079 .138 .270 .548 1.048 1.845 2.955 -Z2 3.976 4.607 5.026 5.695 6.561 7.374 7.950 8.051 7.593 6.727 5.601 -Z3 4.466 3.532 2.816 2.264 1.838 1.502 1.225 .997 .811 -A-45LAT12M -T1 278.8 272.0 259.3 245.8 233.4 224.6 220.2 218.6 218.1 218.7 220.3 -T2 222.4 225.1 228.1 231.4 234.8 238.9 244.1 249.9 255.4 260.6 265.3 -T3 268.6 270.6 270.9 269.5 266.5 261.4 255.6 249.6 243.7 234.3 229.5 -T4 221.2 213.2 206.4 200.0 193.6 187.2 181.0 175.6 -Z1 .025 .034 .039 .039 .052 .101 .213 .420 .785 1.446 2.476 -Z2 3.516 4.250 4.864 5.921 7.314 8.429 8.988 8.887 8.190 7.122 5.876 -Z3 4.677 3.710 2.973 2.400 1.947 1.584 1.288 1.045 .848 -A-35LAT12M -T1 285.8 278.9 265.7 251.4 237.5 225.9 217.8 212.9 210.6 211.1 213.6 -T2 216.8 220.3 224.0 227.7 231.5 235.9 241.2 247.0 252.8 258.4 263.3 -T3 266.9 268.9 269.2 267.6 264.3 259.1 253.5 247.7 242.0 233.4 228.6 -T4 220.2 212.8 207.5 202.5 197.5 192.5 187.8 183.9 -Z1 .025 .034 .039 .036 .044 .080 .159 .297 .537 1.011 1.823 -Z2 2.857 3.962 5.153 6.564 8.029 9.119 9.625 9.456 8.685 7.541 6.218 -Z3 4.950 3.923 3.138 2.528 2.046 1.662 1.349 1.093 .885 -A-25LAT12M -T1 291.0 283.9 270.5 256.1 241.6 228.2 216.9 208.2 203.8 204.5 208.2 -T2 212.7 217.0 221.1 224.9 228.9 233.3 238.6 244.4 250.5 256.5 262.0 -T3 265.9 268.0 268.2 266.4 263.0 258.1 252.7 247.3 241.9 233.6 228.9 -T4 220.6 213.8 209.1 205.2 201.3 197.4 193.8 191.1 -Z1 .025 .033 .039 .041 .047 .069 .116 .200 .357 .699 1.338 -Z2 2.379 3.876 5.651 7.241 8.459 9.338 9.799 9.695 9.018 7.936 6.593 -Z3 5.259 4.155 3.297 2.634 2.126 1.727 1.401 1.133 .916 -A-15LAT12M -T1 293.4 286.3 273.1 258.8 244.1 229.9 216.5 205.0 199.0 200.0 204.7 -T2 210.1 214.9 219.2 223.1 227.0 231.4 236.8 242.8 249.1 255.5 261.2 -T3 265.3 267.4 267.5 265.6 262.4 258.5 253.3 247.8 242.4 233.7 228.9 -T4 220.3 213.2 208.9 205.7 202.6 199.5 196.4 194.3 -Z1 .025 .033 .039 .039 .040 .050 .073 .118 .210 .449 .946 -Z2 1.971 3.776 6.053 7.849 8.945 9.673 10.047 9.930 9.295 8.251 6.894 -Z3 5.513 4.345 3.424 2.714 2.181 1.770 1.433 1.157 .932 -A -5LAT12M -T1 293.3 286.5 273.7 259.6 244.9 230.3 216.3 203.9 197.2 198.3 203.6 -T2 209.3 214.2 218.5 222.2 226.1 230.6 236.2 242.5 248.9 255.3 260.9 -T3 264.7 266.5 266.5 264.8 262.1 259.4 254.0 248.1 242.2 232.7 227.7 -T4 218.5 211.3 207.5 205.4 203.4 201.3 199.4 197.6 -Z1 .026 .034 .038 .032 .028 .034 .057 .095 .171 .371 .797 -Z2 1.753 3.546 5.910 7.866 9.130 9.870 10.113 9.877 9.231 8.235 6.935 -Z3 5.595 4.433 3.496 2.769 2.229 1.814 1.474 1.193 .964 -A 5LAT12M -T1 293.1 286.4 273.6 259.5 244.8 230.1 216.1 203.9 197.2 198.3 203.9 -T2 209.8 214.8 218.7 222.2 225.7 230.0 235.6 242.0 248.5 254.9 260.6 -T3 264.4 266.3 266.3 264.6 262.0 259.3 253.7 247.6 241.6 232.5 226.7 -T4 217.2 210.0 206.8 205.4 204.1 202.8 201.5 199.8 -Z1 .026 .034 .038 .032 .027 .032 .052 .088 .159 .353 .768 -Z2 1.709 3.489 5.830 7.737 8.933 9.592 9.765 9.524 8.958 8.073 6.868 -Z3 5.590 4.447 3.504 2.768 2.229 1.820 1.483 1.203 .975 -A 15LAT12M -T1 292.1 285.3 272.3 258.1 243.3 229.0 215.8 204.6 198.5 199.4 204.6 -T2 210.4 215.1 218.8 222.1 225.4 229.4 234.7 240.8 247.2 253.7 259.6 -T3 263.8 266.1 266.5 264.7 261.5 257.7 252.3 246.8 241.2 232.6 227.3 -T4 218.3 211.2 207.6 205.8 204.0 202.1 200.3 198.4 -Z1 .025 .034 .039 .037 .035 .038 .051 .085 .166 .383 .841 -Z2 1.831 3.627 5.867 7.480 8.300 8.788 9.028 8.988 8.647 7.953 6.848 -Z3 5.602 4.440 3.459 2.697 2.158 1.758 1.430 1.156 .933 -A 25LAT12M -T1 287.5 280.8 267.9 253.7 239.7 226.9 216.0 207.7 203.0 203.2 206.8 -T2 211.2 215.1 218.4 221.4 224.6 228.3 233.1 238.7 244.8 251.1 256.9 -T3 261.4 264.2 264.9 263.2 259.6 254.6 249.9 245.3 240.7 232.8 228.9 -T4 221.4 214.7 210.6 207.8 204.9 202.1 199.1 197.5 -Z1 .025 .034 .038 .034 .031 .038 .068 .146 .308 .623 1.172 -Z2 2.198 3.896 5.861 7.106 7.584 7.920 8.219 8.382 8.308 7.869 6.937 -Z3 5.766 4.574 3.514 2.691 2.135 1.738 1.411 1.137 .914 -A 35LAT12M -T1 280.4 273.6 260.6 246.8 233.9 223.6 216.9 212.7 210.1 209.4 210.6 -T2 212.9 215.3 217.7 220.0 222.4 225.5 229.6 234.6 240.0 245.5 250.9 -T3 255.4 258.7 260.1 259.2 256.2 251.1 247.3 243.8 240.2 233.9 231.2 -T4 225.3 219.6 215.6 212.4 209.0 205.7 202.3 200.9 -Z1 .026 .035 .037 .027 .025 .055 .143 .320 .628 1.072 1.677 -Z2 2.689 4.290 6.032 6.948 7.100 7.249 7.532 7.843 8.046 7.939 7.296 -Z3 6.282 5.025 3.789 2.822 2.204 1.783 1.440 1.151 .918 -A 45LAT12M -T1 271.6 265.4 253.1 240.0 228.4 220.7 217.5 216.3 215.1 214.0 213.6 -T2 213.9 214.7 215.9 217.2 218.8 221.1 224.5 228.8 233.4 238.1 242.8 -T3 247.3 251.0 253.5 254.2 252.9 249.5 246.0 242.6 239.1 233.6 231.7 -T4 229.6 225.1 221.8 218.5 215.3 212.1 208.8 207.7 -Z1 .025 .034 .038 .036 .048 .100 .236 .517 .982 1.533 2.129 -Z2 3.065 4.552 6.106 6.755 6.639 6.590 6.767 7.110 7.518 7.796 7.712 -Z3 7.152 5.879 4.344 3.111 2.352 1.855 1.463 1.145 .894 -A 55LAT12M -T1 263.5 258.3 247.3 234.9 224.5 218.4 216.8 216.5 215.6 214.2 213.0 -T2 212.2 211.9 212.2 212.9 213.9 215.7 218.8 222.9 227.4 232.1 236.7 -T3 241.5 245.9 249.4 251.6 252.3 251.2 247.7 243.8 240.0 232.8 231.7 -T4 231.1 229.5 226.3 223.3 220.1 217.0 213.9 212.8 -Z1 .024 .032 .040 .048 .076 .150 .320 .664 1.212 1.795 2.345 -Z2 3.120 4.301 5.534 6.115 6.130 6.143 6.270 6.478 6.715 6.904 7.008 -Z3 6.811 5.880 4.538 3.329 2.468 1.852 1.407 1.080 .830 -A 65LAT12M -T1 257.5 253.0 242.8 231.1 221.4 216.1 214.8 214.4 212.9 210.9 209.2 -T2 207.8 207.1 207.2 207.8 208.7 210.5 213.8 218.1 223.0 228.2 233.5 -T3 238.9 244.1 248.7 252.0 254.1 255.0 250.7 245.6 240.5 230.6 229.8 -T4 228.9 227.6 225.0 222.5 220.0 217.6 215.2 214.1 -Z1 .025 .033 .040 .044 .069 .142 .315 .667 1.219 1.780 2.269 -Z2 2.935 3.955 5.054 5.655 5.802 5.956 6.203 6.463 6.645 6.684 6.532 -Z3 6.121 5.298 4.247 3.251 2.447 1.828 1.382 1.058 .813 -A 75LAT12M -T1 253.0 249.0 239.6 228.4 219.3 214.3 212.8 211.7 209.6 207.0 204.7 -T2 203.2 202.4 202.5 203.1 204.1 205.9 209.2 213.7 219.0 224.8 230.8 -T3 237.0 242.9 248.3 252.5 255.8 258.0 253.3 247.6 241.8 231.7 229.3 -T4 225.5 220.9 219.3 218.1 217.0 215.8 214.5 214.3 -Z1 .025 .033 .040 .044 .069 .142 .315 .667 1.219 1.780 2.269 -Z2 2.935 3.955 5.054 5.655 5.802 5.956 6.203 6.463 6.645 6.684 6.532 -Z3 6.121 5.298 4.247 3.251 2.447 1.828 1.382 1.058 .813 -A 85LAT12M -T1 251.2 247.2 237.8 226.9 218.0 212.9 211.0 209.6 207.0 203.7 201.2 -T2 199.7 199.2 199.3 199.8 200.7 202.4 205.6 210.1 215.5 221.6 227.9 -T3 234.5 241.0 247.0 252.1 256.3 259.4 254.4 248.3 242.2 234.2 228.4 -T4 222.6 218.1 216.5 216.0 215.4 214.8 214.3 214.2 -Z1 .025 .033 .040 .044 .069 .142 .315 .667 1.219 1.780 2.269 -Z2 2.935 3.955 5.054 5.655 5.802 5.956 6.203 6.463 6.645 6.684 6.532 -Z3 6.121 5.298 4.247 3.251 2.447 1.828 1.382 1.058 .813 -US-std geom-alt density O3-dens T P - 0 0.00E+00 2.521E+19 7.564E+11 287.40 1000.0000 - 2 2.36E+05 1.996E+19 6.588E+11 272.20 749.8942 - 4 4.59E+05 1.581E+19 5.693E+11 257.70 562.3413 - 6 6.70E+05 1.252E+19 6.011E+11 244.00 421.6965 - 8 8.70E+05 9.920E+18 8.531E+11 231.00 316.2278 - 10 1.06E+06 7.779E+18 1.455E+12 220.90 237.1374 - 12 1.24E+06 5.947E+18 2.105E+12 216.70 177.8279 - 14 1.43E+06 4.459E+18 2.475E+12 216.70 133.3521 - 16 1.61E+06 3.344E+18 3.073E+12 216.70 100.0000 - 18 1.79E+06 2.508E+18 4.067E+12 216.70 74.9894 - 20 1.97E+06 1.874E+18 4.718E+12 217.40 56.2341 - 22 2.16E+06 1.399E+18 4.840E+12 218.40 42.1697 - 24 2.34E+06 1.041E+18 4.632E+12 220.20 31.6228 - 26 2.53E+06 7.740E+17 4.174E+12 222.00 23.7137 - 28 2.72E+06 5.755E+17 3.460E+12 223.90 17.7828 - 30 2.91E+06 4.280E+17 2.760E+12 225.80 13.3352 - 32 3.10E+06 3.182E+17 2.214E+12 227.70 10.0000 - 34 3.29E+06 2.346E+17 1.757E+12 231.60 7.4989 - 36 3.49E+06 1.719E+17 1.366E+12 237.00 5.6234 - 38 3.69E+06 1.259E+17 1.009E+12 242.70 4.2170 - 40 3.90E+06 9.221E+16 6.979E+11 248.50 3.1623 - 42 4.11E+06 6.755E+16 4.543E+11 254.40 2.3714 - 44 4.33E+06 4.949E+16 2.955E+11 260.40 1.7783 - 46 4.55E+06 3.623E+16 1.733E+11 266.70 1.3335 - 48 4.77E+06 2.677E+16 9.915E+10 270.70 1.0000 - 50 5.00E+06 2.011E+16 5.911E+10 270.20 0.7499 - 52 5.23E+06 1.527E+16 3.310E+10 266.80 0.5623 - 54 5.45E+06 1.173E+16 2.056E+10 260.60 0.4217 - 56 5.67E+06 9.004E+15 1.302E+10 254.50 0.3162 - 58 5.88E+06 6.915E+15 8.381E+09 248.50 0.2371 - 60 6.09E+06 5.307E+15 5.360E+09 242.80 0.1778 - 62 6.29E+06 4.077E+15 3.432E+09 237.00 0.1334 - 64 6.48E+06 3.129E+15 2.198E+09 231.60 0.1000 - 66 6.68E+06 2.404E+15 1.407E+09 226.00 0.0750 - 68 6.87E+06 1.852E+15 9.009E+08 220.00 0.0562 - 70 7.05E+06 1.421E+15 5.769E+08 215.00 0.0422 - 72 7.23E+06 1.091E+15 3.694E+08 210.00 0.0316 - 74 7.40E+06 8.382E+14 2.365E+08 205.00 0.0237 - 76 7.57E+06 6.411E+14 1.514E+08 201.00 0.0178 - 78 7.74E+06 4.880E+14 9.696E+07 198.00 0.0133 - 80 7.91E+06 3.735E+14 6.209E+07 194.00 0.0100 - - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/fastJX53b.code b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/fastJX53b.code deleted file mode 100644 index 6ce9fc13..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53b/fastJX53b.code +++ /dev/null @@ -1,2181 +0,0 @@ -!----------------------------------------------------------------------- - subroutine SET_ATM(GMTAU) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" - - real*8 MASFAC,SCALEH,GMTAU -! real*8 PJ(L1_+1) - integer I,J,L,N -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - - do J = 1,J_ - do I = 1,I_ - P(I,J) = PMEAN(I,J) -! do L = 1,L1_ -! PJ(L) = ETAA(L) + ETAB(L)*P(I,J) -! enddo -! PJ(L1_+1) = 0.d0 - do L = 1,L1_ - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = DO3(I,J,L)*DM(I,J,L) - enddo - do L = 1,L_ - TJ(I,J,L) = T(I,J,L) - enddo -!-------calculate effective altitude of each CTM level edge - ZH(I,J,1) = 16d5*log10(1000.d0/P(I,J)) - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -(log(PJ(L+1)/PJ(L))*SCALEH) - enddo - enddo - enddo - -!begHamid Oloso 8/2005 -!---load O3 from CTM is being calculated: -! do N = 1,NTR_ -! if (TCNAME(N) .eq. 'O3') then -! do J = 1,J_ -! do I = 1,I_ -! do L = 1,L_ ! unit of DO3: # molecules/cm^2 -! DO3(I,J,L) = 6.023d26*STT(I,J,L,N)/48.d0 -! & *1.d-4 /AREAXY(I,J) -! enddo -! enddo -! enddo -! endif -! enddo -!endHamid Oloso 8/2005 - - return - end subroutine SET_ATM - - subroutine SET_AER(GMTAU) - real*8 GMTAU - return - end subroutine SET_AER - - subroutine SET_CLD(GMTAU) - real*8 GMTAU - return - end subroutine SET_CLD - - -!----------------------------------------------------------------------- - subroutine INPHOT (CrossSection_InfileName, & - & ScatteringData_InfileName, & - & PhotRateLabels_InfileName, & - & T_O3_Climatology_InfileName) -!----------------------------------------------------------------------- -! Routine to initialise photolysis rate data, called directly from the -! cinit routine in ASAD. Currently use it to read the JPL spectral data -! and standard O3 and T profiles and to set the appropriate reaction index. -!----------------------------------------------------------------------- -! -! IPH Channel number for reading all data files -! RAD Radius of Earth (cm) -! ZZHT Effective scale height above top of atmosphere (cm) -! DATUMX Maximum opt.depth above which sub layers should be inserted -! SZAMAX Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" -# include "fastJX53b_cmn_JVdat.h" - -! !INPUT PARAMETERS: - character (len=128), intent (in) :: CrossSection_InfileName - ! fast-J X-sections (spectral data) input file name - character (len=128), intent (in) :: ScatteringData_InfileName - ! Aerosol/cloud scattering data input file name - character (len=128), intent (in) :: PhotRateLabels_InfileName - ! Labels of photolysis rates required input file name - ! keyed to chem code - character (len=128), intent (in) :: T_O3_Climatology_InfileName - ! Read in T & O3 climatology input file name - ! general backup clim. - - integer IPH, I, J, K - real*8 PI -! -! PI = 3.141592653589793d0 -! Use channel 8 to read files at the moment - IPH = 8 -! -! Defaults & constants - RAD = 6375.d5 - ZZHT = 5.d5 - STT(:,:,:,:) = 1.d6 - TCNAME(:) = 'CO2' -!beg Hamid Oloso 8/2005 -! Read in annual mean pressure field -! open (IPH,file='ECT42_grid.dat',form='formatted',status='old') -! read (IPH,*) -! read (IPH,'(16F8.2)') (XDGRD(I),I=1,I_) -! read (IPH,*) -! read (IPH,'(16F8.2)') (YDGRD(J),J=1,J_) -! read (IPH,*) -! read (IPH,'(16F8.2)') (AREAXY(1,J),J=1,J_) -! read (IPH,*) -! read (IPH,'(16F8.1)') ((PMEAN(I,J),I=1,I_),J=1,J_) -! close(IPH) - -! do J=1,J_ -! AREAXY(1,J) = AREAXY(1,J)*1.d9 -! do I=2,I_ -! AREAXY(I,J) = AREAXY(1,J) -! enddo -! enddo -!end Hamid Oloso 8/2005 - -! do I = 1,I_ -! XGRD(I) = XDGRD(I) *PI/180.d0 -! enddo -! do J = 1,J_ -! YGRD(J) = YDGRD(J) *PI/180.d0 -! enddo -! -! Read in fast-J X-sections (spectral data) <<<<<<<<<<<<<< new fast-JX -! call RD_XXX(IPH,'FJX_spec.dat') - call RD_XXX(IPH, CrossSection_InfileName) - -! Read in aerosol/cloud scattering data <<<<<<<<<<<<<<<<<< new fast-JX -! call RD_MIE(IPH,'FJX_scat.dat') - call RD_MIE(IPH, ScatteringData_InfileName) - -! Read in labels of photolysis rates required >>>>> keyed to chem code -! call RD_JS(IPH,'ratj.dat') - call RD_JS(IPH, PhotRateLabels_InfileName) -! -! Read in T & O3 climatology >>>> general backup clim. -! call RD_PROF(IPH,'atmos_std.dat') - call RD_PROF(IPH, T_O3_Climatology_InfileName) -! - return - end subroutine INPHOT - - - subroutine RD_JS(NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield 'jfacta' and fastj2 label 'jlabel' -!----------------------------------------------------------------------- -! -! jfacta Quantum yield (or multiplication factor) for photolysis -! jlabel Reference label identifying appropriate J-value to use -! ipr Photolysis reaction counter - should total 'JVN_' -! -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" -# include "fastJX53b_cmn_JVdat.h" -! - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - - integer IPR, I, J, K - character*120 CLINE -! -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield jfacta and fastj2 label jlabel - IPR = 0 - open (NJ1,file=NAMFIL,status='old',form='formatted') - 10 read (NJ1,'(A)',err=20) CLINE - if (IPR .eq. JVN_) goto 20 - - if (CLINE(2:5).eq.'9999') then - go to 20 - elseif (CLINE(1:1).eq.'#') then - go to 10 - elseif (CLINE(5:5).eq.'$') then - go to 10 - else - IPR = IPR+1 - read (CLINE(79:83),'(F5.1)') JFACTA(IPR) - read (CLINE(86:92),'(A7)') JLABEL(IPR) - JFACTA(IPR) = JFACTA(IPR)/100.d0 - if(JLABEL(IPR) == "C3H6O" ) JLABEL(IPR) = "Acet-a" ! Added for GMI {Oloso, 9/05} - go to 10 - endif - 20 close(NJ1) - - NRATJ = IPR - -!----------------------------------------------------------------------- -! compare Xsections titles with J-values listed in chem code (jratd.dat) -! map the J-values needed for chemistry (ratj.dat) onto the fast-JX rates -! >>>>>>>>>>>>>>>>current code revised to JPL-02 ver 8.5 (5/05)<<<<<<<<< -! >>>this must now follow the read in of Xsects, etc<<< -!----------------------------------------------------------------------- - -!---Zero / Set index arrays that map Jvalue(j) onto rates - do J = 1,JVN_ - JIND(J) = 0 - enddo - do J = 1,NJVAL - do K = 1,NRATJ - if (JLABEL(K) .eq. TITLEJ(J)) JIND(K)=J - enddo - enddo - -! write(6,'(a,i4,a)') ' Photochemistry Scheme with ',IPR,' J-values' - do K=1,NRATJ - J = JIND(K) - if (J.eq.0) then - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & - & ' has no mapping onto onto fast-JX' - else - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & - & ' mapped onto fast-JX:',J,TITLEJ(J) - endif - enddo - - return - end subroutine RD_JS - - -!----------------------------------------------------------------------- - subroutine RD_PROF(NJ2,NAMFIL) -!----------------------------------------------------------------------- -! Routine to input T and O3 reference profiles -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" - - integer, intent(in) :: NJ2 - character(*), intent(in) :: NAMFIL -! - integer IA, I, M, L, LAT, MON, NTLATS, NTMONS, N216 - real*8 OFAC, OFAK - character*72 TITLE0 -! - open (NJ2,file=NAMFIL,status='old',form='formatted') - read (NJ2,'(A)') TITLE0 - read (NJ2,'(2I5)') NTLATS,NTMONS -! write(6,'(1X,A)') TITLE0 -! write(6,1000) NTLATS,NTMONS - N216 = min(216, NTLATS*NTMONS) - do IA = 1,N216 - read (NJ2,'(1X,I3,3X,I2)') LAT, MON - M = min(12, max(1, MON)) - L = min(18, max(1, (LAT+95)/10)) - read (NJ2,'(3X,11F7.1)') (TREF(I,L,M), I=1,41) - read (NJ2,'(3X,11F7.4)') (OREF(I,L,M), I=1,31) - enddo - close (NJ2) - -! Extend climatology to 100 km - OFAC = exp(-2.d5/5.d5) - do I = 32,51 - OFAK = OFAC**(I-31) - do M = 1,NTMONS - do L = 1,NTLATS - OREF(I,L,M) = OREF(31,L,M)*OFAK - enddo - enddo - enddo - do L = 1,NTLATS - do M = 1,NTMONS - do I = 42,51 - TREF(I,L,M) = TREF(41,L,M) - enddo - enddo - enddo - - return - 1000 format(1x,'std atmos profiles: ',i3,' lat x ',i2,' mon') - end subroutine RD_PROF - - - -!----------------------------------------------------------------------- - subroutine SET_CLD0(TINIT,ODINIT,ODINDX,ALBEDO) -!----------------------------------------------------------------------- -! Routine to set cloud and surface properties: now loads the input prof's -! -! >>>>>> this subroutine will need to be customized -! >>>>>> it is separate from aerosols since it comes from met fields -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" -# include "fastJX53b_cmn_JVdat.h" - - integer, intent(in) :: ODINDX - real*8, intent(in) :: TINIT(L_),ODINIT(L_),ALBEDO - integer I, J, L -! - do J = 1,J_ - do I = 1,I_ - do L = 1,L_ - ODCLD(I,J,L) = ODINIT(L) - T(I,J,L) = TINIT(L) - enddo - ODCLD(I,J,L1_) = 0.d0 - SA(I,J) = ALBEDO - enddo - enddo - NCLDX(:,:,:) = ODINDX -! - return - end subroutine SET_CLD0 - - -!----------------------------------------------------------------------- - subroutine SET_AER0 -!----------------------------------------------------------------------- -! Set up aerosols >>>>customize for climatology or CTM as source. -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" -# include "fastJX53b_cmn_JVdat.h" - - integer I, J, L, K - -! Add aerosol OD and indices -! DAERn(L=1:L_) = aerosol/cloud Optical Depth (OD) within CTM layer L -! DAERn(L1_=L_+1)= aerosol/cloud OD in layer above CTM (L1_) - - NAER1(:,:,:) = 0 - NAER2(:,:,:) = 0 - NAER3(:,:,:) = 0 - do J = 1,J_ - do I = 1,I_ - do L = 1,L_+1 - DAER1(I,J,L) = 0.d0 - DAER2(I,J,L) = 0.d0 - DAER3(I,J,L) = 0.d0 - enddo - enddo - enddo - - end subroutine SET_AER0 - - -!----------------------------------------------------------------------- - subroutine SET_ATM0 -!----------------------------------------------------------------------- -! Routine to set up atmospheric profiles required by Fast-J2 using a -! doubled version of the level scheme used in the CTM. First pressure -! and z* altitude are defined, then O3 and T are taken from the supplied -! climatology and integrated to the CTM levels (may be overwritten with -! values directly from the CTM, if desired). -! Oliver (04/07/99) & MJP (7/05) -!----------------------------------------------------------------------- -! -! -! PJ Pressure at boundaries of model levels (hPa) -! MASFAC Conversion factor for pressure to column density -! -! TJ Temperature profile on model grid -! DM Air column for each model level (molecules.cm-2) -! DO3 Ozone column for each model level (molecules.cm-2) -! ZH Altitude of boundaries of model levels (cm) -! PSTD Approximate pressures of levels for supplied climatology -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_metdat.h" - - integer I, J, K, L, M, N - real*8 PSTD(52),OREF2(51),TREF2(51) -! real*8 PJ(L1_+1) - real*8 DLOGP,F0,T0,PB,PC,XC,MASFAC,SCALEH -! -! Select appropriate month - M = max(1,min(12,MONTH)) - -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - -!----------------------------------------------------------------------- - do J = 1,J_ - -! Select appropriate latitudinal profiles - N = max(1, min(18, (int(YDGRD(J))+99)/10 )) -! Temporary zonal arrays for climatology data - do K = 1,51 - OREF2(K) = OREF(K,N,M) - TREF2(K) = TREF(K,N,M) - enddo - - do I = 1,I_ - -! Apportion O3 and T on supplied climatology z* levels onto CTM levels -! with mass (pressure) weighting, assuming constant mixing ratio and -! temperature half a layer on either side of the point supplied. -! L1_ = L_+1: -! PJ(L=1:L1_) = pressure at CTM layer edge, PJ(L1_+1)=0 (top-of-atmos) - -! PJ(L1_+1) = 0.d0 -! do K = 1,L1_ -! PJ(K) = ETAA(K) + ETAB(K)*PMEAN(I,J) -! enddo - -! Set up pressure levels for O3/T climatology - assume that value -! given for each 2 km z* level applies from 1 km below to 1 km above, -! so select pressures at these boundaries. Surface level values at -! 1000 mb are assumed to extend down to the actual P(ILNG,JLAT). -! - PSTD(1) = max(PJ(1),1000.d0) - PSTD(2) = 1000.d0 * 10.d0**(-1.d0/16.d0) - DLOGP = 10.d0**(-2.d0/16.d0) - do K = 3,51 - PSTD(K) = PSTD(K-1)*DLOGP - enddo - PSTD(52) = 0.d0 - - do L = 1,L1_ - F0 = 0.d0 - T0 = 0.d0 - do K = 1,51 - PC = min(PJ(L),PSTD(K)) - PB = max(PJ(L+1),PSTD(K+1)) - if (PC .gt. PB) then - XC = (PC-PB)/(PJ(L)-PJ(L+1)) - F0 = F0 + OREF2(K)*XC - T0 = T0 + TREF2(K)*XC - endif - enddo - TJ(I,J,L) = T0 - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = F0*1.d-6*DM(I,J,L) - enddo - -! Calculate effective altitudes using scale height at each level - ZH(I,J,1) = 0.d0 - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -( LOG(PJ(L+1)/PJ(L)) * SCALEH ) - enddo - - enddo - enddo - - return - end subroutine SET_ATM0 - -!<<<<<<<<<<<<<<<<<<<<<<< 98.0 deg => tan ht = 63 km -! or 99. 80 km - if (SZA .gt. SZAMAX) goto 99 - -!---load the amtospheric column data - do L = 1,L1_ -! PPJ(L) = ETAA(L) + ETAB(L)*P(ILNG,JLAT) ! JulesKouatchou 09/25/06 - TTJ(L) = TJ(ILNG,JLAT,L) - DDJ(L) = DM(ILNG,JLAT,L) - ZZJ(L) = DO3(ILNG,JLAT,L) - enddo -! PPJ(L1_+1) = 0.d0 ! JulesKouatchou 09/25/06 - PPJ(1:L1_+1) = PJ(1:L1_+1) - -!---calculate spherical weighting functions (AMF: Air Mass Factor) - do L = 1,L1_ - ZHL(L) = ZH(ILNG,JLAT,L) - enddo - -!----------------------------------------------------------------------- - call SPHERE(U0,RAD,ZHL,ZZHT,AMF,L1_) -!----------------------------------------------------------------------- - -!---load the profiles of aerosols & clouds: treated as the same from here - do L = 1,L1_ - AER(1,L) = DAER1(ILNG,JLAT,L) ! Opt. Depth aerosol 1 in layer L - AER(2,L) = DAER2(ILNG,JLAT,L) ! Opt. Depth aerosol 2 in layer L - AER(3,L) = DAER3(ILNG,JLAT,L) ! Opt. Depth aerosol 3 in layer L - AER(4,L) = ODCLD(ILNG,JLAT,L) ! cloud Opt. Depth in L - AER(5,L) = 0.d0 ! save space for Rayleigh - ADX(1,L) = NAER1(ILNG,JLAT,L) ! index for aerosol 1 at layer L - ADX(2,L) = NAER2(ILNG,JLAT,L) ! index for aerosol 2 at layer L - ADX(3,L) = NAER3(ILNG,JLAT,L) ! index for aerosol 3 at layer L - ADX(4,L) = NCLDX(ILNG,JLAT,L) ! index for cloud at layer L - ADX(5,L) = 1 ! index for Rayleigh phase in L - enddo - - do L = 1,L1_ - do I=1,4 - ADX(I,L) = min(NAA, max(0, ADX(I,L))) - enddo - enddo - -!---Now given the aerosol+cloud OD/layer in visible (600 nm) can calculate -! how to add additonal levels at top of clouds (now uses log spacing) -!----------------------------------------------------------------------- - call EXTRAL(AER,ADX,L1_,L2_,N_,JTAUMX,ATAU,ATAU0, JXTRA) -!----------------------------------------------------------------------- - -!---set surface reflectance - RFLECT = SA(ILNG,JLAT) - RFLECT = max(0.d0,min(1.d0,RFLECT)) - -!---Loop over all wavelength bins to calc mean actinic flux AVGF(L) - do K = NW1,NW2 - WAVE = WL(K) -!---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 ! use 300 nm aerosol properties for <355 nm - if( WAVE .gt. 355.d0 ) KM=2 ! use 400 nm prop for 355-500 nm - if( WAVE .gt. 500.d0 ) KM=3 - if( WAVE .gt. 800.d0 ) KM=4 - -!---Loop over CTM layers L=1:L1_ = 1:L_+1, -! values at L1_=L_+1 are a pseudo layer above the top CTM layer (L_) - do L = 1,L1_ - TTT = TTJ(L) - XQO3 = FLINT(TTT,TQQ(1,2),TQQ(2,2),TQQ(3,2) & - & ,QO3(K,1),QO3(K,2),QO3(K,3)) - XQO2 = FLINT(TTT,TQQ(1,1),TQQ(2,1),TQQ(3,1) & - & ,QO2(K,1),QO2(K,2),QO2(K,3)) - - ABX(L) = XQO3*ZZJ(L) + XQO2*DDJ(L)*0.20948d0 - - AER(5,L) = DDJ(L)*QRAYL(K) - enddo - -!----------------------------------------------------------------------- - call OPMIE(K,KM, WAVE, ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,AVGF) -!----------------------------------------------------------------------- - - do L = 1,JVL_ - FFF(K,L) = FFF(K,L) + SOLF*FL(K)*AVGF(L) - enddo - - enddo ! loop over wavelngth K - -!----------------------------------------------------------------------- - call JRATET(PPJ,TTJ,FFF, VALJL) -!----------------------------------------------------------------------- - -!---map the J-values from fast-JX onto ASAD ones (use JIND & JFACTA) - do L = 1,JVL_ - do J = 1,NRATJ - if (JIND(J).gt.0) then - ZPJ(L,J) = VALJL(L,JIND(J))*JFACTA(J) - else - ZPJ(L,J) = 0.d0 - endif - enddo - enddo - -!---diagnostics that are NOT returned to the CTM code - -!----------------------------------------------------------------------- -! write(6,*) 'fast-JX(5.3b)--------------internal print------------' - - call JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) - -!---Print solar flux terms -! write(6,'(a,4f10.4)') ' fast-JX: SZA/u0/albedo/SOL*fact', -! & SZA,U0,RFLECT,SOLF -! write(6,'(a5,18i9)') ' bin:',(K, K=NW1,NW2) -! write(6,'(a5,18f9.2)') ' wvl:',(WL(K), K=NW1,NW2) -! do L = JVL_,1,-1 -! write(6,'(i3,2x,18f9.6)') L,(FFF(K,L)/FL(K),K=NW1,NW2) -! enddo -! write(6,*) 'fast-JX(5.3b)--------------internal print------------' -!----------------------------------------------------------------------- - - 99 continue - return - end subroutine PHOTOJ - -!<<<<<<<<<<<<<<<<<<<<<< O(3P)+O2 will be close to from previous fastj versions - - do J = 4,NJVAL - - if (TQQ(2,J) .gt. TQQ(1,J)) then - TFACT = max(0.d0,min(1.d0,(TT-TQQ(1,J))/(TQQ(2,J)-TQQ(1,J)))) - else - TFACT = 0.d0 - endif - - do K = NW1,NW2 - QQQT = QQQ(K,1,J) + (QQQ(K,2,J) - QQQ(K,1,J))*TFACT - VALJ(J) = VALJ(J) + QQQT*FFF(K,L) - enddo - -! #52 Methylvinyl ketone 'MeVK ' q(M) = 1/(1 + 1.67e-19*[M]) - if (TITLEJ(J).eq.'MeVK ') then - VALJ(J) = VALJ(J)/(1.0 + 1.67e-19*DD) - endif -! #55 Methylethyl ketone MEKeto q(M) = 1/(1 + 2.0*[M/2.5e19]) - if (TITLEJ(J).eq.'MEKeto') then - VALJ(J) = VALJ(J)/(1.0 + 0.80E-19*DD) - endif -! #57 Methyl glyoxal MGlyxl q(M) = 1/(1 + 4.15*[M/2.5E19]) - if (TITLEJ(J).eq.'MGlyxl') then - VALJ(J) = VALJ(J)/(1.0 + 1.66e-19*DD) - endif - - enddo - - if (TITLEJ(NJVAL-1).eq.'Acet-a') then -!--------------J-ref v8.3 includes Blitz ACETONE q-yields-------------- -!---Acetone is a special case: (as per Blitz et al GRL, 2004) -!--- 61 = NJVAL-1 = J1(acetone-a) ==> CH3CO + CH3 -!--- 62 = NJVAL = J2(acetone-b) ==> CH3 + CO + CH3 - VALJ(NJVAL-1) = 0.d0 - VALJ(NJVAL) = 0.d0 -!---IV=NJVAL-1 = Xsect (total abs) for Acetone - pre-calc Temp interp factors - IV = NJVAL-1 - TFACA = (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - TFACA = max(0.d0, min(1.d0, TFACA)) -!---IV=NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. -!--- but force to Q2=0 by 210K - IV = NJVAL - TFAC0 = ( (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) )**2 - if (TT .lt. TQQ(1,IV)) then - TFAC0 = (TT - 210.d0)/(TQQ(1,IV)-210.d0) - endif - TFAC0 = max(0.d0, min(1.d0, TFAC0)) -!---IV=NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - TT200 = min(300.d0, max(200.d0, TT)) - TFAC1 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) -!---IV=NJVAL+2 = Q1B for Acetone => (1) - IV = NJVAL+2 - TFAC2 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - -!---now integrate over wavelengths - do K = NW1,NW2 -!---NJVAL-1 = Xsect (total abs) for Acetone - IV = NJVAL-1 - QQQA = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFACA -!---NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. - IV = NJVAL - QQ2 = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC0 - if (TT .lt. TQQ(1,IV)) then - QQ2 = QQQ(K,1,IV)*TFAC0 - endif -!---NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - QQ1A = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC1 -!---NJVAL+2 = Q1B for Acetone => (1) ! scaled to [M]=2.5e19 - IV = NJVAL+2 - QQ1B = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC2 - QQ1B = QQ1B*4.d-20 -!---J(61) - VALJ(NJVAL-1) = VALJ(NJVAL-1) & - & + FFF(K,L)*QQQA*(1.d0-QQ2)/(QQ1A + QQ1B*DD) -!---J(62) - VALJ(NJVAL) = VALJ(NJVAL) + FFF(K,L)*QQQA*QQ2 - - enddo !K -!-----------end v-8.3 includes Blitz ACETONE q-yields-------------- - endif - -!----Load array of J-values in native order, need to be indexed/scaled -! by ASAD-related code later: ZPJ(L,JJ) = VALJL(L,JIND(JJ))*JFACTA(JJ) - do J=1,NJVAL - VALJL(L,J) = VALJ(J) - enddo - - enddo ! master loop over L=1,JVL_ - return - end subroutine JRATET - - -!----------------------------------------------------------------------- - subroutine JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -!----------------------------------------------------------------------- -!--------key amtospheric data needed to solve plane-parallel J--------- - real*8, dimension(5,L1_) :: AER - integer,dimension(5,L1_) :: ADX - real*8, dimension(L1_) :: ABX, TTJ,DDJ,ZZJ,ZHL - real*8, dimension(L1_+1) :: PPJ - integer,dimension(L2_+1) :: JXTRA - real*8 :: ZZHT -!----------------------------------------------------------------------- - integer I,J,K,L - real*8 COL(4),COLO2,COLO3,ZKM,DELZ,ZTOP - -! write(6,100) -! 100 format(' L z(km) p T ',' d(air) d(O3)', -! & ' col(O2) col(O3) ndx col(aer/cld)') - - COLO2 = 0.d0 - COLO3 = 0.d0 - do I=1,4 - COL(I) = 0.d0 - enddo - ZTOP = ZHL(L1_) + ZZHT - - do L = L1_,1,-1 - - do I=1,4 - COL(I) = COL(I) + AER(I,L) - enddo - COLO2 = COLO2 + DDJ(L)*0.20948d0 - COLO3 = COLO3 + ZZJ(L) - DELZ = ZTOP-ZHL(L) - ZTOP = ZHL(L) - ZKM = ZHL(L)*1.d-5 - -! write(6,110) L,ZKM,PPJ(L),TTJ(L),DDJ(L)/DELZ,ZZJ(L)/DELZ, -! & COLO2,COLO3, -! & (ADX(I,L),COL(I), I=1,4), JXTRA(L+L),JXTRA(L+L-1) -! 110 format(1x,i3,0p,f6.2,f10.3,f7.2,1p,4e9.2,4(i3,e9.2),2i3) - - enddo - - return - end subroutine JP_ATM - - -!----------------------------------------------------------------------- - subroutine RD_XXX(NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Read in wavelength bins, solar fluxes, Rayleigh parameters, -! T-dependent X-sections. - -! >>>current code revised to JPL-02 ver 8.5 (5/05)<<<<< - -!----------------------------------------------------------------------- -! NAMFIL Name of spectral data file (j2_spec.dat) >> j2 for fast-J2 -! NJ1 Channel number for reading data file -! -! NJVAL Number of species to calculate J-values for -! NWWW Number of wavelength bins, from 1:NWWW -! WBIN Boundaries of wavelength bins -! WL Centres of wavelength bins - 'effective wavelength' -! FL Solar flux incident on top of atmosphere (cm-2.s-1) -! QRAYL Rayleigh parameters (effective cross-section) (cm2) -! QO2 O2 cross-sections -! QO3 O3 cross-sections -! Q1D O3 => O(1D) quantum yield -! TQQ Temperature for supplied cross sections -! QQQ Supplied cross sections in each wavelength bin (cm2) -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_JVdat.h" - - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - - integer I, J, K, IW, NQQQ, NWWW - - TQQ(:,:) = 0.d0 - -!----------spectral data----set for new format data J-ver8.3------------------ -! note that NJVAL = # J-values, but NQQQ (>NJVAL) = # Xsects read in -! for 2005a data, NJVAL = 62 (including a spare XXXX) and -! NQQQ = 64 so that 4 wavelength datasets read in for acetone -! note NQQQ is not used outside this subroutine! - - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - read (NJ1,100) TITLE0 - read (NJ1,101) NJVAL,NQQQ, NWWW,NW1,NW2 - if (NJVAL.gt.X_ .or. NQQQ.gt.X_) then - write(6,201) NJVAL,X_ - stop - endif -! write(6,'(1X,A)') TITLE0 -!----J-values: 1=O2, 2=O3P,3=O3D 4=readin Xsects - read (NJ1,102) (WL(IW),IW=1,NWWW) - read (NJ1,102) (FL(IW),IW=1,NWWW) - read (NJ1,102) (QRAYL(IW),IW=1,NWWW) - -!---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - read (NJ1,103) TITLEJ(1),TQQ(1,1), (QO2(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,1), (QO2(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,1), (QO2(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(2),TQQ(1,2), (QO3(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,2), (QO3(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,2), (QO3(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(3),TQQ(1,3), (Q1D(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,3), (Q1D(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,3), (Q1D(IW,3),IW=1,NWWW) - -! do J = 1,3 -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,3) -! enddo - -!---Read remaining species: X-sections at 2 T_s - do J = 4,NQQQ - read (NJ1,103) TITLEJ(J),TQQ(1,J),(QQQ(IW,1,J),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,J),(QQQ(IW,2,J),IW=1,NWWW) -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,2) - enddo - -! Reset the titles for NJVAL-1 & NJVAL to be the two acetone J_s -! 61: C3H6O = Acet-a (CH3CO + CH3) -! 62: Q2-Ac = Acet-b (CH3 + CO + CH3) - - TITLEJ(NJVAL-1) = 'Acet-a' - TITLEJ(NJVAL) = 'Acet-b' - - close(NJ1) - - 100 format(a) - 101 format(10x,5i5) - 102 format(10x, 6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 103 format(a7,f3.0,6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 200 format(1x,' x-sect:',a10,3(3x,f6.2)) - 201 format(' Number of x-sections supplied to Fast-J2: ',i3,/, & - & ' Maximum number allowed (X_) only set to: ',i3, & - & ' - increase in fastJX53b_cmn_jv.h') - - return - end subroutine RD_XXX - - -!----------------------------------------------------------------------- - subroutine RD_MIE(NJ1,NAMFIL) -!----------------------------------------------------------------------- -!-------aerosols/cloud scattering data set for fast-JX (ver 5.3) -! >>>>>>>>>>>>>>>>spectral data rev to J-ref ver8.5 (5/05)<<<<<<<<<<<< -!----------------------------------------------------------------------- -! NAMFIL Name of scattering data file (e.g., FJX_scat.dat) -! NJ1 Channel number for reading data file -! NAA Number of categories for scattering phase functions -! QAA Aerosol scattering phase functions -! NK Number of wavelengths at which functions supplied (set as 4) -! WAA Wavelengths for the NK supplied phase functions -! PAA Phase function: first 8 terms of expansion -! RAA Effective radius associated with aerosol type -! SSA Single scattering albedo -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_cmn_JVdat.h" - - integer, intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL - integer I, J, K - - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - - read (NJ1,'(i2,a78)') NAA,TITLE0 - read (NJ1,'(5x,i5,2f10.5)') JTAUMX,ATAU,ATAU0 -! write(6,'(a,2f9.5,i5)') ' ATAU/ATAU0/JMX',ATAU,ATAU0,JTAUMX - read (NJ1,*) - - do J = 1,NAA - read (NJ1,'(3x,a20)') TITLEA(J) - do K = 1,4 ! Fix number of aerosol wavelengths at 4 - read (NJ1,'(f5.0,f8.1,f7.3,f8.4,f7.3,7f6.3)') & - & WAA(K,J),QAA(K,J),RAA(K,J),SSA(K,J),(PAA(I,K,J),I=1,8) - enddo - enddo - - close(NJ1) - -! write(6,*) 'Aerosol phase functions & wavelengths' -! write(6,*) TITLE0 -! do J=1,NAA -! write(6,'(1x,A8,I2,A,9F8.1)') -! & TITLEA(J),J,' wavel=',(WAA(K,J),K=1,4) -! write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,4) -! enddo - - return - end subroutine RD_MIE - - -!----------------------------------------------------------------------- - real*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -!----------------------------------------------------------------------- -! Three-point linear interpolation function -!----------------------------------------------------------------------- - real*8 TINT,T1,T2,T3,F1,F2,F3 - if (TINT .le. T2) then - if (TINT .le. T1) then - FLINT = F1 - else - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - endif - else - if (TINT .ge. T3) then - FLINT = F3 - else - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - endif - endif - return - end FUNCTION FLINT - - -!----------------------------------------------------------------------- - subroutine SOLARZ(GMTIME,NDAY,YGRDJ,XGRDI, SZA,COSSZA,SOLFX) -!----------------------------------------------------------------------- -! GMTIME = UT for when J-values are wanted -! (for implicit solver this is at the end of the time step) -! NDAY = integer day of the year (used for solar lat and declin) -! YGRDJ = laitude (radians) for grid (I,J) -! XGDRI = longitude (radians) for grid (I,J) -! -! SZA = solar zenith angle in degrees -! COSSZA = U0 = cos(SZA) -!----------------------------------------------------------------------- - implicit none - real*8, intent(in) :: GMTIME,YGRDJ,XGRDI - real*8, intent(in) :: SZA - integer, intent(in) :: NDAY - real*8, intent(out) :: COSSZA,SOLFX - - real*8 PI, PI180, LOCT - real*8 SINDEC, SOLDEK, COSDEC, SINLAT, SOLLAT, COSLAT, COSZ -! - PI = 3.141592653589793d0 - PI180 = PI/180.d0 - !SINDEC = 0.3978d0*sin(0.9863d0*(dble(NDAY)-80.d0)*PI180) - !SOLDEK = asin(SINDEC) - !COSDEC = cos(SOLDEK) - !SINLAT = sin(YGRDJ) - !SOLLAT = asin(SINLAT) - !COSLAT = cos(SOLLAT) -! - !LOCT = (((GMTIME)*15.d0)-180.d0)*PI180 + XGRDI - !COSSZA = COSDEC*COSLAT*cos(LOCT) + SINDEC*SINLAT - !SZA = acos(COSSZA)/PI180 - - COSSZA = cos(SZA*PI180) - - SOLFX = 1.d0-(0.034d0*cos(dble(NDAY-186)*2.d0*PI/365.d0)) - - return - end subroutine SOLARZ - - -!----------------------------------------------------------------------- - subroutine SPHERE(GMU,RAD,ZHL,ZZHT,AMF,L1_) -!----------------------------------------------------------------------- -! Calculation of spherical geometry; derive tangent heights, slant path -! lengths and air mass factor for each layer. Not called when -! SZA > 98 degrees. Beyond 90 degrees, include treatment of emergent -! beam (where tangent height is below altitude J-value desired at). -!----------------------------------------------------------------------- -! in: -! GMU = MU0 = cos(solar zenith angle) -! RAD radius of Earth mean sea level (cm) -! ZHL(L) height (cm) of the bottome edge of CTM level L -! ZZHT scale height (cm) used above top of CTM (ZHL(L_+1) -! L1_ dimension of CTM = levels +1 -! out: -! AMF(I,J) = air mass factor for CTM level I for sunlight reaching J -!----------------------------------------------------------------------- - implicit none - integer, intent(in) :: L1_ - real*8, intent(in) :: GMU,RAD,ZHL(L1_),ZZHT - real*8, intent(out) :: AMF(L1_,L1_) - -! RZ Distance from centre of Earth to each point (cm) -! RQ Square of radius ratios -! TANHT Tangent height for the current SZA -! XL Slant path between points - - integer I, J, K, II - real*8 AIRMAS, XMU1, XMU2, XL, DIFF, TANHT & - & ,Ux,H,RZ(L1_),RQ(L1_),ZBYR -! -! Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- & - & 0.6817d0*EXP(-57.3d0*abs(Ux)/SQRT(1.0d0+5500.d0*H))/ & - & (1.0d0+0.625d0*H))) -! - RZ(1) = RAD + ZHL(1) - ZBYR = ZZHT/RAD - do II = 2,L1_ - RZ(II) = RAD + ZHL(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - enddo - if (GMU .lt. 0.0d0) then - TANHT = RZ(1)/dsqrt(1.0d0-GMU**2) - else - TANHT = RZ(1) - endif -! -! Go up from the surface calculating the slant paths between each level -! and the level above, and deriving the appropriate Air Mass Factor - do 16 J = 1,L1_ - do I = 1,L1_ - AMF(I,J) = 0.d0 - enddo -! -! Air Mass Factors all zero if below the tangent height - if (RZ(J) .lt. TANHT) goto 16 -! Ascend from layer J calculating AMFs - XMU1 = abs(GMU) - do I = J,L1_-1 - XMU2 = dsqrt(1.0d0 - RQ(I)*(1.0d0-XMU1**2)) - XL = RZ(I+1)*XMU2 - RZ(I)*XMU1 - AMF(I,J) = XL / (RZ(I+1)-RZ(I)) - XMU1 = XMU2 - enddo -! Use function and scale height to provide AMF above top of model - AMF(L1_,J) = AIRMAS(XMU1,ZBYR) -! -! Twilight case - Emergent Beam - if (GMU .ge. 0.0d0) goto 16 - XMU1 = abs(GMU) -! Descend from layer J - do II = J-1,1,-1 - DIFF = RZ(II+1)*sqrt(1.0d0-XMU1**2)-RZ(II) - if (II.eq.1) DIFF = max(DIFF,0.d0) ! filter -! Tangent height below current level - beam passes through twice - if (DIFF .lt. 0.0d0) then - XMU2 = sqrt(1.0d0 - (1.0d0-XMU1**2)/RQ(II)) - XL = abs(RZ(II+1)*XMU1-RZ(II)*XMU2) - AMF(II,J) = 2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1 = XMU2 -! Lowest level intersected by emergent beam - else - XL = RZ(II+1)*XMU1*2.0d0 - AMF(II,J) = XL/(RZ(II+1)-RZ(II)) - goto 16 - endif - enddo - - 16 continue - return - end subroutine SPHERE - - -!----------------------------------------------------------------------- - subroutine EXTRAL(AER,ADX,L1X,L2X,NX,JTAUMX,ATAU,ATAU0, JXTRA) -!----------------------------------------------------------------------- -! -! new version 5.3, add sub-layers (JXTRA) to thick cloud/aerosol layers -! this version sets up log-spaced sub-layers of increasing thickness ATAU -! -! AER(5,L=1:L1X) = Optical Depth in layer L (general visible OD) -! This is not used in the calculation of J's but in calculating -! the number in levels to insert in each layer L -! Set for log-spacing of tau levels, increasing top-down. -! AER(1:4,L) = aerosol+cloud OD (up to 4 types, index type = ADX(1:4,L) -! AER(5,L) = Rayleigh-not used here -! -! N.B. the TTAU, etc caluclate here are not really used elsewhere - -!---The log-spacing parameters have been tested for convergence and chosen -!--- to be within 0.5% for ranges OD=1-500, rflect=0-100%, mu0=0.1-1.0 -!--- use of ATAU = 1.18 and min = 0.01, gives at most +135 pts for OD=100 -!----------------------------------------------------------------------- -! - implicit none - integer, intent(in) :: JTAUMX,L1X,L2X !index of cloud/aerosol - integer, intent(in) :: NX !Mie scattering array size - real*8, intent(in) :: AER(5,L1X) !cloud+3aerosol OD in each layer - real*8, intent(in) :: ATAU,ATAU0 - integer, intent(in) :: ADX(5,L1X) !index of cloud/aerosol - integer, intent(out) :: JXTRA(L2X+1) !number of sub-layers to be added -! - integer JTOTL,I,L,L2 - real*8 DTAUX(L1X),TTAU(L2X+1),DTAUJ, ATAU1,ATAULN,ATAUM,ATAUN1 -! -!---Reinitialize arrays - TTAU(:) = 0.d0 - JXTRA(:) = 0 -! -!---Set up total optical depth over each CTM level (L=1:L1X) -!--- DTAUX(L) = bulk properties (OD) of each CTM layer - - do L = 1,L1X -! Total optical depth from all elements I=1:4 = clouds + 3 aerosol types -! Assume here that AER(1:4, 1:L1X) is 'visible' Optical Depth = 600 nm -! do NOT count if ADX = 0 - DTAUX(L) = 0.d0 - do I = 1,4 - if (ADX(I,L) .gt. 0) DTAUX(L) = DTAUX(L) + AER(I,L) - enddo - enddo -! -!---combine these edge- and mid-layer points into grid of size: -!--- L2X+1 = 2*L1X+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2X+1) -!--- note that TTAU(L2X+1)=0 and TTAU(1)=total OD -! -!---Divide thick layers to achieve better accuracy in the scattering code -!---In the original fast-J, equal sub-layers were chosen, this is wasteful -!---and this new code (ver 5.3) uses log-scale: -!--- Each succesive layer (down) increase thickness by ATAU > 1 -!--- e.g., if ATAU = 2, a layer with OD = 15 could be divided into -!--- 4 sub-layers with ODs = 1 - 2 - 4 - 8 -!---The key parameters are: -!--- ATAU = factor increase from one layer to the next -!--- ATAUMN = the smallest OD layer desired -!--- JTAUMX = maximum number of divisions (i.e., may not get to ATAUMN) -!---These are hardwired below, can be changed, but have been tested/optimized - - ATAU1 = ATAU - 1.d0 - ATAULN = log(ATAU) - TTAU(L2X+1) = 0.0d0 - do L2 = L2X,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ -!---Now compute the number of log-spaced sub-layers to be added in -!--- the interval TTAU(L2) > TTAU(L2+1) -!---The objective is to have successive TAU-layers increasing by factor ATAU >1 -!---the number of sub-layers + 1 - if (TTAU(L2) .lt. ATAU0) then - JXTRA(L2) = 0 - else - ATAUM = max(ATAU0, TTAU(L2+1)) - ATAUN1 = log(TTAU(L2)/ATAUM) / ATAULN - JXTRA(L2) = min(JTAUMX, max(0, int(ATAUN1 - 0.5d0))) - endif - enddo - -!---check on overflow of arrays, cut off JXTRA at lower L if too many levels - JTOTL = L2X + 2 - do L2 = L2X,1,-1 - JTOTL = JTOTL + JXTRA(L2) - if (JTOTL .gt. NX/2) then - write(6,'(A,2I5,F9.2)') 'N_/L2_/L2-cutoff JXTRA:',NX,L2X,L2 - do L = L2,1,-1 - JXTRA(L) = 0 - enddo - go to 10 - endif - enddo - 10 continue - - return - end subroutine EXTRAL - - -!----------------------------------------------------------------------- - subroutine OPMIE & - & (KW,KM,WAVEL,ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,FMEAN) -!----------------------------------------------------------------------- -! in: -! KW = wavelength bin # (1:18) -! KM = wavelength index for Mie properties (1:4 = 300-400-600-999 nm) -! WAVEL = wavelength of bin (in nm) - not now used -! ABX(L1_) = vertical profiles of ABSORPTION Optical Depth in each layer -! includes O2 and O3 for now (BC under aerosols) -! AER(1:5,1:L1_) = 5 vertical profiles of Optical Depth in each layer -! ADX(1:5,1:L1_) = integer index of the scattering properties of each AER -! 1:4 are reserved for aerosols and clouds -! 5 is meant only for Rayleigh scattering! -! JXTRA(1:L1_) = number 0:J = no. of additional levels to be inserted -! U0 = cos (SZA) -! RFLECT = Lambertian albedo of surface -! out: -! FMEAN(1:L_) = mean actinic flux at standard CTM levels (mid-layer) -!----------------------------------------------------------------------- -! -! DTAUX Local optical depth of each CTM level -! TTAU Optical depth of air vertically above each point (to top of atm) -! FTAU Attenuation of solar beam -! POMEGA Scattering phase function -! -!---new Ver 5.3 code adds sub-layers (# = JXTRA(L2)) using ATAU as the -! factor increase from sub-layer to sub-layer - -! fast-J Mie code for J_s, only uses 8-term expansion, 4-Gauss pts -! Currently allow up to A_ aerosol phase functions (at all altitudes) to -! be associated with optical depth AER(1:L2_) = aerosol opt.depth @ 1000 nm -! -! Pick Mie-wavelength with phase function and Qext: e.g., -! 01 RAYLE = Rayleigh phase -! 02 ISOTR = isotropic -! 03 ABSRB = fully absorbing 'soot', wavelength indep. -! 04 X_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -! 05 X_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -!. . . -! 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -!. . . -! 13 Ice-H = hexagonal ice cloud (Mishchenko) -! 14 Ice-I = irregular ice cloud (Mishchenko) -! -! Choice of the 4 aerosol/cloud indices ADX is made earlier -! Optical depths for the 4 (aerosol+clouds) = AER -! -!----------------------------------------------------------------------- - implicit none -# include "fastJX53b_parm_CTM.h" -# include "fastJX53b_parm_MIE.h" -# include "fastJX53b_cmn_JVdat.h" - - real*8, intent(in) :: WAVEL,AER(5,L1_),ABX(L1_),AMF(L1_,L1_) - real*8, intent(in) :: U0,RFLECT - integer, intent(in) :: KW,KM,ADX(5,L1_) - integer, intent(in) :: JXTRA(L2_+1) - real*8, intent(out) :: FMEAN(L_) -! - integer JNDLEV(L_),JADDLV(L2_+1),JADDTO(L2_+1),L2LEV(L2_+1) & - & ,JTOTL,I,II,J,K,L,IX,JK, L2,L2L,L22,LZ,LZZ,NDZ -! - real*8 QXMIE(5),XLAER(5),SSALB(5),DTAUX(L1_),PIAER(5,L1_) & - & ,POMEGAJ(2*M_,L2_+1),TTAU(L2_+1),FTAU(L1_) & - & ,FTAU2(L2_+1),DTTAU,DFTAU,dPOMEGA(2*M_) & - & ,XLO2,XLO3,XLRAY,XLTAU,ZK,TAUDN,TAUUP,ZK2 & - & ,DTAUJ,DTAUAD,TAUBTM,TAUTOP,FBTM,FTOP,POMEGAB(2*M_) & - & ,ATAUA,ATAUZ -!--- variables used in mie code----------------------------------------- - real*8 FJ(N_),POMEGA(2*M_,N_),FZ(N_),ZTAU(N_),ZREFL,ZU0,ZFLUX - integer MFIT, ND - -!---Reinitialize arrays - ZTAU(:) = 0.d0 - FZ(:) = 0.d0 - POMEGA(:,:) = 0.d0 - - -!---Set up optical depth DTAUX(L), and scattering fraction PIAER(1:5,L) -!--- where L = 1:L1_ = bulk properties of each CTM layer. - do L = 1,L1_ - - do I = 1,4 - if (ADX(I,L) .eq. 0) then - QXMIE(I) = 0.d0 - SSALB(I) = 0.d0 - else -!---for Mie code scale extinction at 600 nm to wavelength WAVEL (QXMIE) - QXMIE(I) = QAA(KM,ADX(I,L))/QAA(3,ADX(I,L)) - SSALB(I) = SSA(KM,ADX(I,L)) - endif - enddo -!---special case for Rayleigh scattering - QXMIE(5) = 1.d0 - SSALB(5) = 1.d0 - do I = 1,5 - XLAER(I) = AER(I,L)*QXMIE(I) - enddo - - DTAUX(L) = ABX(L) - do I = 1,5 - DTAUX(L) = DTAUX(L) + XLAER(I) - enddo -!---fractional extinction for Rayleigh scattering and each aerosol type - do I = 1,5 - PIAER(I,L) = SSALB(I)*XLAER(I)/DTAUX(L) - enddo - - enddo - -!---Calculate attenuated incident beam exp(-TTAU/U0 = DTAUX * AirMassFactor) -!--- at the edges of the CTM layers L=1:L1_ - do L = 1,L1_ - if (AMF(L,L) .gt. 0.0d0) then - XLTAU = 0.0d0 - do I = 1,L1_ - XLTAU = XLTAU + DTAUX(I)*AMF(I,L) - enddo - if (XLTAU .gt. 76.d0) then ! zero out flux at 1e-33 - FTAU(L) = 0.d0 - else - FTAU(L) = exp(-XLTAU) - endif - else - FTAU(L) = 0.0d0 - endif - enddo -! -!---Define the total scattering phase fn for each CTM layer L=1:L_+1 -!--- from a DTAUX-wt_d mix of aerosols, cloud & Rayleigh -!---No. of quadrature pts fixed at 4(M_), expansion of phase fn @ 8 - MFIT = 2*M_ - do L = 1,L1_ - do I = 1,MFIT - POMEGAJ(I,L) = 0.d0 - do K = 1,5 - POMEGAJ(I,L)=POMEGAJ(I,L) + PIAER(K,L)*PAA(I,KM,ADX(K,L)) - enddo - enddo - enddo - -!--printout diagnositcs of different aerosol+cld contrib to OD -! if(KW.eq.18) then -! do L=1,L1_ -! write(6,'(3i5,1p,20e12.5)') L,JXTRA(L+L),JXTRA(L+L-1), -! & DTAUX(L),(AER(I,L),I=1,5) -! enddo -! endif - -! -!------------------------------------------------------------------------ -! Take optical properties on CTM layers and convert to a photolysis -! level grid corresponding to layer centres and boundaries. This is -! required so that J-values can be calculated for the centre of CTM -! layers; the index of these layers is kept in the JNDLEV array. -!------------------------------------------------------------------------ -! -!---Now combine the CTM layer edges (1:L_+2) with the CTM mid-layer -!--- points (1:L_) plus 1 for the mid point of added top layer. - -!---combine these edge- and mid-layer points into grid of size: -!--- L2_+1 = 2*L1_+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2_+1) -!--- note that TTAU(L2_+1)=0 and TTAU(1)=total OD - TTAU(L2_+1) = 0.0d0 - do L2 = L2_,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ - enddo -! -!---reflected flux from surface - if (U0 .gt. 0.d0) then - ZFLUX = U0*FTAU(1)*RFLECT/(1.d0+RFLECT) - else - ZFLUX = 0.d0 - endif -! -!---calculate attenuated beam FTAU2 on the new doubled-levels L2=1:L2_+1 -!--- calculate FTAU2 at CTM mid-layers from sqrt -!--- L2_ = 2*L1_ = 2*L_+2 - - FTAU2(L2_+1) = 1.0d0 - FTAU2(L2_) = sqrt(1.0d0*FTAU(L1_)) - FTAU2(L2_-1) = FTAU(L1_) - do L2 = L2_-3,1,-2 - L = (L2+1)/2 - FTAU2(L2) = FTAU(L) - FTAU2(L2+1) = sqrt(FTAU(L+1)*FTAU(L)) - enddo -! -! Calculate scattering properties, level centres then level boundaries -! ***be careful of order, we are shifting the 'POMEGAJ' upward in index*** - do L2 = L2_,2,-2 - L = L2/2 - do I = 1,MFIT - POMEGAJ(I,L2) = POMEGAJ(I,L) - enddo - enddo -!---lower boundary value is set (POMEGAJ(I,1), but set upper: - do I = 1,MFIT - POMEGAJ(I,L2_+1) = POMEGAJ(I,L2_) - enddo -!---now have POMEGAJ filled at even points from L2=3:L2_-1 -!---use inverse interpolation for correct tau-weighted values at edges - do L2 = 3,L2_-1,2 - TAUDN = TTAU(L2-1)-TTAU(L2) - TAUUP = TTAU(L2)-TTAU(L2+1) - do I = 1,MFIT - POMEGAJ(I,L2) = (POMEGAJ(I,L2-1)*TAUDN + & - & POMEGAJ(I,L2+1)*TAUUP) / (TAUDN+TAUUP) - enddo - enddo -!---at this point FTAU2(1:L2_+1) and POMEAGJ(1:8, 1:L2_+1) -!--- where FTAU2(L2_+1) = 1.0 = top-of-atmos, FTAU2(1) = surface -! -!------------------------------------------------------------------------ -! Calculate cumulative total and define levels we want J-values at. -! Sum upwards for levels, and then downwards for Mie code readjustments. -! -! JXTRA(L2) Number of new levels to add between (L2) and (L2+1) -! ***JXTRA(1:L2_+1) is calculated based on the aerosol+cloud OD_s -! JADDLV(L2) Number of new levels actually added at each wavelength -! where JADDLV = 0 when there is effectively no FTAU2 -! JADDTO(L2) Total number of new levels to add to and above level (L2) -! JNDLEV(L) = L2 index that maps on CTM mid-layer L -! -!------------------------------------------------------------------------ - -!---JADDLV(L2=1:L2_) = number of levels to add between TTAU2(L2) and TTAU(L2+1) -!--- JADDLV is taken from JXTRA, which is based on visible OD. -!--- JADDTO(L2=1:L2_+1) is the cumulative number of levels to be added -!---note that JADDLV and JADDTO will change with wavelength and solar zenith - -!--now try to insert additional levels for thick clouds, ONLY IF FTAU2 > 1.e-8 -!-- this will cut off additional levels where the solar beam is negligible. - - do L2 = 1,L2_ - if (FTAU2(L2+1) .lt. 1.d-30) then - JADDLV(L2) = 0 - else - JADDLV(L2) = JXTRA(L2) - endif - enddo - JADDTO(L2_+1) = 0 - do L2 = L2_,1,-1 - JADDTO(L2) = JADDTO(L2+1) + JADDLV(L2) - enddo - -!---expanded grid now included CTM edge and mid layers plus expanded -!--- grid to allow for finer delta-tau at tops of clouds. -!--- DIM of new grid = L2_ + JADDTO(1) + 1 - -!---L2LEV(L2) = L2-index for old level L2 in expanded J-grid (w/JADDLV) -! in absence of JADDLV, L2LEV(L2) = L2 - L2LEV(1) = 1 - do L2 = 2,L2_+1 - L2LEV(L2) = L2LEV(L2-1) + 1 + JADDLV(L2-1) - enddo - -!---JNDLEV(L=1:L_) = L2-index in expanded grid for CTM mid-layer L - do L = 1,L_ - JNDLEV(L) = L2LEV(2*L) - enddo - -!---------------------SET UP FOR MIE CODE------------------------------- -! -! Transpose the ascending TTAU grid to a descending ZTAU grid. -! Double the resolution - TTAU points become the odd points on the -! ZTAU grid, even points needed for asymm phase fn soln, contain 'h'. -! Odd point added at top of grid for unattenuated beam (Z='inf') -! -! The following mapping holds for JADDLV=0 -! Surface: TTAU(1) ==> ZTAU(2*L2_+1) -! Top: TTAU(L2_) ==> ZTAU(3) -! Infinity: 0.0 ==> ZTAU(1) -! index: 2*(L2_+1-L2)+1 ==> LZ -! -! Mie scattering code only used from surface to level L2_ -!------------------------------------------------------------------------ -! -!------------------------------------------------------------------------ -! Insert new levels, working downwards from the top of the atmosphere -! to the surface (down in 'LZ', up in 'L2'). This allows ztau and pomega -! to be incremented linearly (in a +ve sense), and the flux fz to be -! attenuated top-down (avoiding problems where lower level fluxes are -! zero). -! -! zk fractional increment in level -! dTTAU change in ttau per increment (linear, positive) -! dPOMEGA change in pomega per increment (linear) -! ftaulog change in ftau per increment (exponential, normally < 1) -! -!------------------------------------------------------------------------ -! -! Ascend through atmosphere transposing grid and adding extra points -! remember L2=1 is surface of CTM, but last layer (LZ) in scattering code. -! there are twice the number of layers in the LZ arrays (2*L2_ + 2*JADDTO + 1) -! because we need to insert the intermediate layers (even LZ) for the -! asymmetric scattering code. - - -! Transfer the L2=1:L2_+1 values (TTAU,FTAU2,POMEGAJ) onto the reverse -! order, expanded, doubled-level scatter grid. -! Note that we need to deal with the expansion by JADD levels (L2L). -! These JADDLV levels are skipped and need to be interpolated later. -! Note that only odd LZ levels are filled, - - NDZ = 2*L2_ + 2*JADDTO(1) + 1 - -! Note that the successive sub-layers have the ratio in OD of ATAU -! ATAUA = (ATAU - 1.d0)/ATAU ! this is the limit for L22=>inf - - do L2 = 1,L2_+1 ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - ZTAU(LZ) = TTAU(L2) - FZ(LZ) = FTAU2(L2) - do I=1,MFIT - POMEGA(I,LZ) = POMEGAJ(I,L2) - enddo - enddo - -! Now go thru the pairs of L2 levels to see if we need JADD levels - do L2 = 1,L2_ ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - L22 = L2LEV(L2+1) - L2LEV(L2) - 1 ! L22 = 0 if no added levels - if (L22 .gt. 0) then - TAUBTM = TTAU(L2) - TAUTOP = TTAU(L2+1) - FBTM = FTAU2(L2) - FTOP = FTAU2(L2+1) - do I = 1,MFIT - POMEGAB(I) = POMEGAJ(I,L2) - enddo - -!---to fit L22 new layers between TAUBOT > TAUTOP, calculate new 1/ATAU factor -!--- such that TAU(just above TAU-btm) = ATUAZ * TAUBTM < TAUBTM - - ATAUZ = exp(-log(TAUBTM/max(TAUTOP,ATAU0))/float(L22+1)) - - do L = 1,L22 ! add odd levels between L2LEV(L2) & L2LEV(L2+1) - LZZ = LZ - 2*L ! LZZ = index(odd) of added level in scatt arrays - ZTAU(LZZ) = TAUBTM * ATAUZ - ATAUA=(TAUBTM-ZTAU(LZZ))/(TAUBTM-TAUTOP) !fraction from TAUBTM=>TAUTOP - if (FBTM .lt. 1.d-32) then - FZ(LZZ) = 0.d0 - else - FZ(LZZ) = FBTM * (FTOP/FBTM)**ATAUA - endif - do I = 1,MFIT - POMEGA(I,LZZ) = POMEGAB(I) + & - & ATAUA*(POMEGAJ(I,L2+1)-POMEGAB(I)) - enddo - TAUBTM = ZTAU(LZZ) - FBTM = FZ(LZZ) - do I = 1,MFIT - POMEGAB(I) = POMEGA(I,LZZ) - enddo - enddo - endif - enddo - -! Now fill in the even points with simple interpolation in scatter arrays: - do LZ = 2,NDZ-1,2 - ZTAU(LZ) = 0.5d0*(ZTAU(LZ-1)+ZTAU(LZ+1)) - FZ(LZ) = sqrt(FZ(LZ-1)*FZ(LZ+1)) - do I=1,MFIT - POMEGA(I,LZ) = 0.5d0*(POMEGA(I,LZ-1)+POMEGA(I,LZ+1)) - enddo - enddo - - ND = NDZ - ZU0 = U0 - ZREFL = RFLECT - -!---PRINT diagnostics -! write(6,'(A,2I6)') 'Total levels of photolysis in OPMIE',ND - if(ND .gt. N_) then - write(6,'(a,2i9)') ' overflow of scatter arrays:',ND,N_ - stop - endif - -!----------------------------------------- - call MIESCT(FJ,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,ZU0,MFIT,ND) -!----------------------------------------- - -!---Move mean intensity from scatter array FJ(LZ=1:ND) -!--- to CTM mid-level array FMEAN(L=1:L_) - do L = 1,L_ - L2L = JNDLEV(L) - LZ = ND+2 - 2*L2L - FMEAN(L) = FJ(LZ) - enddo - - return - end subroutine OPMIE - -!<<<<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>current code revised to JX ver 5.3b (7/05)<<<<<<<<<<<< -! version 5.3b changes include: -! new data files for specral Xsection and mie-scattering. -! add sub-layers (JXTRA) to thick cloud/aerosol layers, -! sets up log-spaced sub-layers of increasing thickness ATAU -! correction 'b' does massive clean up of the linking code, -! now the only subroutine that has access to CTM arrays is PHOTOJ -! Also, the access to the cmn_JVdat.h is 'read-only' after init. -! This should enable safe openMP/MPI coding. -! -! common files and what they mean: -! parm_CTM.h dimensions & params for code (CTM and fast-JX) -! parm_MIE.h dimensions for mie code variables. -! cmn_metdat.h CTM 3-D arrays, time of day, grid, etc. -! cmn_JVdat.h Xsects, Mie, etc., (initialized and then read-only) -! -!<<<<<<<<<<<<<<<<<<<<>>>>overall program revised to run with FAST-JX J-code ver 5.3 (6/05) -! >>>>> now designed to use log spacing in TAU to get <0.5% accuracy -! much better accuracy and fewer added levels vs. old linear adds. -! -!----------------------------------------------------------------------- -! -!<<<<<<<<<<<<<<<<<<<< sub-b code has vastly cleaned up the interfaces and is - now ready for parallel implementation. Also the - standalone version is simpler! - > vastly simplified calling sequences, reduced use of commons - > simplified input datasets - > updated cross-sections AND code for generating new X-sections. - >>> new, improved method for adding layers for thick clouds: - uses log-spacing factor of 1.18 (error in tests <0.3%) - reduces the number of layers (linear with comp costs) - log-spacing eliminates need for upper bound on cloud OD - eliminated some unnecessary bits of previous fast-J - -The common blocks (all local) needed for Mie scattering have been -replaced with local internal arrays passed through calls. - -The new code has been implemented in UCI's CTM with openMP. - ------------------------------------------------------------------ -The new standalone version of fast-JX (fast-JX53.f) requires: - parm_CTM.f parameters for CTM dimensions - parm_MIE.f parameters for Mie scattering arrays - cmn_metdat.f common blocks w/ general CTM data for fast-JX - cmn_JVdat.f common blocks w. specific data for J-values - -The needed data sets standalone runs are included: - FJX_spec.dat spectral data (X-sections+) ver 2005e - FJX-scat.dat scattering data for clouds+aerosols - this data set has been separated from the X-sections - - these are for the standalone run and will not be needed in CTM run - FJX_test.dat set up for p, T, grid etc - atmos_std.dat UCI's old std atmospheres - ECT42_grid.dat used for sample run - ratj.dat UCI's old chemistry set of J's, - shows mapping from fast-JX - - std.out output from this test of fast-JX53 standalone - ------------------------------------------------------------------ - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTM_FastjLinking_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTM_FastjLinking_mod.F90 deleted file mode 100644 index 97f766bb..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTM_FastjLinking_mod.F90 +++ /dev/null @@ -1,242 +0,0 @@ -!------------------------------------------------------------------------- -! NASA/GFSC, SIVO, Code 610.3 -!------------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cCTM_FastjLinking_mod -! -! !INTERFACE: -! - module FastJX53cCTM_FastjLinking_mod -! - implicit none -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: PHOTOJ -! -! !DESCRIPTION: -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- - CONTAINS - -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: PHOTOJ -! -! !INTERFACE: -! - subroutine PHOTOJ(UTIME,IDAY,ILNG,JLAT, SZA, U0, FREFL, ZPJ) -! -! !USES: -! - use FastJX53cMetVars_mod , only : ETAA, ETAB, DM, TJ, DO3, SA - use FastJX53cMetVars_mod , only : P, ZH, YGRD, XGRD, PJ - use FastJX53cMetVars_mod , only : NAER1, NAER2, NAER3, NCLDX - use FastJX53cMetVars_mod , only : DAER1, DAER2, DAER3, ODCLD - use FastJX53cJvaluesVars_mod , only : RAD, NAA, JTAUMX, ZZHT, ATAU, ATAU0 - use FastJX53cJvaluesVars_mod , only : JIND, JFACTA, NJVAL, NW1, NW2, NRATJ - use FastJX53cJvaluesVars_mod , only : WL, FL, QRAYL, TQQ, QO2, QO3 - use FastJX53cCTMparameters_mod, only : L_, L1_, L2_, W_, X_, JVL_, JVN_, SZAMAX - use FastJX53cMIEparameters_mod, only : N_ - use FastJX53cCoreFastj_mod , only : EXTRAL, SOLARZ, OPMIE, SPHERE - use FastJX53cCoreFastj_mod , only : FLINT, JRATET, JP_ATM -! - implicit none -! -! !INPUT PARAMETERS: - real*8, intent(in) :: UTIME - integer,intent(in) :: IDAY,ILNG,JLAT - real*8, intent(in) :: SZA -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: ZPJ(JVL_,JVN_) !2-D array of J's indexed to CTM chemistry! - real*8 , intent(out) :: FREFL, U0 !fraction of energy reflected -! -! !DESCRIPTION: -! PHOTOJ is the gateway to fast-JX calculations: -! only access to CTM 3-D GLOBAL arrays -! sets up the 1-D column arrays for calculating J's -! \begin{verbatim} -! AVGF Attenuation of beam at each level for each wavelength -! FFF Actinic flux at each desired level -! XQO2 Absorption cross-section of O2 -! XQO3 Absorption cross-section of O3 -! \end{verbatim} -! -! !LOCAL VARIABLES: -!--------key amtospheric data needed to solve plane-parallel J--------- - real*8, dimension(5,L1_) :: AER - integer,dimension(5,L1_) :: ADX - real*8, dimension(L1_) :: ABX, TTJ,DDJ,ZZJ,ZHL - real*8, dimension(L1_+1) :: PPJ - integer,dimension(L2_+1) :: JXTRA - - real*8 :: RFLECT,SOLF,FREFS,FTOP,FBOT - real*8 :: AMF(L1_,L1_) -!------------key arrays AFTER solving for J's--------------------------- - real*8 FFF(W_,JVL_),VALJ(X_) - real*8 VALJL(JVL_,NJVAL) !2-D array of J_s returned by JRATET - - integer I,J,K,L,M,KM - real*8 AVGF(L_),XQO3,XQO2 ,WAVE, TTT -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!----------------------------------------------------------------------- -!BOC - ZPJ(:,:) = 0.d0 - FFF(:,:) = 0.d0 - FREFL = 0.d0 - FREFS = 0.d0 -!----------------------------------------------------------------------- - call SOLARZ(UTIME,IDAY,YGRD(JLAT),XGRD(ILNG), SZA,U0,SOLF) -!----------------------------------------------------------------------- - SOLF = 1.d0 ! this needs to be dropped to include 6.7% annual cycle - -!---check for dark conditions SZA > 98.0 deg => tan ht = 63 km -! or 99. 80 km - if (SZA .gt. SZAMAX) goto 99 - -!---load the amtospheric column data - PPJ(:) = PJ(:) !! Added by Jules - do L = 1,L1_ -! PPJ(L) = ETAA(L) + ETAB(L)*P(ILNG,JLAT) ! commented out by Jules - TTJ(L) = TJ(ILNG,JLAT,L) - DDJ(L) = DM(ILNG,JLAT,L) - ZZJ(L) = DO3(ILNG,JLAT,L) - enddo -! PPJ(L1_+1) = 0.d0 ! commented out by Jules - -!---calculate spherical weighting functions (AMF: Air Mass Factor) - do L = 1,L1_ - ZHL(L) = ZH(ILNG,JLAT,L) - enddo - -!----------------------------------------------------------------------- - call SPHERE(U0,RAD,ZHL,ZZHT,AMF,L1_) -!----------------------------------------------------------------------- - -!---load the profiles of aerosols & clouds: treated as the same from here - do L = 1,L1_ - AER(1,L) = DAER1(ILNG,JLAT,L) ! Opt. Depth aerosol 1 in layer L - AER(2,L) = DAER2(ILNG,JLAT,L) ! Opt. Depth aerosol 2 in layer L - AER(3,L) = DAER3(ILNG,JLAT,L) ! Opt. Depth aerosol 3 in layer L - AER(4,L) = ODCLD(ILNG,JLAT,L) ! cloud Opt. Depth in L - AER(5,L) = 0.d0 ! save space for Rayleigh - ADX(1,L) = NAER1(ILNG,JLAT,L) ! index for aerosol 1 at layer L - ADX(2,L) = NAER2(ILNG,JLAT,L) ! index for aerosol 2 at layer L - ADX(3,L) = NAER3(ILNG,JLAT,L) ! index for aerosol 3 at layer L - ADX(4,L) = NCLDX(ILNG,JLAT,L) ! index for cloud at layer L - ADX(5,L) = 1 ! index for Rayleigh phase in L - enddo - - do L = 1,L1_ - do I=1,4 - ADX(I,L) = min(NAA, max(0, ADX(I,L))) - enddo - enddo - -!---Now given the aerosol+cloud OD/layer in visible (600 nm) can calculate -! how to add additonal levels at top of clouds (now uses log spacing) -!----------------------------------------------------------------------- - call EXTRAL(AER,ADX,L1_,L2_,N_,JTAUMX,ATAU,ATAU0, JXTRA) -!----------------------------------------------------------------------- - -!---set surface reflectance - RFLECT = SA(ILNG,JLAT) - RFLECT = max(0.d0,min(1.d0,RFLECT)) - -!---Loop over all wavelength bins to calc mean actinic flux AVGF(L) - do K = NW1,NW2 - WAVE = WL(K) -!---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 ! use 300 nm aerosol properties for <355 nm - if( WAVE .gt. 355.d0 ) KM=2 ! use 400 nm prop for 355-500 nm - if( WAVE .gt. 500.d0 ) KM=3 - if( WAVE .gt. 800.d0 ) KM=4 - -!---Loop over CTM layers L=1:L1_ = 1:L_+1, -! values at L1_=L_+1 are a pseudo layer above the top CTM layer (L_) - do L = 1,L1_ - TTT = TTJ(L) - XQO3 = FLINT(TTT,TQQ(1,2),TQQ(2,2),TQQ(3,2) & - & ,QO3(K,1),QO3(K,2),QO3(K,3)) - XQO2 = FLINT(TTT,TQQ(1,1),TQQ(2,1),TQQ(3,1) & - & ,QO2(K,1),QO2(K,2),QO2(K,3)) - - ABX(L) = XQO3*ZZJ(L) + XQO2*DDJ(L)*0.20948d0 - - AER(5,L) = DDJ(L)*QRAYL(K) - enddo - -!----------------------------------------------------------------------- - call OPMIE(K,KM, WAVE, ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,AVGF,FTOP,FBOT) -!----------------------------------------------------------------------- - - do L = 1,JVL_ - FFF(K,L) = FFF(K,L) + SOLF*FL(K)*AVGF(L) - enddo - FREFL = FREFL + SOLF*FL(K)*FTOP/WAVE - FREFS = FREFS + SOLF*FL(K)/WAVE - - enddo ! loop over wavelength K - - FREFL = FREFL/FREFS !calculate reflected flux (energy weighted) - -!----------------------------------------------------------------------- - call JRATET(PPJ,TTJ,FFF, VALJL) -!----------------------------------------------------------------------- - -!---map the J-values from fast-JX onto ASAD ones (use JIND & JFACTA) - do L = 1,JVL_ - do J = 1,NRATJ - if (JIND(J).gt.0) then - ZPJ(L,J) = VALJL(L,JIND(J))*JFACTA(J) - else - ZPJ(L,J) = 0.d0 - endif - enddo - enddo - -!---diagnostics that are NOT returned to the CTM code - -!----------------------------------------------------------------------- - write(6,*) 'fast-JX(5.3b)--------------internal print------------' - - call JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) - -!---Print solar flux terms - write(6,'(a,5f10.4)') ' fast-JX: SZA/u0/Frefl/albedo/SOL*fact/', & - & SZA,U0,FREFL,RFLECT,SOLF - write(6,'(a5,18i9)') ' bin:',(K, K=NW1,NW2) - write(6,'(a5,18f9.2)') ' wvl:',(WL(K), K=NW1,NW2) - do L = JVL_,1,-1 - write(6,'(i3,2x,18f9.6)') L,(FFF(K,L)/FL(K),K=NW1,NW2) - enddo - write(6,*) 'fast-JX(5.3b)--------------internal print------------' -!----------------------------------------------------------------------- - - 99 continue - - return - - end subroutine PHOTOJ -!EOC -!----------------------------------------------------------------------- - - end module FastJX53cCTM_FastjLinking_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMparameters_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMparameters_mod.F90 deleted file mode 100644 index 835a58a9..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMparameters_mod.F90 +++ /dev/null @@ -1,96 +0,0 @@ -!----------------------------------------------------------------------- -! NASA/GSFC - SIVO ASTG Code 610.3 ! -!----------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cCTMparameters_mod -! -! !INTERFACE: - module FastJX53cCTMparameters_mod -! - IMPLICIT NONE -! -! !PUBLIC MEMBER FUNCTIONS: - private - public :: SetFastjCTMdims -! -! !PUBLIC DATA MEMBERS: -! - public :: I_ , J_ , L_ , LWE_ - public :: JVL_ , JVN_ , W_ , X_ , A_ - public :: L1_ , L2_ - public :: MX , NTR_ - public :: SZAMAX - - integer :: I_ ! longitude dim of CTM grid - integer :: J_ ! latitude dim of CTM grid - integer :: L_ ! altitude(levels) dim of CTM grid - integer :: JVL_ ! vertical(levels) dim for J-values - integer :: JVN_ ! no. of J-values - integer :: L1_ - integer :: L2_ ! 2*L_+2 ! 2*L1_ = 2*L_ + 2 = no. levels in the basic Fast-JX grid (mid-level) - integer, parameter :: LWE_ = 37 ! for EC T42L37 - altitude(level) dim for trop processes (clouds, rain) - integer, parameter :: A_ = 21 ! dim = no. of Aerosol/cloud Mie sets (input data) - integer, parameter :: W_ = 18 ! dim = no. of Wavelength bins - integer, parameter :: X_ = 64 ! dim = no. of X-section data sets (input data) - integer, parameter :: MX = 4 ! no. of aerosol/cloud types supplied from CTM - integer, parameter :: NTR_ = 1 ! no. of CTM tracers - real*8, parameter :: SZAMAX = 98.0d0 ! Solar zenith angle cut-off, above which to skip calculation -! integer, parameter :: I_ = 128 ! longitude dim of CTM grid -! integer, parameter :: J_ = 64 ! latitude dim of CTM grid -! integer, parameter :: L_ = 37 ! altitude(levels) dim of CTM grid -! integer, parameter :: L1_ = L_+1 -! integer, parameter :: L2_ = 2*L_+2 ! 2*L1_ = 2*L_ + 2 = no. levels in the basic Fast-JX grid (mid-level) -! integer, parameter :: JVL_ = 37 ! vertical(levels) dim for J-values -! integer, parameter :: JVN_ = 62 ! no. of J-values -! -! !DESCRIPTION: -! Defined CTM parameters. -! -! !AUTHOR: -! Michael Prather -! -! !HISTORY: -! -!EOP -!----------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SetFastjCTMdims -! -! !INTERFACE: -! - subroutine SetFastjCTMdims(iI_, jJ_, lL_, jJVL_, jJVN_) -! -! !INPUT PARAMETERS: - integer, intent(in) :: iI_, jJ_, lL_, jJVL_, jJVN_ -! !DESCRIPTION: -! Sets the values of some integer parameters. -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - I_ = iI_ - J_ = jJ_ - L_ = lL_ - JVL_ = jJVL_ - JVN_ = jJVN_ - L1_ = L_ + 1 - L2_ = 2*L_ + 2 - - return - - end subroutine SetFastjCTMdims -!EOC -!----------------------------------------------------------------------- - - end module FastJX53cCTMparameters_mod - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMspecific_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMspecific_mod.F90 deleted file mode 100644 index 5282d6fc..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCTMspecific_mod.F90 +++ /dev/null @@ -1,696 +0,0 @@ -!------------------------------------------------------------------------- -! NASA/GFSC, SIVO, Code 610.3 -!------------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cCTMspecific_mod -! -! !INTERFACE: -! - module FastJX53cCTMspecific_mod -! - implicit none -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: SET_ATM - public :: SET_AER - public :: SET_CLD - public :: INPHOT - public :: SET_CLD0 - public :: SET_AER0 - public :: SET_ATM0 -! -! !DESCRIPTION: -! Contains CTM-specific routines. -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_ATM -! -! !INTERFACE: -! - subroutine SET_ATM(GMTAU) -! -! !USES: -! - use FastJX53cMetVars_mod , only : T, P, PJ, PMEAN, TJ, DM, ETAA, ETAB - use FastJX53cMetVars_mod , only : ZH, STT, DO3, AREAXY, TCNAME - use FastJX53cCTMparameters_mod, only : I_, J_, L_, L1_, NTR_ -! - implicit none -! -! !INPUT PARAMETERS: - real*8, intent(in) :: GMTAU ! time -! -! !DESCRIPTION: -! Sets up atmosphere (p,T,O3,airmass, etc) for time GMTAU. -! -! !LOCAL VARIABLES: - real*8 MASFAC,SCALEH -! real*8 MASFAC,SCALEH,PJ(L1_+1) - integer I,J,L,N -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - - do J = 1,J_ - do I = 1,I_ - P(I,J) = PMEAN(I,J) -!Begin Jules Kouatchou 08/24/2006 -! do L = 1,L1_ -! PJ(L) = ETAA(L) + ETAB(L)*P(I,J) -! enddo -! PJ(L1_+1) = 0.d0 -!End Jules Kouatchou 08/24/2006 - do L = 1,L1_ - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = DO3(I,J,L)*DM(I,J,L) ! Jules Kouatchou 11/02/06 - enddo - do L = 1,L_ - TJ(I,J,L) = T(I,J,L) - enddo -!-------calculate effective altitude of each CTM level edge - ZH(I,J,1) = 16d5*log10(1000.d0/P(I,J)) - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -(log(PJ(L+1)/PJ(L))*SCALEH) - enddo - enddo - enddo - -!Begin Jules Kouatchou 08/24/2006 -!!---load O3 from CTM is being calculated: -! do N = 1,NTR_ -! if (TCNAME(N) .eq. 'O3') then -! do J = 1,J_ -! do I = 1,I_ -! do L = 1,L_ ! unit of DO3: # molecules/cm^2 -! DO3(I,J,L) = 6.023d26*STT(I,J,L,N)/48.d0 & -! & *1.d-4 /AREAXY(I,J) -! enddo -! enddo -! enddo -! endif -! enddo -!End Jules Kouatchou 08/24/2006 - - return - - end subroutine SET_ATM -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_AER -! -! !INTERFACE: -! - subroutine SET_AER(GMTAU) -! - implicit none -! -! !INPUT PARAMETERS: - real*8 ,intent(in) :: GMTAU ! dummy time -! -! !DESCRIPTION: -! Sets up aerosols for time GMTAU. -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - return - end subroutine SET_AER -!EOC -!----------------------------------------------------------------------- -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_CLD -! -! !INTERFACE: -! - subroutine SET_CLD(GMTAU) -! - implicit none -! -! !INPUT PARAMETERS: - real*8 ,intent(in) :: GMTAU ! dummy time -! -! !DESCRIPTION: -! Sets up cloud for time GMTAU. -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - return - end subroutine SET_CLD -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: INPHOT -! -! !INTERFACE: -! - subroutine INPHOT(CrossSection_InfileName, & - & ScatteringData_InfileName, & - & PhotRateLabels_InfileName, & - & T_O3_Climatology_InfileName) -! -! !USES: -! - use FastJX53cCoreFastj_mod, only : RD_XXX, RD_MIE - use FastJX53cJvaluesVars_mod, only : RAD, ZZHT - use FastJX53cMetVars_mod , only : TCNAME, STT -! - implicit none -! -! !INPUT PARAMETERS: - character (len=128), intent (in) :: CrossSection_InfileName - ! fast-J X-sections (spectral data) input file name - character (len=128), intent (in) :: ScatteringData_InfileName - ! Aerosol/cloud scattering data input file name - character (len=128), intent (in) :: PhotRateLabels_InfileName - ! Labels of photolysis rates required input file name - ! keyed to chem code - character (len=128), intent (in) :: T_O3_Climatology_InfileName - ! Read in T & O3 climatology input file name - ! general backup clim. -! -! !DESCRIPTION: -! Routine to initialise photolysis rate data, called directly from the -! cinit routine in ASAD. Currently use it to read the JPL spectral data -! and standard O3 and T profiles and to set the appropriate reaction index. -! \begin{verbatim} -! IPH Channel number for reading all data files -! RAD Radius of Earth (cm) -! ZZHT Effective scale height above top of atmosphere (cm) -! DATUMX Maximum opt.depth above which sub layers should be inserted -! SZAMAX Solar zenith angle cut-off, above which to skip calculation -! \end{verbatim} -! -! -! !LOCAL VARIABLES: - integer IPH -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - -! -! Defaults & constants - RAD = 6375.d5 - ZZHT = 5.d5 - STT(:,:,:,:) = 1.d6 - TCNAME(:) = 'CO2' - -! Use channel 8 to read files at the moment - IPH = 8 - -! Read in fast-J X-sections (spectral data) <<<<<<<<<<<<<< new fast-JX - call RD_XXX(IPH, CrossSection_InfileName) - -! Read in aerosol/cloud scattering data <<<<<<<<<<<<<<<<<< new fast-JX - call RD_MIE(IPH, ScatteringData_InfileName) - -! Read in labels of photolysis rates required >>>>> keyed to chem code - call RD_JS(IPH, PhotRateLabels_InfileName) -! -! Read in T & O3 climatology >>>> general backup clim. - call RD_PROF(IPH, T_O3_Climatology_InfileName) -! - return - end subroutine INPHOT -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: RD_JS -! -! !INTERFACE: -! - subroutine RD_JS(NJ1,NAMFIL) -! -! !USES: -! - use FastJX53cJvaluesVars_mod , only : JFACTA, JLABEL, TITLEJ - use FastJX53cJvaluesVars_mod , only : JIND, NRATJ, NJVAL - use FastJX53cCTMparameters_mod, only : JVN_ -! - implicit none -! -! -! !INPUT PARAMETERS: - integer , intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL -! -! !DESCRIPTION: -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield 'jfacta' and fastj2 label 'jlabel' -! \begin{verbatim} -! jfacta Quantum yield (or multiplication factor) for photolysis -! jlabel Reference label identifying appropriate J-value to use -! ipr Photolysis reaction counter - should total 'JVN_' -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer :: IPR, I, J, K - character*120 :: CLINE -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -! Reread the ratj.dat file to map photolysis rate to reaction -! Read in quantum yield jfacta and fastj2 label jlabel - IPR = 0 - open (NJ1,file=NAMFIL,status='old',form='formatted') - 10 read (NJ1,'(A)',err=20) CLINE - if (IPR .eq. JVN_) goto 20 - - if (CLINE(2:5).eq.'9999') then - go to 20 - elseif (CLINE(1:1).eq.'#') then - go to 10 - elseif (CLINE(5:5).eq.'$') then - go to 10 - else - IPR = IPR+1 - read (CLINE(79:83),'(F5.1)') JFACTA(IPR) - read (CLINE(86:92),'(A7)') JLABEL(IPR) - JFACTA(IPR) = JFACTA(IPR)/100.d0 -!Beg Jules Kouatchou 08/29/06 -! if (JLABEL(IPR) == "C3H6O") JLABEL(IPR) = "Acet-a" -!End Jules Kouatchou 08/29/06 - go to 10 - endif - 20 close(NJ1) - - NRATJ = IPR - -!----------------------------------------------------------------------- -! compare Xsections titles with J-values listed in chem code (jratd.dat) -! map the J-values needed for chemistry (ratj.dat) onto the fast-JX rates -! >>>>>>>>>>>>>>>>current code revised to JPL-02 ver 8.5 (5/05)<<<<<<<<< -! >>>this must now follow the read in of Xsects, etc<<< -!----------------------------------------------------------------------- - -!---Zero / Set index arrays that map Jvalue(j) onto rates - do J = 1,JVN_ - JIND(J) = 0 - enddo - do J = 1,NJVAL - do K = 1,NRATJ - if (JLABEL(K) .eq. TITLEJ(J)) JIND(K)=J - enddo - enddo - -! write(6,'(a,i4,a)') ' Photochemistry Scheme with ',IPR,' J-values' - do K=1,NRATJ - J = JIND(K) - if (J.eq.0) then - write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & - & ' has no mapping onto onto fast-JX' - else -! write(6,'(i5,a9,f6.2,a,i4,a9)') K,JLABEL(K),JFACTA(K), & -! & ' mapped onto fast-JX:',J,TITLEJ(J) - endif - enddo - - return - - end subroutine RD_JS -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: RD_PROF -! -! !INTERFACE: -! - subroutine RD_PROF(NJ2,NAMFIL) -! -! !USES: -! - use FastJX53cMetVars_mod, only : OREF, TREF -! - implicit none -! -! !INPUT PARAMETERS: - integer , intent(in) :: NJ2 - character(*), intent(in) :: NAMFIL -! -! !DESCRIPTION: -! Routine to input T and O3 reference profiles -! -! !LOCAL VARIABLES: - integer IA, I, M, L, LAT, MON, NTLATS, NTMONS, N216 - real*8 OFAC, OFAK - character*72 TITLE0 -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! - open (NJ2,file=NAMFIL,status='old',form='formatted') - read (NJ2,'(A)') TITLE0 - read (NJ2,'(2I5)') NTLATS,NTMONS -! write(6,'(1X,A)') TITLE0 -! write(6,1000) NTLATS,NTMONS - N216 = min(216, NTLATS*NTMONS) - do IA = 1,N216 - read (NJ2,'(1X,I3,3X,I2)') LAT, MON - M = min(12, max(1, MON)) - L = min(18, max(1, (LAT+95)/10)) - read (NJ2,'(3X,11F7.1)') (TREF(I,L,M), I=1,41) - read (NJ2,'(3X,11F7.4)') (OREF(I,L,M), I=1,31) - enddo - close (NJ2) - -! Extend climatology to 100 km - OFAC = exp(-2.d5/5.d5) - do I = 32,51 - OFAK = OFAC**(I-31) - do M = 1,NTMONS - do L = 1,NTLATS - OREF(I,L,M) = OREF(31,L,M)*OFAK - enddo - enddo - enddo - do L = 1,NTLATS - do M = 1,NTMONS - do I = 42,51 - TREF(I,L,M) = TREF(41,L,M) - enddo - enddo - enddo - - return -! 1000 format(1x,'std atmos profiles: ',i3,' lat x ',i2,' mon') - - end subroutine RD_PROF -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_CLD0 -! -! !INTERFACE: -! - subroutine SET_CLD0(TINIT,ODINIT,ODINDX,ALBEDO) -! -! !USES: -! - use FastJX53cMetVars_mod , only : T, ODCLD, SA, NCLDX - use FastJX53cCTMparameters_mod, only : I_, J_, L_, L1_ -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: ODINDX - real*8 , intent(in) :: TINIT(L_), ODINIT(L_), ALBEDO -! -! !DESCRIPTION: -! Routine to set cloud and surface properties: now loads the -! input prof's. -! -! {\bf This subroutine will need to be customized. -! It is separate from aerosols since it comes from met fields.} -! -! !LOCAL VARIABLES: - integer I, J, L -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! - do J = 1,J_ - do I = 1,I_ - do L = 1,L_ - ODCLD(I,J,L) = ODINIT(L) - T (I,J,L) = TINIT(L) - enddo - ODCLD(I,J,L1_) = 0.d0 - SA (I,J) = ALBEDO - enddo - enddo - NCLDX(:,:,:) = ODINDX - - return - - end subroutine SET_CLD0 -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_AER0 -! -! !INTERFACE: -! - subroutine SET_AER0 -! -! !USES: - use FastJX53cMetVars_mod , only : NAER1, NAER2, NAER3 - use FastJX53cMetVars_mod , only : DAER1, DAER2, DAER3 - use FastJX53cCTMparameters_mod, only : I_, J_, L_ -! - implicit none -! -! !DESCRIPTION: -! Set up aerosols. -! -! {\bf Customize for climatology or CTM as source.} -! -! !LOCAL VARIABLES: - integer I, J, L, K -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - -! Add aerosol OD and indices -! DAERn(L=1:L_) = aerosol/cloud Optical Depth (OD) within CTM layer L -! DAERn(L1_=L_+1)= aerosol/cloud OD in layer above CTM (L1_) - - NAER1(:,:,:) = 0 - NAER2(:,:,:) = 0 - NAER3(:,:,:) = 0 -! NAER1(:,:,:) = 3 ! Black carbon absorber -! NAER2(:,:,:) = 10 ! Water Cloud (Deirmenjian 8 micron) -! NAER3(:,:,:) = 14 ! Irregular Ice Cloud (Mishchenko) - do J = 1,J_ - do I = 1,I_ - do L = 1,L_+1 - DAER1(I,J,L) = 0.d0 - DAER2(I,J,L) = 0.d0 - DAER3(I,J,L) = 0.d0 - enddo - enddo - enddo - - return - - end subroutine SET_AER0 -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SET_ATM0 -! -! !INTERFACE: -! - subroutine SET_ATM0 -! -! !USES: - use FastJX53cMetVars_mod , only : OREF, TREF, DM, DO3, TJ, ZH, doModelClima - use FastJX53cMetVars_mod , only : ETAA, ETAB, PMEAN, MONTH, YDGRD - use FastJX53cCTMparameters_mod, only : I_, J_, L_, L1_ -! - implicit none -! -! !INPUT PARAMETERS: - -! -! !DESCRIPTION: -! Routine to set up atmospheric profiles required by Fast-J2 using a -! doubled version of the level scheme used in the CTM. First pressure -! and z* altitude are defined, then O3 and T are taken from the supplied -! climatology and integrated to the CTM levels (may be overwritten with -! values directly from the CTM, if desired). \newline -! Oliver (04/07/99) \& MJP (7/05) -! -! \begin{verbatim} -! PJ Pressure at boundaries of model levels (hPa) -! MASFAC Conversion factor for pressure to column density -! -! TJ Temperature profile on model grid -! DM Air column for each model level (molecules.cm-2) -! DO3 Ozone column for each model level (molecules.cm-2) -! ZH Altitude of boundaries of model levels (cm) -! PSTD Approximate pressures of levels for supplied climatology -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer I, J, K, L, M, N - real*8 PSTD(52),OREF2(51),TREF2(51),PJ(L1_+1) - real*8 DLOGP,F0,T0,PB,PC,XC,MASFAC,SCALEH -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -! Select appropriate month - M = max(1,min(12,MONTH)) - -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - MASFAC = 100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - - do J = 1,J_ - -! Select appropriate latitudinal profiles - N = max(1, min(18, (int(YDGRD(J))+99)/10 )) -! Temporary zonal arrays for climatology data - do K = 1,51 - if (.not. doModelClima) then ! Jules Kouatchou 08/31/06 - OREF2(K) = OREF(K,N,M) - TREF2(K) = TREF(K,N,M) - end if ! Jules Kouatchou 08/31/06 - enddo - - do I = 1,I_ - -! Apportion O3 and T on supplied climatology z* levels onto CTM levels -! with mass (pressure) weighting, assuming constant mixing ratio and -! temperature half a layer on either side of the point supplied. -! L1_ = L_+1: -! PJ(L=1:L1_) = pressure at CTM layer edge, PJ(L1_+1)=0 (top-of-atmos) - -!Begin Jules Kouatchou 08/24/2006 -! PJ(L1_+1) = 0.d0 -! do K = 1,L1_ -! PJ(K) = ETAA(K) + ETAB(K)*PMEAN(I,J) -! enddo -!End Jules Kouatchou 08/24/2006 - -! Set up pressure levels for O3/T climatology - assume that value -! given for each 2 km z* level applies from 1 km below to 1 km above, -! so select pressures at these boundaries. Surface level values at -! 1000 mb are assumed to extend down to the actual P(ILNG,JLAT). -! - PSTD(1) = max(PJ(1),1000.d0) - PSTD(2) = 1000.d0 * 10.d0**(-1.d0/16.d0) - DLOGP = 10.d0**(-2.d0/16.d0) - do K = 3,51 - PSTD(K) = PSTD(K-1)*DLOGP - enddo - PSTD(52) = 0.d0 - - do L = 1,L1_ - if (.not. doModelClima) then ! Jules Kouatchou 08/31/06 - F0 = 0.d0 - T0 = 0.d0 - end if ! Jules Kouatchou 08/31/06 - do K = 1,51 - PC = min(PJ(L),PSTD(K)) - PB = max(PJ(L+1),PSTD(K+1)) - if (PC .gt. PB) then - XC = (PC-PB)/(PJ(L)-PJ(L+1)) - if (.not. doModelClima) then ! Jules Kouatchou 08/31/06 - F0 = F0 + OREF2(K)*XC - T0 = T0 + TREF2(K)*XC - end if ! Jules Kouatchou 08/31/06 - endif - enddo - if (.not. doModelClima) then ! Jules Kouatchou 08/31/06 - TJ(I,J,L) = T0 - DM(I,J,L) = (PJ(L)-PJ(L+1))*MASFAC - DO3(I,J,L) = F0*1.d-6*DM(I,J,L) - end if ! Jules Kouatchou 08/31/06 - enddo - -! Calculate effective altitudes using scale height at each level - ZH(I,J,1) = 0.d0 - do L = 1,L_ - SCALEH = 1.3806d-19*MASFAC*TJ(I,J,L) - ZH(I,J,L+1) = ZH(I,J,L) -( LOG(PJ(L+1)/PJ(L)) * SCALEH ) - enddo - - enddo - enddo - - return - end subroutine SET_ATM0 -!EOC -!------------------------------------------------------------------------- - - end module FastJX53cCTMspecific_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreFastj_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreFastj_mod.F90 deleted file mode 100644 index e40032cc..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreFastj_mod.F90 +++ /dev/null @@ -1,1257 +0,0 @@ -!------------------------------------------------------------------------- -! NASA/GFSC, SIVO, Code 610.3 -!------------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cCoreFastj_mod -! -! !INTERFACE: -! - module FastJX53cCoreFastj_mod -! - implicit none -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: JRATET - public :: JP_ATM - public :: RD_XXX - public :: RD_MIE - public :: FLINT - public :: SOLARZ - public :: SPHERE - public :: EXTRAL - public :: OPMIE -! -! !DESCRIPTION: -! Contains core fast-J routines. -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: JRATET -! -! !INTERFACE: -! - subroutine JRATET(PPJ,TTJ,FFF, VALJL) -! -! !USES: - use FastJX53cJvaluesVars_mod , only : NJVAL, TQQ, QO2, QO3, Q1D, TITLEJ - use FastJX53cJvaluesVars_mod , only : NW1, NW2, QQQ - use FastJX53cCTMparameters_mod, only : L1_, W_, JVL_, X_ - - implicit none -! -! !INPUT PARAMETERS: - real*8, intent(in) :: PPJ(L1_+1) ! pressure profile at edges - real*8, intent(in) :: TTJ(L1_) ! temperatures at mid-level - real*8, intent(in) :: FFF(W_,JVL_) ! mean actinic flux -! -! !OUTPUT PARAMETERS: - real*8, intent(out) :: VALJL(JVL_,NJVAL) ! JVL_ = no of levels -! -! !DESCRIPTION: -! Calculate J-value, called by PTOTOJ. -! -! !LOCAL VARIABLES: - real*8 VALJ(X_) ! temp for call J's at one L - real*8 QO2TOT, QO3TOT, QO31DY, QO31D, QQQT, TFACT - real*8 TT,PP,DD,TT200,TFACA,TFAC0,TFAC1,TFAC2,QQQA,QQ2,QQ1A,QQ1B - integer J,K,L, IV -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - do L = 1,JVL_ ! master loop over layer = L - -!---need temperature and density (for some quantum yields): -!---in this case the Pressures PPJ are defined at the boundaries, -!--- Temperatures in the middle of each layer - TT = TTJ(L) - PP = (PPJ(L)+PPJ(L+1))*0.5d0 - if (L.eq.1) PP = PPJ(1) - DD = 7.24e18*PP/TT - - do J = 1,NJVAL - VALJ(J) = 0.d0 - enddo - - do K = NW1,NW2 ! Using model 'T's here - QO3TOT = FLINT(TT,TQQ(1,2),TQQ(2,2),TQQ(3,2) & - & ,QO3(K,1),QO3(K,2),QO3(K,3)) - QO2TOT = FLINT(TT,TQQ(1,1),TQQ(2,1),TQQ(3,1) & - & ,QO2(K,1),QO2(K,2),QO2(K,3)) - QO31DY = FLINT(TT,TQQ(1,3),TQQ(2,3),TQQ(3,3) & - & ,Q1D(K,1),Q1D(K,2),Q1D(K,3)) - QO31D = QO31DY*QO3TOT - VALJ(1) = VALJ(1) + QO2TOT*FFF(K,L) - VALJ(2) = VALJ(2) + QO3TOT*FFF(K,L) - VALJ(3) = VALJ(3) + QO31D*FFF(K,L) - enddo - VALJ(2) = VALJ(2) - VALJ(3) ! Kouatchou To see if O3 -> O(3P)+O2 will be close to from previous fastj versions - - do J = 4,NJVAL - - if (TQQ(2,J) .gt. TQQ(1,J)) then - TFACT = max(0.d0,min(1.d0,(TT-TQQ(1,J))/(TQQ(2,J)-TQQ(1,J)))) - else - TFACT = 0.d0 - endif - - do K = NW1,NW2 - QQQT = QQQ(K,1,J) + (QQQ(K,2,J) - QQQ(K,1,J))*TFACT - VALJ(J) = VALJ(J) + QQQT*FFF(K,L) - enddo - -! #52 Methylvinyl ketone 'MeVK ' q(M) = 1/(1 + 1.67e-19*[M]) - if (TITLEJ(J).eq.'MeVK ') then - VALJ(J) = VALJ(J)/(1.0 + 1.67e-19*DD) - endif -! #55 Methylethyl ketone MEKeto q(M) = 1/(1 + 2.0*[M/2.5e19]) - if (TITLEJ(J).eq.'MEKeto') then - VALJ(J) = VALJ(J)/(1.0 + 0.80E-19*DD) - endif -! #57 Methyl glyoxal MGlyxl q(M) = 1/(1 + 4.15*[M/2.5E19]) - if (TITLEJ(J).eq.'MGlyxl') then - VALJ(J) = VALJ(J)/(1.0 + 1.66e-19*DD) - endif - - enddo - - if (TITLEJ(NJVAL-1).eq.'Acet-a') then -!--------------J-ref v8.3 includes Blitz ACETONE q-yields-------------- -!---Acetone is a special case: (as per Blitz et al GRL, 2004) -!--- 61 = NJVAL-1 = J1(acetone-a) ==> CH3CO + CH3 -!--- 62 = NJVAL = J2(acetone-b) ==> CH3 + CO + CH3 - VALJ(NJVAL-1) = 0.d0 - VALJ(NJVAL) = 0.d0 -!---IV=NJVAL-1 = Xsect (total abs) for Acetone - pre-calc Temp interp factors - IV = NJVAL-1 - TFACA = (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - TFACA = max(0.d0, min(1.d0, TFACA)) -!---IV=NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. -!--- but force to Q2=0 by 210K - IV = NJVAL - TFAC0 = ( (TT-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) )**2 - if (TT .lt. TQQ(1,IV)) then - TFAC0 = (TT - 210.d0)/(TQQ(1,IV)-210.d0) - endif - TFAC0 = max(0.d0, min(1.d0, TFAC0)) -!---IV=NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - TT200 = min(300.d0, max(200.d0, TT)) - TFAC1 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) -!---IV=NJVAL+2 = Q1B for Acetone => (1) - IV = NJVAL+2 - TFAC2 = (TT200-TQQ(1,IV))/(TQQ(2,IV)-TQQ(1,IV)) - -!---now integrate over wavelengths - do K = NW1,NW2 -!---NJVAL-1 = Xsect (total abs) for Acetone - IV = NJVAL-1 - QQQA = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFACA -!---NJVAL = Q2 for Acetone=>(2), specifically designed for quadratic interp. - IV = NJVAL - QQ2 = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC0 - if (TT .lt. TQQ(1,IV)) then - QQ2 = QQQ(K,1,IV)*TFAC0 - endif -!---NJVAL+1 = Q1A for Acetone => (1), allow full range of T = 200K-300K - IV = NJVAL+1 - QQ1A = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC1 -!---NJVAL+2 = Q1B for Acetone => (1) ! scaled to [M]=2.5e19 - IV = NJVAL+2 - QQ1B = QQQ(K,1,IV) + (QQQ(K,2,IV)-QQQ(K,1,IV))*TFAC2 - QQ1B = QQ1B*4.d-20 -!---J(61) - VALJ(NJVAL-1) = VALJ(NJVAL-1) & - & + FFF(K,L)*QQQA*(1.d0-QQ2)/(QQ1A + QQ1B*DD) -!---J(62) - VALJ(NJVAL) = VALJ(NJVAL) + FFF(K,L)*QQQA*QQ2 - - enddo !K -!-----------end v-8.3 includes Blitz ACETONE q-yields-------------- - endif - -!----Load array of J-values in native order, need to be indexed/scaled -! by ASAD-related code later: ZPJ(L,JJ) = VALJL(L,JIND(JJ))*JFACTA(JJ) - do J=1,NJVAL - VALJL(L,J) = VALJ(J) - enddo - - enddo ! master loop over L=1,JVL_ - return - end subroutine JRATET -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: JP_ATM -! -! !INTERFACE: -! - subroutine JP_ATM(PPJ,TTJ,DDJ,ZZJ,ZHL,ZZHT,AER,ABX,ADX,JXTRA) -! -! !USES: -! - use FastJX53cCTMparameters_mod, only : L1_, L2_ -! - implicit none -! -! !INPUT PARAMETERS: -!--------key amtospheric data needed to solve plane-parallel J--------- - real*8, dimension(5,L1_) :: AER - integer,dimension(5,L1_) :: ADX - real*8, dimension(L1_) :: ABX, TTJ,DDJ,ZZJ,ZHL - real*8, dimension(L1_+1) :: PPJ - integer,dimension(L2_+1) :: JXTRA - real*8 :: ZZHT -! -! !DESCRIPTION: -! print out atmosphere used in J-value calc. -! -! !LOCAL VARIABLES: - integer I,J,K,L - real*8 COL(4),COLO2,COLO3,ZKM,DELZ,ZTOP -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - write(6,100) - 100 format(' L z(km) p T ',' d(air) d(O3)', & - & ' col(O2) col(O3) ndx col(aer/cld)') - - COLO2 = 0.d0 - COLO3 = 0.d0 - do I=1,4 - COL(I) = 0.d0 - enddo - ZTOP = ZHL(L1_) + ZZHT - - do L = L1_,1,-1 - - do I=1,4 - COL(I) = COL(I) + AER(I,L) - enddo - COLO2 = COLO2 + DDJ(L)*0.20948d0 - COLO3 = COLO3 + ZZJ(L) - DELZ = ZTOP-ZHL(L) - ZTOP = ZHL(L) - ZKM = ZHL(L)*1.d-5 - - write(6,110) L,ZKM,PPJ(L),TTJ(L),DDJ(L)/DELZ,ZZJ(L)/DELZ, & - & COLO2,COLO3, & - & (ADX(I,L),COL(I), I=1,4), JXTRA(L+L),JXTRA(L+L-1) - 110 format(1x,i3,0p,f6.2,f10.3,f7.2,1p,4e9.2,4(i3,e9.2),2i3) - - enddo - - return - end subroutine JP_ATM -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: RD_XXX -! -! !INTERFACE: -! - subroutine RD_XXX(NJ1,NAMFIL) -! -! !USES: - use FastJX53cCTMparameters_mod, only : X_ - use FastJX53cJvaluesVars_mod , only : TQQ , QQQ , QRAYL - use FastJX53cJvaluesVars_mod , only : QO2 , QO3 , Q1D - use FastJX53cJvaluesVars_mod , only : WBIN , WL , FL - use FastJX53cJvaluesVars_mod , only : NJVAL , NW1 , NW2 - use FastJX53cJvaluesVars_mod , only : TITLE0, TITLEJ, TITLEJ2, TITLEJ3 -! - implicit none -! -! !INPUT PARAMETERS: - integer , intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL -! -! !DESCRIPTION: -! Read in wavelength bins, solar fluxes, Rayleigh parameters, -! T-dependent X-sections. -! \newline -! {\bf Current code revised to JPL-02 ver 8.5 (5/05)} -! \newline -! -! \begin{verbatim} -! NAMFIL Name of spectral data file (j2_spec.dat) >> j2 for fast-J2 -! NJ1 Channel number for reading data file -! -! NJVAL Number of species to calculate J-values for -! NWWW Number of wavelength bins, from 1:NWWW -! WBIN Boundaries of wavelength bins -! WL Centres of wavelength bins - 'effective wavelength' -! FL Solar flux incident on top of atmosphere (cm-2.s-1) -! QRAYL Rayleigh parameters (effective cross-section) (cm2) -! QO2 O2 cross-sections -! QO3 O3 cross-sections -! Q1D O3 => O(1D) quantum yield -! TQQ Temperature for supplied cross sections -! QQQ Supplied cross sections in each wavelength bin (cm2) -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer I, J, K, IW, NQQQ, NWWW -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - - TQQ(:,:) = 0.d0 - -!----------spectral data----set for new format data J-ver8.3------------------ -! note that NJVAL = # J-values, but NQQQ (>NJVAL) = # Xsects read in -! for 2005a data, NJVAL = 62 (including a spare XXXX) and -! NQQQ = 64 so that 4 wavelength datasets read in for acetone -! note NQQQ is not used outside this subroutine! - - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - read (NJ1,100) TITLE0 - read (NJ1,101) NJVAL,NQQQ, NWWW,NW1,NW2 - if (NJVAL.gt.X_ .or. NQQQ.gt.X_) then - write(6,201) NJVAL,X_ - stop - endif -! write(6,'(1X,A)') TITLE0 -!----J-values: 1=O2, 2=O3P,3=O3D 4=readin Xsects - read (NJ1,102) (WL(IW),IW=1,NWWW) - read (NJ1,102) (FL(IW),IW=1,NWWW) - read (NJ1,102) (QRAYL(IW),IW=1,NWWW) - -!---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - read (NJ1,103) TITLEJ(1),TQQ(1,1), (QO2(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,1), (QO2(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,1), (QO2(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(2),TQQ(1,2), (QO3(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,2), (QO3(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,2), (QO3(IW,3),IW=1,NWWW) - - read (NJ1,103) TITLEJ(3),TQQ(1,3), (Q1D(IW,1),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,3), (Q1D(IW,2),IW=1,NWWW) - read (NJ1,103) TITLEJ3, TQQ(3,3), (Q1D(IW,3),IW=1,NWWW) - -! do J = 1,3 -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,3) -! enddo - -!---Read remaining species: X-sections at 2 T_s - do J = 4,NQQQ - read (NJ1,103) TITLEJ(J),TQQ(1,J),(QQQ(IW,1,J),IW=1,NWWW) - read (NJ1,103) TITLEJ2, TQQ(2,J),(QQQ(IW,2,J),IW=1,NWWW) -! write(6,200) TITLEJ(J),(TQQ(I,J),I=1,2) - enddo - -! Reset the titles for NJVAL-1 & NJVAL to be the two acetone J_s -! 61: C3H6O = Acet-a (CH3CO + CH3) -! 62: Q2-Ac = Acet-b (CH3 + CO + CH3) - - TITLEJ(NJVAL-1) = 'Acet-a' - TITLEJ(NJVAL) = 'Acet-b' - - close(NJ1) - - 100 format(a) - 101 format(10x,5i5) - 102 format(10x, 6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 103 format(a7,f3.0,6e10.3/(10x,6e10.3)/(10x,6e10.3)) - 200 format(1x,' x-sect:',a10,3(3x,f6.2)) - 201 format(' Number of x-sections supplied to Fast-J2: ',i3,/, & - & ' Maximum number allowed (X_) only set to: ',i3, & - & ' - increase in cmn_jv.f') - - return - end subroutine RD_XXX -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: RD_MIE -! -! !INTERFACE: -! - subroutine RD_MIE(NJ1,NAMFIL) -! -! !USES: -! - use FastJX53cJvaluesVars_mod , only : NAA, QAA, WAA, PAA, RAA, SSA - use FastJX53cJvaluesVars_mod , only : JTAUMX, ATAU, ATAU0 - use FastJX53cJvaluesVars_mod , only : TITLE0, TITLEA - - implicit none -! -! !INPUT PARAMETERS: - integer , intent(in) :: NJ1 - character(*), intent(in) :: NAMFIL -! -! !DESCRIPTION: -! Aerosols/cloud scattering data set for fast-JX (ver 5.3). -! \newline -! {\bf Spectral data rev to J-ref ver8.5 (5/05)} -! -! \begin{verbatim} -! NAMFIL Name of scattering data file (e.g., FJX_scat.dat) -! NJ1 Channel number for reading data file -! NAA Number of categories for scattering phase functions -! QAA Aerosol scattering phase functions -! NK Number of wavelengths at which functions supplied (set as 4) -! WAA Wavelengths for the NK supplied phase functions -! PAA Phase function: first 8 terms of expansion -! RAA Effective radius associated with aerosol type -! SSA Single scattering albedo -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer I, J, K -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - open (NJ1,FILE=NAMFIL,status='old',form='formatted') - - read (NJ1,'(i2,a78)') NAA,TITLE0 - read (NJ1,'(5x,i5,2f10.5)') JTAUMX,ATAU,ATAU0 -! write(6,'(a,2f9.5,i5)') ' ATAU/ATAU0/JMX',ATAU,ATAU0,JTAUMX - read (NJ1,*) - - do J = 1,NAA - read (NJ1,'(3x,a20)') TITLEA(J) - do K = 1,4 ! Fix number of aerosol wavelengths at 4 - read (NJ1,'(f5.0,f8.1,f7.3,f8.4,f7.3,7f6.3)') & - & WAA(K,J),QAA(K,J),RAA(K,J),SSA(K,J),(PAA(I,K,J),I=1,8) - enddo - enddo - - close(NJ1) - -! write(6,*) 'Aerosol phase functions & wavelengths' -! write(6,*) TITLE0 -! do J=1,NAA -! write(6,'(1x,A8,I2,A,9F8.1)') & -! & TITLEA(J),J,' wavel=',(WAA(K,J),K=1,4) -! write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,4) -! enddo - - return - end subroutine RD_MIE -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IFUNCTION: FLINT -! -! !INTERFACE: -! - real*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -! - implicit none -! -! !INPUT PARAMETERS: - real*8 TINT,T1,T2,T3,F1,F2,F3 -! -! !DESCRIPTION: -! Three-point linear interpolation function -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - if (TINT .le. T2) then - if (TINT .le. T1) then - FLINT = F1 - else - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - endif - else - if (TINT .ge. T3) then - FLINT = F3 - else - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - endif - endif - return - end FUNCTION FLINT -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SOLARZ -! -! !INTERFACE: -! - subroutine SOLARZ(GMTIME,NDAY,YGRDJ,XGRDI, SZA,COSSZA,SOLFX) -! - implicit none -! -! !INPUT PARAMETERS: - real*8, intent(in) :: GMTIME,YGRDJ,XGRDI, SZA - integer, intent(in) :: NDAY -! -! !OUTPUT PARAMETERS: - real*8, intent(out) :: COSSZA,SOLFX -! -! !DESCRIPTION: -! Calculate the Solar Zenith Angle and Solar Flux factor for given -! lat/lon/UT. -! \begin{verbatim} -! GMTIME = UT for when J-values are wanted -! (for implicit solver this is at the end of the time step) -! NDAY = integer day of the year (used for solar lat and declin) -! YGRDJ = laitude (radians) for grid (I,J) -! XGDRI = longitude (radians) for grid (I,J) -! -! SZA = solar zenith angle in degrees -! COSSZA = U0 = cos(SZA) -! \end{verbatim} -! -! !LOCAL VARIABLES: - real*8 PI, PI180, LOCT - real*8 SINDEC, SOLDEK, COSDEC, SINLAT, SOLLAT, COSLAT, COSZ -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! - PI = 3.141592653589793d0 - PI180 = PI/180.d0 - !SINDEC = 0.3978d0*sin(0.9863d0*(dble(NDAY)-80.d0)*PI180) - !SOLDEK = asin(SINDEC) - !COSDEC = cos(SOLDEK) - !SINLAT = sin(YGRDJ) - !SOLLAT = asin(SINLAT) - !COSLAT = cos(SOLLAT) -! - !LOCT = (((GMTIME)*15.d0)-180.d0)*PI180 + XGRDI - !COSSZA = COSDEC*COSLAT*cos(LOCT) + SINDEC*SINLAT - !SZA = acos(COSSZA)/PI180 - - COSSZA = cos(SZA*PI180) - - SOLFX = 1.d0-(0.034d0*cos(dble(NDAY-186)*2.d0*PI/365.d0)) - - return - end subroutine SOLARZ -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: SPHERE -! -! !INTERFACE: -! - subroutine SPHERE(GMU,RAD,ZHL,ZZHT,AMF,L1_) -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: L1_ ! dimension of CTM = levels +1 - real*8 , intent(in) :: GMU ! MU0 = cos(solar zenith angle) - real*8 , intent(in) :: RAD ! radius of Earth mean sea level (cm) - real*8 , intent(in) :: ZHL(L1_) ! height (cm) of the bottome edge of CTM level L1_ - real*8 , intent(in) :: ZZHT ! scale height (cm) used above top of CTM (ZHL(L_+1) -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: AMF(L1_,L1_) - ! air mass factor for CTM level I for sunlight reaching J -! -! !DESCRIPTION: -! Calculation of spherical geometry; derive tangent heights, slant path -! lengths and air mass factor for each layer. Not called when -! $SZA \;\; > \;\; 98$ degrees. Beyond 90 degrees, include treatment -! of emergent beam (where tangent height is below altitude J-value -! desired at). -! -! !LOCAL VARIABLES: - integer I, J, K, II - real*8 AIRMAS - real*8 XMU1, XMU2 - real*8 DIFF, Ux - real*8 H, ZBYR - real*8 RZ(L1_) ! Distance from centre of Earth to each point (cm) - real*8 RQ(L1_) ! Square of radius ratios - real*8 TANHT ! Tangent height for the current SZA - real*8 XL ! Slant path between points -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -! Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- & - & 0.6817d0*EXP(-57.3d0*abs(Ux)/SQRT(1.0d0+5500.d0*H))/ & - & (1.0d0+0.625d0*H))) -! - RZ(1) = RAD + ZHL(1) - ZBYR = ZZHT/RAD - do II = 2,L1_ - RZ(II) = RAD + ZHL(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - enddo - if (GMU .lt. 0.0d0) then - TANHT = RZ(1)/dsqrt(1.0d0-GMU**2) - else - TANHT = RZ(1) - endif -! -! Go up from the surface calculating the slant paths between each level -! and the level above, and deriving the appropriate Air Mass Factor - do 16 J = 1,L1_ - do I = 1,L1_ - AMF(I,J) = 0.d0 - enddo -! -! Air Mass Factors all zero if below the tangent height - if (RZ(J) .lt. TANHT) goto 16 -! Ascend from layer J calculating AMFs - XMU1 = abs(GMU) - do I = J,L1_-1 - XMU2 = dsqrt(1.0d0 - RQ(I)*(1.0d0-XMU1**2)) - XL = RZ(I+1)*XMU2 - RZ(I)*XMU1 - AMF(I,J) = XL / (RZ(I+1)-RZ(I)) - XMU1 = XMU2 - enddo -! Use function and scale height to provide AMF above top of model - AMF(L1_,J) = AIRMAS(XMU1,ZBYR) -! -! Twilight case - Emergent Beam - if (GMU .ge. 0.0d0) goto 16 - XMU1 = abs(GMU) -! Descend from layer J - do II = J-1,1,-1 - DIFF = RZ(II+1)*sqrt(1.0d0-XMU1**2)-RZ(II) - if (II.eq.1) DIFF = max(DIFF,0.d0) ! filter -! Tangent height below current level - beam passes through twice - if (DIFF .lt. 0.0d0) then - XMU2 = sqrt(1.0d0 - (1.0d0-XMU1**2)/RQ(II)) - XL = abs(RZ(II+1)*XMU1-RZ(II)*XMU2) - AMF(II,J) = 2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1 = XMU2 -! Lowest level intersected by emergent beam - else - XL = RZ(II+1)*XMU1*2.0d0 - AMF(II,J) = XL/(RZ(II+1)-RZ(II)) - goto 16 - endif - enddo - - 16 continue - return - end subroutine SPHERE -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: EXTRAL -! -! !INTERFACE: -! - subroutine EXTRAL(AER,ADX,L1X,L2X,NX,JTAUMX,ATAU,ATAU0, JXTRA) -! - implicit none -! - integer, intent(in) :: JTAUMX,L1X,L2X !index of cloud/aerosol - integer, intent(in) :: NX !Mie scattering array size - real*8, intent(in) :: AER(5,L1X) !cloud+3aerosol OD in each layer - real*8, intent(in) :: ATAU,ATAU0 - integer, intent(in) :: ADX(5,L1X) !index of cloud/aerosol - integer, intent(out) :: JXTRA(L2X+1) !number of sub-layers to be added -! -! !DESCRIPTION: -! New version 5.3, add sub-layers (JXTRA) to thick cloud/aerosol layers. -! This version sets up log-spaced sub-layers of increasing thickness ATAU. -! -! \begin{verbatim} -! AER(5,L=1:L1X) = Optical Depth in layer L (general visible OD) -! This is not used in the calculation of J's but in calculating -! the number in levels to insert in each layer L -! Set for log-spacing of tau levels, increasing top-down. -! AER(1:4,L) = aerosol+cloud OD (up to 4 types, index type = ADX(1:4,L) -! AER(5,L) = Rayleigh-not used here -! \end{verbatim} -! -! N.B. the TTAU, etc caluclate here are not really used elsewhere. -! \newline \newline -! -! The log-spacing parameters have been tested for convergence and chosen -! to be within $0.5\%$ for ranges OD=1-500, rflect=$0-100\%$, mu0=0.1-1.0 -! use of ATAU = 1.18 and min = 0.01, gives at most +135 pts for OD=100 -! -! !LOCAL VARIABLES: - integer JTOTL,I,L,L2 - real*8 DTAUX(L1X),TTAU(L2X+1),DTAUJ, ATAU1,ATAULN,ATAUM,ATAUN1 -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -!---Reinitialize arrays - TTAU(:) = 0.d0 - JXTRA(:) = 0 -! -!---Set up total optical depth over each CTM level (L=1:L1X) -!--- DTAUX(L) = bulk properties (OD) of each CTM layer - - do L = 1,L1X -! Total optical depth from all elements I=1:4 = clouds + 3 aerosol types -! Assume here that AER(1:4, 1:L1X) is 'visible' Optical Depth = 600 nm -! do NOT count if ADX = 0 - DTAUX(L) = 0.d0 - do I = 1,4 - if (ADX(I,L) .gt. 0) DTAUX(L) = DTAUX(L) + AER(I,L) - enddo - enddo -! -!---combine these edge- and mid-layer points into grid of size: -!--- L2X+1 = 2*L1X+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2X+1) -!--- note that TTAU(L2X+1)=0 and TTAU(1)=total OD -! -!---Divide thick layers to achieve better accuracy in the scattering code -!---In the original fast-J, equal sub-layers were chosen, this is wasteful -!---and this new code (ver 5.3) uses log-scale: -!--- Each succesive layer (down) increase thickness by ATAU > 1 -!--- e.g., if ATAU = 2, a layer with OD = 15 could be divided into -!--- 4 sub-layers with ODs = 1 - 2 - 4 - 8 -!---The key parameters are: -!--- ATAU = factor increase from one layer to the next -!--- ATAUMN = the smallest OD layer desired -!--- JTAUMX = maximum number of divisions (i.e., may not get to ATAUMN) -!---These are hardwired below, can be changed, but have been tested/optimized - - ATAU1 = ATAU - 1.d0 - ATAULN = log(ATAU) - TTAU(L2X+1) = 0.0d0 - do L2 = L2X,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ -!---Now compute the number of log-spaced sub-layers to be added in -!--- the interval TTAU(L2) > TTAU(L2+1) -!---The objective is to have successive TAU-layers increasing by factor ATAU >1 -!---the number of sub-layers + 1 - if (TTAU(L2) .lt. ATAU0) then - JXTRA(L2) = 0 - else - ATAUM = max(ATAU0, TTAU(L2+1)) - ATAUN1 = log(TTAU(L2)/ATAUM) / ATAULN - JXTRA(L2) = min(JTAUMX, max(0, int(ATAUN1 - 0.5d0))) - endif - enddo - -!---check on overflow of arrays, cut off JXTRA at lower L if too many levels - JTOTL = L2X + 2 - do L2 = L2X,1,-1 - JTOTL = JTOTL + JXTRA(L2) - if (JTOTL .gt. NX/2) then - write(6,'(A,2I5,F9.2)') 'N_/L2_/L2-cutoff JXTRA:',NX,L2X,L2 - do L = L2,1,-1 - JXTRA(L) = 0 - enddo - go to 10 - endif - enddo - 10 continue - - return - end subroutine EXTRAL -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: OPMIE -! -! !INTERFACE: -! - subroutine OPMIE & - & (KW,KM,WAVEL,ABX,AER,ADX,U0,RFLECT,AMF,JXTRA,FMEAN, FJTOP,FJBOT) -! -! !USES: -! - use FastJX53cJvaluesVars_mod , only : QAA, SSA, PAA, ATAU0 - use FastJX53cCTMparameters_mod , only : L1_, L2_, L_ - use FastJX53cMIEparameters_mod , only : M_, N_ - use FastJX53cCoreScattering_mod, only : MIESCT -! - implicit none -! -! -! !INPUT PARAMETERS: - real*8 , intent(in) :: WAVEL - ! wavelength of bin (in nm) - not now used - real*8 , intent(in) :: AER(5,L1_) - ! 5 vertical profiles of Optical Depth in each layer - real*8 , intent(in) :: ABX(L1_) - ! vertical profiles of ABSORPTION Optical Depth in each layer - ! includes O2 and O3 for now (BC under aerosols) - real*8 , intent(in) :: AMF(L1_,L1_) - real*8 , intent(in) :: U0 - ! cos (SZA) - real*8 , intent(in) :: RFLECT - ! Lambertian albedo of surface - integer, intent(in) :: KW - ! wavelength bin # (1:18) - integer, intent(in) :: KM - ! wavelength index for Mie properties (1:4 = 300-400-600-999 nm) - integer, intent(in) :: ADX(5,L1_) - ! integer index of the scattering properties of each AER - ! 1:4 are reserved for aerosols and clouds - ! 5 is meant only for Rayleigh scattering! - integer, intent(in) :: JXTRA(L2_+1) - ! number 0:J = no. of additional levels to be inserted -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: FMEAN(L_) - ! mean actinic flux at standard CTM levels (mid-layer) - real*8 , intent(out) :: FJTOP,FJBOT -! !DESCRIPTION: -! \begin{verbatim} -! -! DTAUX Local optical depth of each CTM level -! TTAU Optical depth of air vertically above each point (to top of atm) -! FTAU Attenuation of solar beam -! POMEGA Scattering phase function -! -!---new Ver 5.3 code adds sub-layers (# = JXTRA(L2)) using ATAU as the -! factor increase from sub-layer to sub-layer - -! fast-J Mie code for J_s, only uses 8-term expansion, 4-Gauss pts -! Currently allow up to A_ aerosol phase functions (at all altitudes) to -! be associated with optical depth AER(1:L2_) = aerosol opt.depth @ 1000 nm -! -! Pick Mie-wavelength with phase function and Qext: e.g., -! 01 RAYLE = Rayleigh phase -! 02 ISOTR = isotropic -! 03 ABSRB = fully absorbing 'soot', wavelength indep. -! 04 X_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -! 05 X_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -!. . . -! 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -!. . . -! 13 Ice-H = hexagonal ice cloud (Mishchenko) -! 14 Ice-I = irregular ice cloud (Mishchenko) -! -! Choice of the 4 aerosol/cloud indices ADX is made earlier -! Optical depths for the 4 (aerosol+clouds) = AER -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer JNDLEV(L_),JADDLV(L2_+1),JADDTO(L2_+1),L2LEV(L2_+1) & - & ,JTOTL,I,II,J,K,L,IX,JK, L2,L2L,L22,LZ,LZZ,NDZ -! - real*8 QXMIE(5),XLAER(5),SSALB(5),DTAUX(L1_),PIAER(5,L1_) & - & ,POMEGAJ(2*M_,L2_+1),TTAU(L2_+1),FTAU(L1_) & - & ,FTAU2(L2_+1),DTTAU,DFTAU,dPOMEGA(2*M_) & - & ,XLO2,XLO3,XLRAY,XLTAU,ZK,TAUDN,TAUUP,ZK2 & - & ,DTAUJ,DTAUAD,TAUBTM,TAUTOP,FBTM,FTOP,POMEGAB(2*M_) & - & ,ATAUA,ATAUZ -!--- variables used in mie code----------------------------------------- - real*8 FJ(N_),POMEGA(2*M_,N_),FZ(N_),ZTAU(N_),ZREFL,ZU0,ZFLUX - real*8 FJT,FJB - integer MFIT, ND -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -!---Reinitialize arrays - ZTAU(:) = 0.d0 - FZ(:) = 0.d0 - POMEGA(:,:) = 0.d0 - - -!---Set up optical depth DTAUX(L), and scattering fraction PIAER(1:5,L) -!--- where L = 1:L1_ = bulk properties of each CTM layer. - do L = 1,L1_ - - do I = 1,4 - if (ADX(I,L) .eq. 0) then - QXMIE(I) = 0.d0 - SSALB(I) = 0.d0 - else -!---for Mie code scale extinction at 600 nm to wavelength WAVEL (QXMIE) - QXMIE(I) = QAA(KM,ADX(I,L))/QAA(3,ADX(I,L)) - SSALB(I) = SSA(KM,ADX(I,L)) - endif - enddo -!---special case for Rayleigh scattering - QXMIE(5) = 1.d0 - SSALB(5) = 1.d0 - do I = 1,5 - XLAER(I) = AER(I,L)*QXMIE(I) - enddo - - DTAUX(L) = ABX(L) - do I = 1,5 - DTAUX(L) = DTAUX(L) + XLAER(I) - enddo -!---fractional extinction for Rayleigh scattering and each aerosol type - do I = 1,5 - PIAER(I,L) = SSALB(I)*XLAER(I)/DTAUX(L) - enddo - - enddo - -!---Calculate attenuated incident beam exp(-TTAU/U0 = DTAUX * AirMassFactor) -!--- at the edges of the CTM layers L=1:L1_ - do L = 1,L1_ - if (AMF(L,L) .gt. 0.0d0) then - XLTAU = 0.0d0 - do I = 1,L1_ - XLTAU = XLTAU + DTAUX(I)*AMF(I,L) - enddo - if (XLTAU .gt. 76.d0) then ! zero out flux at 1e-33 - FTAU(L) = 0.d0 - else - FTAU(L) = exp(-XLTAU) - endif - else - FTAU(L) = 0.0d0 - endif - enddo -! -!---Define the total scattering phase fn for each CTM layer L=1:L_+1 -!--- from a DTAUX-wt_d mix of aerosols, cloud & Rayleigh -!---No. of quadrature pts fixed at 4(M_), expansion of phase fn @ 8 - MFIT = 2*M_ - do L = 1,L1_ - do I = 1,MFIT - POMEGAJ(I,L) = 0.d0 - do K = 1,5 - POMEGAJ(I,L)=POMEGAJ(I,L) + PIAER(K,L)*PAA(I,KM,ADX(K,L)) - enddo - enddo - enddo - -!--printout diagnositcs of different aerosol+cld contrib to OD -! if(KW.eq.18) then -! do L=1,L1_ -! write(6,'(3i5,1p,20e12.5)') L,JXTRA(L+L),JXTRA(L+L-1), -! & DTAUX(L),(AER(I,L),I=1,5) -! enddo -! endif - -! -!------------------------------------------------------------------------ -! Take optical properties on CTM layers and convert to a photolysis -! level grid corresponding to layer centres and boundaries. This is -! required so that J-values can be calculated for the centre of CTM -! layers; the index of these layers is kept in the JNDLEV array. -!------------------------------------------------------------------------ -! -!---Now combine the CTM layer edges (1:L_+2) with the CTM mid-layer -!--- points (1:L_) plus 1 for the mid point of added top layer. - -!---combine these edge- and mid-layer points into grid of size: -!--- L2_+1 = 2*L1_+1 = 2*L_+3 -!---calculate column optical depths above each level, TTAU(1:L2_+1) -!--- note that TTAU(L2_+1)=0 and TTAU(1)=total OD - TTAU(L2_+1) = 0.0d0 - do L2 = L2_,1,-1 - L = (L2+1)/2 - DTAUJ = 0.5d0 * DTAUX(L) - TTAU(L2) = TTAU(L2+1) + DTAUJ - enddo -! -!---reflected flux from surface - if (U0 .gt. 0.d0) then - ZFLUX = U0*FTAU(1)*RFLECT/(1.d0+RFLECT) - else - ZFLUX = 0.d0 - endif -! -!---calculate attenuated beam FTAU2 on the new doubled-levels L2=1:L2_+1 -!--- calculate FTAU2 at CTM mid-layers from sqrt -!--- L2_ = 2*L1_ = 2*L_+2 - - FTAU2(L2_+1) = 1.0d0 - FTAU2(L2_) = sqrt(1.0d0*FTAU(L1_)) - FTAU2(L2_-1) = FTAU(L1_) - do L2 = L2_-3,1,-2 - L = (L2+1)/2 - FTAU2(L2) = FTAU(L) - FTAU2(L2+1) = sqrt(FTAU(L+1)*FTAU(L)) - enddo -! -! Calculate scattering properties, level centres then level boundaries -! ***be careful of order, we are shifting the 'POMEGAJ' upward in index*** - do L2 = L2_,2,-2 - L = L2/2 - do I = 1,MFIT - POMEGAJ(I,L2) = POMEGAJ(I,L) - enddo - enddo -!---lower boundary value is set (POMEGAJ(I,1), but set upper: - do I = 1,MFIT - POMEGAJ(I,L2_+1) = POMEGAJ(I,L2_) - enddo -!---now have POMEGAJ filled at even points from L2=3:L2_-1 -!---use inverse interpolation for correct tau-weighted values at edges - do L2 = 3,L2_-1,2 - TAUDN = TTAU(L2-1)-TTAU(L2) - TAUUP = TTAU(L2)-TTAU(L2+1) - do I = 1,MFIT - POMEGAJ(I,L2) = (POMEGAJ(I,L2-1)*TAUDN + & - & POMEGAJ(I,L2+1)*TAUUP) / (TAUDN+TAUUP) - enddo - enddo -!---at this point FTAU2(1:L2_+1) and POMEAGJ(1:8, 1:L2_+1) -!--- where FTAU2(L2_+1) = 1.0 = top-of-atmos, FTAU2(1) = surface -! -!------------------------------------------------------------------------ -! Calculate cumulative total and define levels we want J-values at. -! Sum upwards for levels, and then downwards for Mie code readjustments. -! -! JXTRA(L2) Number of new levels to add between (L2) and (L2+1) -! ***JXTRA(1:L2_+1) is calculated based on the aerosol+cloud OD_s -! JADDLV(L2) Number of new levels actually added at each wavelength -! where JADDLV = 0 when there is effectively no FTAU2 -! JADDTO(L2) Total number of new levels to add to and above level (L2) -! JNDLEV(L) = L2 index that maps on CTM mid-layer L -! -!------------------------------------------------------------------------ - -!---JADDLV(L2=1:L2_) = number of levels to add between TTAU2(L2) and TTAU(L2+1) -!--- JADDLV is taken from JXTRA, which is based on visible OD. -!--- JADDTO(L2=1:L2_+1) is the cumulative number of levels to be added -!---note that JADDLV and JADDTO will change with wavelength and solar zenith - -!--now try to insert additional levels for thick clouds, ONLY IF FTAU2 > 1.e-8 -!-- this will cut off additional levels where the solar beam is negligible. - - do L2 = 1,L2_ - if (FTAU2(L2+1) .lt. 1.d-30) then - JADDLV(L2) = 0 - else - JADDLV(L2) = JXTRA(L2) - endif - enddo - JADDTO(L2_+1) = 0 - do L2 = L2_,1,-1 - JADDTO(L2) = JADDTO(L2+1) + JADDLV(L2) - enddo - -!---expanded grid now included CTM edge and mid layers plus expanded -!--- grid to allow for finer delta-tau at tops of clouds. -!--- DIM of new grid = L2_ + JADDTO(1) + 1 - -!---L2LEV(L2) = L2-index for old level L2 in expanded J-grid (w/JADDLV) -! in absence of JADDLV, L2LEV(L2) = L2 - L2LEV(1) = 1 - do L2 = 2,L2_+1 - L2LEV(L2) = L2LEV(L2-1) + 1 + JADDLV(L2-1) - enddo - -!---JNDLEV(L=1:L_) = L2-index in expanded grid for CTM mid-layer L - do L = 1,L_ - JNDLEV(L) = L2LEV(2*L) - enddo - -!---------------------SET UP FOR MIE CODE------------------------------- -! -! Transpose the ascending TTAU grid to a descending ZTAU grid. -! Double the resolution - TTAU points become the odd points on the -! ZTAU grid, even points needed for asymm phase fn soln, contain 'h'. -! Odd point added at top of grid for unattenuated beam (Z='inf') -! -! The following mapping holds for JADDLV=0 -! Surface: TTAU(1) ==> ZTAU(2*L2_+1) -! Top: TTAU(L2_) ==> ZTAU(3) -! Infinity: 0.0 ==> ZTAU(1) -! index: 2*(L2_+1-L2)+1 ==> LZ -! -! Mie scattering code only used from surface to level L2_ -!------------------------------------------------------------------------ -! -!------------------------------------------------------------------------ -! Insert new levels, working downwards from the top of the atmosphere -! to the surface (down in 'LZ', up in 'L2'). This allows ztau and pomega -! to be incremented linearly (in a +ve sense), and the flux fz to be -! attenuated top-down (avoiding problems where lower level fluxes are -! zero). -! -! zk fractional increment in level -! dTTAU change in ttau per increment (linear, positive) -! dPOMEGA change in pomega per increment (linear) -! ftaulog change in ftau per increment (exponential, normally < 1) -! -!------------------------------------------------------------------------ -! -! Ascend through atmosphere transposing grid and adding extra points -! remember L2=1 is surface of CTM, but last layer (LZ) in scattering code. -! there are twice the number of layers in the LZ arrays (2*L2_ + 2*JADDTO + 1) -! because we need to insert the intermediate layers (even LZ) for the -! asymmetric scattering code. - - -! Transfer the L2=1:L2_+1 values (TTAU,FTAU2,POMEGAJ) onto the reverse -! order, expanded, doubled-level scatter grid. -! Note that we need to deal with the expansion by JADD levels (L2L). -! These JADDLV levels are skipped and need to be interpolated later. -! Note that only odd LZ levels are filled, - - NDZ = 2*L2_ + 2*JADDTO(1) + 1 - -! Note that the successive sub-layers have the ratio in OD of ATAU -! ATAUA = (ATAU - 1.d0)/ATAU ! this is the limit for L22=>inf - - do L2 = 1,L2_+1 ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - ZTAU(LZ) = TTAU(L2) - FZ(LZ) = FTAU2(L2) - do I=1,MFIT - POMEGA(I,LZ) = POMEGAJ(I,L2) - enddo - enddo - -! Now go thru the pairs of L2 levels to see if we need JADD levels - do L2 = 1,L2_ ! L2 = index of CTM edge- and mid-layers - L2L = L2LEV(L2) ! L2L = index for L2 in expanded scale(JADD) - LZ = NDZ + 2 - 2*L2L ! LZ = index for L2 in scatt arrays - L22 = L2LEV(L2+1) - L2LEV(L2) - 1 ! L22 = 0 if no added levels - if (L22 .gt. 0) then - TAUBTM = TTAU(L2) - TAUTOP = TTAU(L2+1) - FBTM = FTAU2(L2) - FTOP = FTAU2(L2+1) - do I = 1,MFIT - POMEGAB(I) = POMEGAJ(I,L2) - enddo - -!---to fit L22 new layers between TAUBOT > TAUTOP, calculate new 1/ATAU factor -!--- such that TAU(just above TAU-btm) = ATUAZ * TAUBTM < TAUBTM - - ATAUZ = exp(-log(TAUBTM/max(TAUTOP,ATAU0))/float(L22+1)) - - do L = 1,L22 ! add odd levels between L2LEV(L2) & L2LEV(L2+1) - LZZ = LZ - 2*L ! LZZ = index(odd) of added level in scatt arrays - ZTAU(LZZ) = TAUBTM * ATAUZ - ATAUA=(TAUBTM-ZTAU(LZZ))/(TAUBTM-TAUTOP) !fraction from TAUBTM=>TAUTOP - if (FBTM .lt. 1.d-32) then - FZ(LZZ) = 0.d0 - else - FZ(LZZ) = FBTM * (FTOP/FBTM)**ATAUA - endif - do I = 1,MFIT - POMEGA(I,LZZ) = POMEGAB(I) + & - & ATAUA*(POMEGAJ(I,L2+1)-POMEGAB(I)) - enddo - TAUBTM = ZTAU(LZZ) - FBTM = FZ(LZZ) - do I = 1,MFIT - POMEGAB(I) = POMEGA(I,LZZ) - enddo - enddo - endif - enddo - -! Now fill in the even points with simple interpolation in scatter arrays: - do LZ = 2,NDZ-1,2 - ZTAU(LZ) = 0.5d0*(ZTAU(LZ-1)+ZTAU(LZ+1)) - FZ(LZ) = sqrt(FZ(LZ-1)*FZ(LZ+1)) - do I=1,MFIT - POMEGA(I,LZ) = 0.5d0*(POMEGA(I,LZ-1)+POMEGA(I,LZ+1)) - enddo - enddo - - ND = NDZ - ZU0 = U0 - ZREFL = RFLECT - -!---PRINT diagnostics -! write(6,'(A,2I6)') 'Total levels of photolysis in OPMIE',ND - if(ND .gt. N_) then - write(6,'(a,2i9)') ' overflow of scatter arrays:',ND,N_ - stop - endif - -!----------------------------------------------------------------------- - call MIESCT(FJ,FJT,FJB,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,ZU0,MFIT,ND) -!----------------------------------------------------------------------- - -!---Move mean intensity from scatter array FJ(LZ=1:ND) -!--- to CTM mid-level array FMEAN(L=1:L_) - do L = 1,L_ - L2L = JNDLEV(L) - LZ = ND+2 - 2*L2L - FMEAN(L) = FJ(LZ) - enddo - -!---fluxes reflected at top, incident at bottom (1/2 layer flux) - FJTOP = FJT - FJBOT = FJB - - return - end subroutine OPMIE -!EOC -!------------------------------------------------------------------------- - - end module FastJX53cCoreFastj_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreScattering_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreScattering_mod.F90 deleted file mode 100644 index 8122ff87..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cCoreScattering_mod.F90 +++ /dev/null @@ -1,728 +0,0 @@ -!------------------------------------------------------------------------- -! NASA/GFSC, SIVO, Code 610.3 -!------------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cCoreScattering_mod -! -! !INTERFACE: -! - module FastJX53cCoreScattering_mod -! - implicit none -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: MIESCT -! -! !DESCRIPTION: -! Contains core scattering routines. -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: MIESCT -! -! !INTERFACE: -! - subroutine MIESCT(FJ,FJT,FJB,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,ZU0,MFIT,ND) -! -! !USES: - use FastJX53cMIEparameters_mod, only : M_, N_ -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: MFIT - integer, intent(in) :: ND - real*8 , intent(in) :: POMEGA(2*M_,N_) - real*8 , intent(in) :: FZ(N_) - real*8 , intent(in) :: ZTAU(N_) - real*8 , intent(in) :: ZREFL, ZU0, ZFLUX -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: FJ(N_), FJT,FJB -! -! !DESCRIPTION: -! \begin{verbatim} -!----------------------------------------------------------------------- -! This is an adaption of the Prather radiative transfer code, (mjp, 10/95) -! Prather, 1974, Astrophys. J. 192, 787-792. -! Sol_n of inhomogeneous Rayleigh scattering atmosphere. -! (original Rayleigh w/ polarization) -! Cochran and Trafton, 1978, Ap.J., 219, 756-762. -! Raman scattering in the atmospheres of the major planets. -! (first use of anisotropic code) -! Jacob, Gottlieb and Prather, 1989, J.Geophys.Res., 94, 12975-13002. -! Chemistry of a polluted cloudy boundary layer, -! (documentation of extension to anisotropic scattering) -! -! takes atmospheric structure and source terms from std J-code -! ALSO limited to 4 Gauss points, only calculates mean field! -! -! mean rad. field ONLY (M=1) -! \end{verbatim} -! -! !LOCAL VARIABLES: - real*8 WT(M_),EMU(M_),PM(M_,2*M_),PM0(2*M_),CMEQ1 - integer I, ID, IM, M, N -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -!----------------------------------------------------------------------- -!---fix scattering to 4 Gauss pts = 8-stream - call GAUSSP (N,EMU,WT) - -!---calc in OPMIE: ZFLUX = (ZU0*FZ(ND)*ZREFL)/(1.0d0+ZREFL) - M = 1 - do I = 1,N - call LEGND0 (EMU(I),PM0,MFIT) - do IM = M,MFIT - PM(I,IM) = PM0(IM) - enddo - enddo -! - CMEQ1 = 0.25d0 - call LEGND0 (-ZU0,PM0,MFIT) - do IM=M,MFIT - PM0(IM) = CMEQ1*PM0(IM) - enddo -! - call BLKSLV(FJ,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,FJT,FJB,M,N,MFIT,ND) -! - do ID=1,ND,2 - FJ(ID) = 4.0d0*FJ(ID) + FZ(ID) - enddo - - return - end subroutine MIESCT -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: BLKSLV -! -! !INTERFACE: -! - subroutine BLKSLV(FJ,POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,FJTOP,FJBOT, M,N,MFIT,ND) -! -! !USES: - use FastJX53cMIEparameters_mod, only : M_, N_ -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: M, N, MFIT, ND - real*8 , intent(in) :: POMEGA(2*M_,N_) - real*8 , intent(in) :: FZ(N_) - real*8 , intent(in) :: ZTAU(N_) - real*8 , intent(in) :: WT(M_) - real*8 , intent(in) :: EMU(M_) - real*8 , intent(in) :: PM(M_,2*M_) - real*8 , intent(in) :: PM0(2*M_) - real*8 , intent(in) :: ZFLUX - real*8 , intent(in) :: ZREFL -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: FJ(N_),FJTOP,FJBOT -! -! !DESCRIPTION: -! Solves the block tri-diagonal system: -! \begin{verbatim} -! A(I)*X(I-1) + B(I)*X(I) + C(I)*X(I+1) = H(I) -! \end{verbatim} -! -! !LOCAL VARIABLES: - real*8, dimension(M_) :: A, C1, H - real*8, dimension(M_,M_) :: B, AA, CC - real*8 DD(M_,M_,N_), RR(M_,N_) - real*8 SUMM - integer I, J, K, ID -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! -!-----------UPPER BOUNDARY ID=1 - call GEN(POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,B,CC,AA,A,H,C1,M,N,MFIT,ND,1) - call MATIN4 (B) - do I = 1,N - RR(I,1) = 0.0d0 - do J = 1,N - SUMM = 0.0d0 - do K = 1,N - SUMM = SUMM - B(I,K)*CC(K,J) - enddo - DD(I,J,1) = SUMM - RR(I,1) = RR(I,1) + B(I,J)*H(J) - enddo - enddo -!----------CONTINUE THROUGH ALL DEPTH POINTS ID=2 TO ID=ND-1 - do ID = 2,ND-1 - call GEN(POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,B,CC,AA,A,H,C1,M,N,MFIT,ND,ID) - do I = 1,N - do J = 1,N - B(I,J) = B(I,J) + A(I)*DD(I,J,ID-1) - enddo - H(I) = H(I) - A(I)*RR(I,ID-1) - enddo - call MATIN4 (B) - do I = 1,N - RR(I,ID) = 0.0d0 - do J = 1,N - RR(I,ID) = RR(I,ID) + B(I,J)*H(J) - DD(I,J,ID) = - B(I,J)*C1(J) - enddo - enddo - enddo -!---------FINAL DEPTH POINT: ND - call GEN(POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,B,CC,AA,A,H,C1,M,N,MFIT,ND,ND) - do I = 1,N - do J = 1,N - SUMM = 0.0d0 - do K = 1,N - SUMM = SUMM + AA(I,K)*DD(K,J,ND-1) - enddo - B(I,J) = B(I,J) + SUMM - H(I) = H(I) - AA(I,J)*RR(J,ND-1) - enddo - enddo - call MATIN4 (B) - do I = 1,N - RR(I,ND) = 0.0d0 - do J = 1,N - RR(I,ND) = RR(I,ND) + B(I,J)*H(J) - enddo - enddo -!-----------BACK SOLUTION - do ID = ND-1,1,-1 - do I = 1,N - do J = 1,N - RR(I,ID) = RR(I,ID) + DD(I,J,ID)*RR(J,ID+1) - enddo - enddo - enddo -!----------MEAN J & H - do ID = 1,ND,2 - FJ(ID) = 0.0d0 - do I = 1,N - FJ(ID) = FJ(ID) + RR(I,ID)*WT(I) - enddo - enddo - do ID = 2,ND,2 - FJ(ID) = 0.0d0 - do I = 1,N - FJ(ID) = FJ(ID) + RR(I,ID)*WT(I)*EMU(I) - enddo - enddo - - FJTOP = 0.0d0 - FJBOT = 0.0d0 - do I = 1,N - FJTOP = FJTOP + RR(I,1)*WT(I)*EMU(I) -! FJBOT = FJBOT + RR(I,1)*WT(I)*EMU(I) !this is not correct, includes up+down - enddo - FJTOP = 4.d0*FJTOP - - return - end subroutine BLKSLV -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: GEN -! -! !INTERFACE: -! - subroutine GEN(POMEGA,FZ,ZTAU,ZFLUX,ZREFL,WT,EMU,PM,PM0 & - & ,B,CC,AA,A,H,C1,M,N,MFIT,ND,ID) -! -! !USES: - use FastJX53cMIEparameters_mod, only : M_, N_ -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: M - integer, intent(in) :: N - integer, intent(in) :: MFIT - integer, intent(in) :: ND - integer, intent(in) :: ID - real*8 , intent(in) :: POMEGA(2*M_,N_) - real*8 , intent(in) :: FZ(N_) - real*8 , intent(in) :: ZTAU(N_) - real*8 , intent(in) :: WT(M_) - real*8 , intent(in) :: EMU(M_) - real*8 , intent(in) :: PM(M_,2*M_) - real*8 , intent(in) :: PM0(2*M_) - real*8 , intent(in) :: ZFLUX - real*8 , intent(in) :: ZREFL -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: B (M_,M_) - real*8 , intent(out) :: AA(M_,M_) - real*8 , intent(out) :: CC(M_,M_) - real*8 , intent(out) :: A (M_) - real*8 , intent(out) :: C1(M_) - real*8 , intent(out) :: H (M_) -! -! !DESCRIPTION: -! Generates coefficient matrices for the block tri-diagonal system: -! \begin{verbatim} -! A(I)*X(I-1) + B(I)*X(I) + C(I)*X(I+1) = H(I) -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer ID0, ID1, IM, I, J, K, MSTART - real*8 SUM0, SUM1, SUM2, SUM3 - real*8 DELTAU, D1, D2, SURFAC -! - real*8 S(M_,M_), W(M_,M_), U1(M_,M_), V1(M_) -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - if (ID.eq.1 .or. ID.eq.ND) then -!---------calculate generic 2nd-order terms for boundaries - ID0 = ID - ID1 = ID+1 - if (ID .ge. ND) ID1 = ID-1 - - do I = 1,N - SUM0 = 0.0d0 - SUM1 = 0.0d0 - SUM2 = 0.0d0 - SUM3 = 0.0d0 - do IM = M,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID0)*PM(I,IM)*PM0(IM) - SUM2 = SUM2 + POMEGA(IM,ID1)*PM(I,IM)*PM0(IM) - enddo - do IM = M+1,MFIT,2 - SUM1 = SUM1 + POMEGA(IM,ID0)*PM(I,IM)*PM0(IM) - SUM3 = SUM3 + POMEGA(IM,ID1)*PM(I,IM)*PM0(IM) - enddo - H(I) = 0.5d0*(SUM0*FZ(ID0) + SUM2*FZ(ID1)) - A(I) = 0.5d0*(SUM1*FZ(ID0) + SUM3*FZ(ID1)) - do J = 1,I - SUM0 = 0.0d0 - SUM1 = 0.0d0 - SUM2 = 0.0d0 - SUM3 = 0.0d0 - do IM = M,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID0)*PM(I,IM)*PM(J,IM) - SUM2 = SUM2 + POMEGA(IM,ID1)*PM(I,IM)*PM(J,IM) - enddo - do IM = M+1,MFIT,2 - SUM1 = SUM1 + POMEGA(IM,ID0)*PM(I,IM)*PM(J,IM) - SUM3 = SUM3 + POMEGA(IM,ID1)*PM(I,IM)*PM(J,IM) - enddo - S(I,J) = - SUM2*WT(J) - S(J,I) = - SUM2*WT(I) - W(I,J) = - SUM1*WT(J) - W(J,I) = - SUM1*WT(I) - U1(I,J) = - SUM3*WT(J) - U1(J,I) = - SUM3*WT(I) - SUM0 = 0.5d0*(SUM0 + SUM2) - B(I,J) = - SUM0*WT(J) - B(J,I) = - SUM0*WT(I) - enddo - S(I,I) = S(I,I) + 1.0d0 - W(I,I) = W(I,I) + 1.0d0 - U1(I,I) = U1(I,I) + 1.0d0 - B(I,I) = B(I,I) + 1.0d0 - enddo - - do I = 1,N - SUM0 = 0.0d0 - do J = 1,N - SUM0 = SUM0 + S(I,J)*A(J)/EMU(J) - enddo - C1(I) = SUM0 - enddo - do I = 1,N - do J = 1,N - SUM0 = 0.0d0 - SUM2 = 0.0d0 - do K = 1,N - SUM0 = SUM0 + S(J,K)*W(K,I)/EMU(K) - SUM2 = SUM2 + S(J,K)*U1(K,I)/EMU(K) - enddo - A(J) = SUM0 - V1(J) = SUM2 - enddo - do J = 1,N - W(J,I) = A(J) - U1(J,I) = V1(J) - enddo - enddo - if (ID .eq. 1) then -!-------------upper boundary, 2nd-order, C-matrix is full (CC) - DELTAU = ZTAU(2) - ZTAU(1) - D2 = 0.25d0*DELTAU - do I = 1,N - D1 = EMU(I)/DELTAU - do J = 1,N - B(I,J) = B(I,J) + D2*W(I,J) - CC(I,J) = D2*U1(I,J) - enddo - B(I,I) = B(I,I) + D1 - CC(I,I) = CC(I,I) - D1 -! H(I) = H(I) + 2.0d0*D2*C1(I) + D1*SISOTP - H(I) = H(I) + 2.0d0*D2*C1(I) - A(I) = 0.0d0 - enddo - else -!-------------lower boundary, 2nd-order, A-matrix is full (AA) - DELTAU = ZTAU(ND) - ZTAU(ND-1) - D2 = 0.25d0*DELTAU - SURFAC = 4.0d0*ZREFL/(1.0d0 + ZREFL) - do I = 1,N - D1 = EMU(I)/DELTAU - H(I) = H(I) - 2.0d0*D2*C1(I) - SUM0 = 0.0d0 - do J = 1,N - SUM0 = SUM0 + W(I,J) - enddo - SUM0 = D1 + D2*SUM0 - SUM1 = SURFAC*SUM0 - do J = 1,N - B(I,J) = B(I,J) + D2*W(I,J) - SUM1*EMU(J)*WT(J) - enddo - B(I,I) = B(I,I) + D1 - H(I) = H(I) + SUM0*ZFLUX - do J = 1,N - AA(I,J) = - D2*U1(I,J) - enddo - AA(I,I) = AA(I,I) + D1 - C1(I) = 0.0d0 - enddo - endif -!------------intermediate points: can be even or odd, A & C diagonal - else - DELTAU = ZTAU(ID+1) - ZTAU(ID-1) - MSTART = M + MOD(ID+1,2) - do I = 1,N - A(I) = EMU(I)/DELTAU - C1(I) = -A(I) - SUM0 = 0.0d0 - do IM = MSTART,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID)*PM(I,IM)*PM0(IM) - enddo - H(I) = SUM0*FZ(ID) - do J=1,I - SUM0 = 0.0d0 - do IM = MSTART,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID)*PM(I,IM)*PM(J,IM) - enddo - B(I,J) = - SUM0*WT(J) - B(J,I) = - SUM0*WT(I) - enddo - B(I,I) = B(I,I) + 1.0d0 - enddo - endif - return - end subroutine GEN -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: LEGND0 -! -! !INTERFACE: -! - subroutine LEGND0 (X,PL,N) -! - implicit none -! -! !IMPUT PARAMETERS: - integer, intent(in) :: N - real*8 , intent(in) :: X -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: PL(N) - -! !DESCRIPTION: -! Calculates ORDINARY Legendre fns of X (real). -! \begin{verbatim} -! from P[0] = PL(1) = 1, P[1] = X, .... P[N-1] = PL(N) -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer I - real*8 DEN -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -!---Always does PL(2) = P[1] - PL(1) = 1.d0 - PL(2) = X - do I = 3,N - DEN = (I-1) - PL(I) = PL(I-1)*X*(2.d0-1.0/DEN) - PL(I-2)*(1.d0-1.d0/DEN) - enddo - return - end subroutine LEGND0 -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: MATIN4 -! -! !INTERFACE: -! - subroutine MATIN4 (A) -! - implicit none -! -! !INPUT/OUTPUT PARAMETERS: - real*8, intent(INout) :: A(4,4) -! -! !DESCRIPTION: -! Invert $4 \times 4$ matrix A(4,4) in place with L-U decomposition (mjp, old...) -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -!---SETUP L AND U - A(2,1) = A(2,1)/A(1,1) - A(2,2) = A(2,2)-A(2,1)*A(1,2) - A(2,3) = A(2,3)-A(2,1)*A(1,3) - A(2,4) = A(2,4)-A(2,1)*A(1,4) - A(3,1) = A(3,1)/A(1,1) - A(3,2) = (A(3,2)-A(3,1)*A(1,2))/A(2,2) - A(3,3) = A(3,3)-A(3,1)*A(1,3)-A(3,2)*A(2,3) - A(3,4) = A(3,4)-A(3,1)*A(1,4)-A(3,2)*A(2,4) - A(4,1) = A(4,1)/A(1,1) - A(4,2) = (A(4,2)-A(4,1)*A(1,2))/A(2,2) - A(4,3) = (A(4,3)-A(4,1)*A(1,3)-A(4,2)*A(2,3))/A(3,3) - A(4,4) = A(4,4)-A(4,1)*A(1,4)-A(4,2)*A(2,4)-A(4,3)*A(3,4) -!---INVERT L - A(4,3) = -A(4,3) - A(4,2) = -A(4,2)-A(4,3)*A(3,2) - A(4,1) = -A(4,1)-A(4,2)*A(2,1)-A(4,3)*A(3,1) - A(3,2) = -A(3,2) - A(3,1) = -A(3,1)-A(3,2)*A(2,1) - A(2,1) = -A(2,1) -!---INVERT U - A(4,4) = 1.d0/A(4,4) - A(3,4) = -A(3,4)*A(4,4)/A(3,3) - A(3,3) = 1.d0/A(3,3) - A(2,4) = -(A(2,3)*A(3,4)+A(2,4)*A(4,4))/A(2,2) - A(2,3) = -A(2,3)*A(3,3)/A(2,2) - A(2,2) = 1.d0/A(2,2) - A(1,4) = -(A(1,2)*A(2,4)+A(1,3)*A(3,4)+A(1,4)*A(4,4))/A(1,1) - A(1,3) = -(A(1,2)*A(2,3)+A(1,3)*A(3,3))/A(1,1) - A(1,2) = -A(1,2)*A(2,2)/A(1,1) - A(1,1) = 1.d0/A(1,1) -!---MULTIPLY (U-INVERSE)*(L-INVERSE) - A(1,1) = A(1,1)+A(1,2)*A(2,1)+A(1,3)*A(3,1)+A(1,4)*A(4,1) - A(1,2) = A(1,2)+A(1,3)*A(3,2)+A(1,4)*A(4,2) - A(1,3) = A(1,3)+A(1,4)*A(4,3) - A(2,1) = A(2,2)*A(2,1)+A(2,3)*A(3,1)+A(2,4)*A(4,1) - A(2,2) = A(2,2)+A(2,3)*A(3,2)+A(2,4)*A(4,2) - A(2,3) = A(2,3)+A(2,4)*A(4,3) - A(3,1) = A(3,3)*A(3,1)+A(3,4)*A(4,1) - A(3,2) = A(3,3)*A(3,2)+A(3,4)*A(4,2) - A(3,3) = A(3,3)+A(3,4)*A(4,3) - A(4,1) = A(4,4)*A(4,1) - A(4,2) = A(4,4)*A(4,2) - A(4,3) = A(4,4)*A(4,3) - return - end subroutine MATIN4 -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: GAUSSP -! -! !INTERFACE: -! - subroutine GAUSSP (N,XPT,XWT) -! - implicit none -! -! !OUTPUT PARAMETERS: - integer, intent(out) :: N - real*8 , intent(out) :: XPT(*) - real*8 , intent(out) :: XWT(*) -! -! !DESCRIPTION: -! Loads in pre-set Gauss points for 4 angles from 0 to +1 in cos(theta)=mu -! -! !LOCAL VARIABLES: - real*8 GPT4(4),GWT4(4) - integer I - data GPT4/.06943184420297d0,.33000947820757d0,.66999052179243d0, & - & .93056815579703d0/ - data GWT4/.17392742256873d0,.32607257743127d0,.32607257743127d0, & - & .17392742256873d0/ -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - N = 4 - do I = 1,N - XPT(I) = GPT4(I) - XWT(I) = GWT4(I) - enddo - return - end subroutine GAUSSP -!EOC -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: EFOLD -! -! !INTERFACE: -! - subroutine EFOLD (F0, F1, N, F) -! - implicit none -! -! !INPUT PARAMETERS: - integer, intent(in) :: N - real*8 , intent(in) :: F0 - real*8 , intent(in) :: F1 -! -! !OUTPUT PARAMETERS: - real*8 , intent(out) :: F(101) !F(N+1) -! -! !DESCRIPTION: -! \begin{verbatim} -! ***not used in fast-J, part of original scattering code -!---Speciality subroutine for calculating consistent exp(-tau/mu0) -!--- values on the tau grid so that photons are conserved. -!--- ***only works for plane-parallel, NOT psuedo-spherical atmos -! -!--- calculate the e-fold between two boundaries, given the value -!--- at both boundaries F0(x=0) = top, F1(x=1) = bottom. -!--- presume that F(x) proportional to exp[-A*x] for x=0 to x=1 -!--- d2F/dx2 = A*A*F and thus expect F1 = F0 * exp[-A] -!--- alternatively, could define A = ln[F0/F1] -!--- let X = A*x, d2F/dX2 = F -!--- assume equal spacing (not necessary, but makes this easier) -!--- with N-1 intermediate points (and N layers of thickness dX = A/N) -!--- -!--- 2nd-order finite difference: (F(i-1) - 2F(i) + F(i+1)) / dX*dX = F(i) -!--- let D = 1 / dX*dX: -! -! 1 | 1 0 0 0 0 0 | | F0 | -! | | | 0 | -! 2 | -D 2D+1 -D 0 0 0 | | 0 | -! | | | 0 | -! 3 | 0 -D 2D+1 -D 0 0 | | 0 | -! | | | 0 | -! | 0 0 -D 2D+1 -D 0 | | 0 | -! | | | 0 | -! N | 0 0 0 -D 2D+1 -D | | 0 | -! | | | 0 | -! N+1 | 0 0 0 0 0 1 | | F1 | -! -!----------------------------------------------------------------------- -! Advantage of scheme over simple attenuation factor: conserves total -! number of photons - very useful when using scheme for heating rates. -! Disadvantage: although reproduces e-folds very well for small flux -! differences, starts to drift off when many orders of magnitude are -! involved. -!----------------------------------------------------------------------- -! \end{verbatim} -! -! !LOCAL VARIABLES: - integer I - real*8 A,DX,D,DSQ,DDP1, B(101),R(101) -! -! !AUTHOR: -! Michael Prather -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC -! - if (F0 .eq. 0.d0) then - do I = 1,N - F(I)=0.d0 - enddo - return - elseif (F1.eq.0.d0) then - A = log(F0/1.d-250) - else - A = log(F0/F1) - endif - DX = float(N)/A - D = DX*DX - DSQ = D*D - DDP1 = D+D+1.d0 - B(2) = DDP1 - R(2) = +D*F0 - do I = 3,N - B(I) = DDP1 - DSQ/B(I-1) - R(I) = +D*R(I-1)/B(I-1) - enddo - F(N+1) = F1 - do I = N,2,-1 - F(I) = (R(I) + D*F(I+1))/B(I) - enddo - F(1) = F0 - return - end subroutine EFOLD -!EOC -!------------------------------------------------------------------------- - - end module FastJX53cCoreScattering_mod - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cJvaluesVars_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cJvaluesVars_mod.F90 deleted file mode 100644 index cfbd434f..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cJvaluesVars_mod.F90 +++ /dev/null @@ -1,97 +0,0 @@ -!----------------------------------------------------------------------- -! NASA/GSFC - SIVO ASTG Code 610.3 ! -!----------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cJvaluesVars_mod -! -! !INTERFACE: - module FastJX53cJvaluesVars_mod -! -! !USES: - use FastJX53cCTMparameters_mod, only : A_, W_, X_, JVN_ -! - IMPLICIT NONE -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: InitializationFastjJvaluesVars -! -! !PUBLIC DATA MEMBERS: -! - public :: RAD , ZZHT , ATAU , ATAU0 - public :: WBIN , WL , FL , QO2 , QO3, Q1D - public :: QQQ , QRAYL , TQQ - public :: WAA , QAA , PAA , RAA , SSA - public :: JFACTA - public :: JIND , NRATJ , NJVAL - public :: NW1 , NW2 , NAA , JTAUMX - public :: TITLEA - public :: TITLE0 - public :: TITLEJ, TITLEJ2, TITLEJ3, JLABEL - - real*8 :: RAD, ZZHT, ATAU, ATAU0 - real*8 :: WBIN(W_+1) , WL(W_) , FL(W_) - real*8 :: QO2(W_,3) , QO3(W_,3) , Q1D(W_,3) - real*8 :: QQQ(W_,2,X_), QRAYL(W_+1), TQQ(3,X_) - real*8 :: WAA(4,A_) , QAA(4,A_) , PAA(8,4,A_), RAA(4,A_), SSA(4,A_) -! real*8 :: JFACTA(JVN_) -! integer :: JIND(JVN_) - integer :: NRATJ, NJVAL, NW1, NW2, NAA, JTAUMX - character*20 :: TITLEA(A_) - character*78 :: TITLE0 - character*7 :: TITLEJ(X_), TITLEJ2, TITLEJ3 -! character*7 :: JLABEL(JVN_) - - real*8 , pointer :: JFACTA(:) => null() - integer , pointer :: JIND (:) => null() - character*7, pointer :: JLABEL(:) => null() -! -! !DESCRIPTION: -! Declare J-values related variables. -! -! !AUTHOR: -! Michael Prather -! -! !HISTORY: -! -!EOP -!----------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: InitializationFastjJvaluesVars -! -! !INTERFACE: -! - subroutine InitializationFastjJvaluesVars() -! - implicit none -! -! !DESCRIPTION: -! Allocates JvaluesVars related variables. -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - allocate( JFACTA(JVN_)) - allocate( JIND (JVN_)) - allocate( JLABEL(JVN_)) - - JFACTA(:) = 0.0d0 - - return - - end subroutine InitializationFastjJvaluesVars -!EOC -!----------------------------------------------------------------------- - - end module FastJX53cJvaluesVars_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMIEparameters_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMIEparameters_mod.F90 deleted file mode 100644 index a475d09f..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMIEparameters_mod.F90 +++ /dev/null @@ -1,35 +0,0 @@ -!----------------------------------------------------------------------- -! NASA/GSFC - SIVO ASTG Code 610.3 ! -!----------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cMIEparameters_mod -! -! !INTERFACE: - module FastJX53cMIEparameters_mod -! -! !PUBLIC DATA MEMBERS: -! - private - public :: N_ - public :: M_ - - integer, parameter :: N_ = 501 - ! no. of levels in Mie scattering arrays - ! = 2*NC+1 = 4*LPAR + 5 + 2*sum(JADDLV) - integer, parameter :: M_ = 4 - ! no. of Gauss points used, must - ! = 4 in fast_JX (no option) -! -! !DESCRIPTION: -! -! -! !AUTHOR: -! Michael Prather -! -! !HISTORY: -! -!EOP -!----------------------------------------------------------------------- - - end module FastJX53cMIEparameters_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMetVars_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMetVars_mod.F90 deleted file mode 100644 index a0a22bfa..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMetVars_mod.F90 +++ /dev/null @@ -1,173 +0,0 @@ -!----------------------------------------------------------------------- -! NASA/GSFC - SIVO ASTG Code 610.3 ! -!----------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cMetVars_mod -! -! !INTERFACE: - module FastJX53cMetVars_mod -! -! !USES: - use FastJX53cCTMparameters_mod, only : I_, J_, L_, LWE_, L1_, NTR_ - - IMPLICIT NONE -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: InitializationFastjMetVars -! -! !PUBLIC DATA MEMBERS: -! - public :: doModelClima - public :: P , T , OD , PJ - public :: TJ , DM , DO3 , ZH - public :: SA , STT , PMEAN - public :: TREF , OREF - public :: XGRD , XDGRD - public :: YGRD , YDGRD - public :: ETAA , ETAB - public :: MONTH , NSLAT , NSLON - public :: DAER1 , DAER2 , DAER3, ODCLD - public :: NAER1 , NAER2 , NAER3, NCLDX - public :: AREAXY, TCNAME - - logical :: doModelClima - integer :: MONTH - integer :: NSLAT ! Latitude(J) index of current column - integer :: NSLON ! Longitude(I) index of current column - real*8 :: TREF(51,18,12) - real*8 :: OREF(51,18,12) - character*10 :: TCNAME(NTR_) - - real*8 , pointer :: PJ(:) => null() ! Column pressure - real*8 , pointer :: P(:,:) => null() ! Surface pressure - real*8 , pointer :: T(:,:,:) => null() ! Temperature profile - real*8 , pointer :: OD(:,:,:) => null() ! Optical Depth profile - real*8 , pointer :: XGRD(:) => null() ! Longitude (midpoint, radians) - real*8 , pointer :: XDGRD(:) => null() - real*8 , pointer :: YGRD(:) => null() ! Latitude (midpoint, radians) - real*8 , pointer :: YDGRD(:) => null() - real*8 , pointer :: ETAA(:) => null() ! Eta(a) value for level boundaries - real*8 , pointer :: ETAB(:) => null() ! Eta(b) value for level boundaries - real*8 , pointer :: AREAXY(:,:) => null() ! area (m^2) - real*8 , pointer :: TJ(:,:,:) => null() - real*8 , pointer :: DM(:,:,:) => null() - real*8 , pointer :: DO3(:,:,:) => null() - real*8 , pointer :: ZH(:,:,:) => null() - real*8 , pointer :: DAER1(:,:,:) => null() - real*8 , pointer :: DAER2(:,:,:) => null() - real*8 , pointer :: DAER3(:,:,:) => null() - real*8 , pointer :: ODCLD(:,:,:) => null() - integer, pointer :: NAER1(:,:,:) => null() - integer, pointer :: NAER2(:,:,:) => null() - integer, pointer :: NAER3(:,:,:) => null() - integer, pointer :: NCLDX(:,:,:) => null() - real*8 , pointer :: PMEAN(:,:) => null() - real*8 , pointer :: SA(:,:) => null() - real*8 , pointer :: STT(:,:,:,:) => null() - -! -! !DESCRIPTION: -! Delivers $p$ , $T$, Surf Albedo, and Optical Depth from CTM to fastJX. -! This is for standalone fast-JX ver 5.3 (6.05) -! -! !AUTHOR: -! Michael Prather -! -! !HISTORY: -! -!EOP -!----------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: InitializationFastjMetVars -! -! !INTERFACE: -! - subroutine InitializationFastjMetVars() -! - implicit none -! -! !DESCRIPTION: -! Allocates CTM related variables. -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - doModelClima = .false. - - Allocate(PJ(L1_+1)) - PJ = 0.0d0 - Allocate(P(I_,J_)) - P = 0.0d0 - Allocate(T(I_,J_,L_)) - T = 0.0d0 - Allocate(OD(I_,J_,LWE_)) - OD = 0.0d0 - - Allocate(XGRD (I_)) - XGRD = 0.0d0 - Allocate(XDGRD(I_)) - XDGRD = 0.0d0 - - Allocate(YGRD (J_)) - YGRD = 0.0d0 - Allocate(YDGRD(J_)) - YDGRD = 0.0d0 - - Allocate(ETAA(L_+1)) - ETAA = 0.0d0 - Allocate(ETAB(L_+1)) - ETAB = 0.0d0 - - Allocate(AREAXY(I_,J_)) - AREAXY = 0.0d0 - - Allocate(TJ (I_,J_,L1_)) - TJ = 0.0d0 - Allocate(DM (I_,J_,L1_)) - DM = 0.0d0 - Allocate(DO3 (I_,J_,L1_)) - DO3 = 0.0d0 - Allocate(ZH (I_,J_,L1_)) - ZH = 0.0d0 - - Allocate(DAER1(I_,J_,L1_)) - DAER1 = 0.0d0 - Allocate(DAER2(I_,J_,L1_)) - DAER2 = 0.0d0 - Allocate(DAER3(I_,J_,L1_)) - DAER3 = 0.0d0 - Allocate(ODCLD(I_,J_,L1_)) - ODCLD = 0.0d0 - - Allocate(NAER1(I_,J_,L1_)) - Allocate(NAER2(I_,J_,L1_)) - Allocate(NAER3(I_,J_,L1_)) - Allocate(NCLDX(I_,J_,L1_)) - - Allocate(PMEAN(I_,J_)) - PMEAN = 0.0d0 - Allocate(SA (I_,J_)) - SA = 0.0d0 - - Allocate(STT(I_,J_,L_,NTR_)) - STT = 0.0d0 - - return - - end subroutine InitializationFastjMetVars -!EOC -!----------------------------------------------------------------------- - - end module FastJX53cMetVars_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMethod_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMethod_mod.F90 deleted file mode 100644 index 03d0c0c1..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX53c/FastJX53cMethod_mod.F90 +++ /dev/null @@ -1,257 +0,0 @@ -!------------------------------------------------------------------------- -! NASA/GFSC, SIVO, Code 610.3 -!------------------------------------------------------------------------- -!BOP -! -! !MODULE: FastJX53cMethod_mod -! -! !INTERFACE: - module FastJX53cMethod_mod -! -! !USES: - use FastJX53cMetVars_mod, only : MONTH, PMEAN -! - implicit none -! -! !PUBLIC MEMBER FUNCTIONS: -! - private - public :: InitializeFastJX53c - public :: RunFastJX53c - public :: FinalizeFastJX53c -! -! !DESCRIPTION: -! Routines to Initialize, Run and Finalize the package fastJ. -! -! !AUTHOR: -! Jules Kouatchou -! -! !HISTORY: -! -!EOP -!----------------------------------------------------------------------- - CONTAINS -!----------------------------------------------------------------------- -!BOP -! -! !IROUTINE: InitializeFastJX53c -! -! !INTERFACE: -! - subroutine InitializeFastJX53c & - (k1, k2, chem_mask_khi, num_qjs, & - CrossSection_InfileName , ScatteringData_InfileName, & - PhotRateLabels_InfileName, T_O3_Climatology_InfileName) -! -! !USES: - use FastJX53cCTMparameters_mod, only : SetFastjCTMdims - use FastJX53cMetVars_mod , only : InitializationFastjMetVars - use FastJX53cCTMspecific_mod , only : INPHOT, SET_CLD0, SET_AER0, SET_ATM0 - use FastJX53cJvaluesVars_mod , only : InitializationFastjJvaluesVars - - implicit none -! -! !INPUT PARAMETERS: - integer , intent(in) :: k1, k2 - integer , intent(in) :: chem_mask_khi ! number of chemistry levels [JVL_] - integer , intent(in) :: num_qjs ! number of photolysis reactions [JVN_] - character (len=128), intent(in) :: CrossSection_InfileName -! ! fast-J X-sections (spectral data) input file name - character (len=128), intent(in) :: ScatteringData_InfileName -! ! Aerosol/cloud scattering data input file name - character (len=128), intent(in) :: PhotRateLabels_InfileName -! ! Labels of photolysis rates required input file name -! ! keyed to chem code - character (len=128), intent(in) :: T_O3_Climatology_InfileName -! ! Read in T & O3 climatology input file name -! ! general backup clim. -! -! !DESCRIPTION: -! Carry out the initialization of the package FastJX53c. -! -! !LOCAL VARIABLES: - integer :: LongDim ! Longitude dim of CTM grid - integer :: LatDim ! latidude dim of CTM grid - integer :: VertDim ! altitude dim of CTM grid - integer :: NumJval ! num. photolysis reactions - integer :: VertDimJval ! vertical(levels) dim for J-values -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - - longDim = 1 - latDim = 1 - vertDim = k2-k1+1 - numJval = num_qjs - vertDimJval = chem_mask_khi - - ! Set values of some CTM related dimensions - call SetFastjCTMdims (LongDim, Latdim, VertDim, VertDimJval, NumJval) - - ! Initialize MetFields related variables. - call InitializationFastjMetVars () - - ! Initialize Jvalues related variables. - call InitializationFastjJvaluesVars() - - ! Read in the input files - call INPHOT (CrossSection_InfileName, & - & ScatteringData_InfileName, & - & PhotRateLabels_InfileName, & - & T_O3_Climatology_InfileName) - -! call SET_CLD0(Temp, CloudOptDepth, IndexCloud, SurfAlbedo) - - ! Set up aerosol - call SET_AER0 - - return - - end subroutine InitializeFastJX53c -!EOC -!------------------------------------------------------------------------- -!BOP -! -! !IROUTINE: RunFastJX53c -! -! !INTERFACE: -! - subroutine RunFastJX53c(k1, k2, IDAY, timeSec, iMONTH, sza_ij, & - press3c_ij, pctm_ij, kel_ij, optdepth_ij, & - surf_alb_ij, PhotRate, ozone_ij) -! -! !USE: - use FastJX53cMetVars_mod , only : PJ, PMEAN, MONTH, SA, T, NCLDX, ODCLD - use FastJX53cMetVars_mod , only : XDGRD, YDGRD, XGRD, YGRD, DO3, doModelClima - use FastJX53cCTM_FastjLinking_mod, only : PHOTOJ - use FastJX53cCTMspecific_mod , only : SET_ATM0, SET_ATM, SET_AER, SET_CLD - use FastJX53cCTMparameters_mod , only : I_, J_, L_, JVL_, JVN_, L1_ - - implicit none - -! !INPUT PARAMETERS: - integer, intent(in) :: k1, k2 - real*8 , intent(in) :: timeSec ! Time of day in model (s) - integer, intent(in) :: IDAY ! Current day - integer, intent(in) :: imonth ! Current Month - real*8, intent(in) :: kel_ij(k1:k2) ! temperature at box centers (degK) [t] - !real*8, intent(in) :: londeg_i ! longitude (midpoint, deg) [xdgrd] - !real*8, intent(in) :: latdeg_j ! latitude (midpoint, deg) [ydgrd] - real*8, intent(in) :: sza_ij ! solar zenith angle - real*8, intent(in) :: press3c_ij(k1:k2) - real*8, intent(in) :: pctm_ij ! surface pressure (mb) [p] - real*8, intent(in) :: optdepth_ij(k1:k2) ! optical depth in box (unitless) [od] - real*8, intent(in) :: surf_alb_ij ! surface albedo (fraction 0-1) [sa] - real*8, optional, intent(in) :: ozone_ij(k1:k2) ! mixing ratio for ozone -! -! !OUPUT PARAMETERS: - real*8 , intent(out) :: PhotRate(JVL_,JVN_) ! array of J's indexed to CTM chemistry -! -! !LOCAL VARIABLES: - integer :: ILNG, JLAT - real*8 :: GMTAU ! Time of day (hr) - real*8 :: PI - real*8 :: FREFL, U0 ! fraction of flux(energy-wtd) reflected -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - - PI = 4.0d0*atan(1.0d0) - ILNG = I_ - JLAT = J_ - - MONTH = imonth ! current month - GMTAU = timeSec / 3600.0d0 ! time (hr) - - !XDGRD(I_) = londeg_i - !YDGRD(J_) = latdeg_j - !XGRD(I_) = XDGRD(I_) *PI/180.d0 - !YGRD(J_) = YDGRD(J_) *PI/180.d0 - - PJ(1) = pctm_ij - PJ(2:L1_) = press3c_ij(k1:k2) ! pressure at the edge - PJ(L1_+1) = 0.0d0 - - PMEAN(I_, J_) = pctm_ij ! surface pressure - T(I_, J_, 1:L_) = kel_ij(k1:k2) ! temperature - ODCLD(I_, J_, 1:L_) = optdepth_ij(k1:k2) ! cloud optical depth - ODCLD(I_, J_, L1_) = 0.0 - SA(I_, J_) = surf_alb_ij ! surface albedo - NCLDX(I_, J_, 1:L1_) = 10 - -!---reset the atmosphere, aerosols, clouds for the time step (now = dummy) -!----------------------------------------------------------------------- - - ! Set up atmospheric variables at the current time if using - ! fastJ climatology. - if (.not. present(ozone_ij)) then - call SET_ATM0 - endif - - ! Set up atmospheric variables at the current time if using CTM - ! climatology - if (present(ozone_ij)) then - doModelClima = .true. - DO3(I_, J_, 1:L_) = ozone_ij(k1:k2) - DO3(I_, J_, L1_ ) = ozone_ij(k2) - call SET_ATM(GMTAU) - endif - - ! Set up aerosols at the current time - call SET_AER(GMTAU) - - ! Set up cloud at the current time - call SET_CLD(GMTAU) - - ! Calculate the photolysis rate - call PHOTOJ(GMTAU,IDAY,ILNG,JLAT, sza_ij, U0, FREFL, PhotRate) - - return - - end subroutine RunFastJX53c -!EOC -!------------------------------------------------------------------------- -!BOP -! -! !IROUTINE: FinalizeFastJX53c -! -! !INTERFACE: -! - subroutine FinalizeFastJX53c() -! - implicit none -! -! !DESCRIPTION: -! Finalize the package FastJX53c by deallocating (if necessary) variables. -! -! !AUTHOR: -! Jules Kouatchou -! -! !REVISION HISTORY: -! Initial code. -! -!EOP -!------------------------------------------------------------------------- -!BOC - - return - - end subroutine FinalizeFastJX53c -!EOC -!----------------------------------------------------------------------- - - end module FastJX53cMethod_mod diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX65/fastJX65_mod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX65/fastJX65_mod.F90 index 584581a6..9d682ec7 100755 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX65/fastJX65_mod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fast_JX65/fastJX65_mod.F90 @@ -330,22 +330,24 @@ end subroutine initializeFastJX65 ! ! !INTERFACE: ! - subroutine GetQAA_RAAinFastJX65 (bRAA, bQAA) + subroutine GetQAA_RAAinFastJX65 (RAA_b, QAA_b, id, jd) ! # include "parm_CTM_fastJX65.h" # include "cmn_JVdat_fastJX65.h" ! +! !INPUT PARAMETERS: this maps a subset of JX65 parameters to use in our aerdust OD calc + integer, intent(in) :: id, jd ! !OUTPUT PARAMETERS: - real*8 , intent(out) :: bRAA(:,:) - real*8 , intent(out) :: bQAA(:,:) + real*8 , intent(out) :: RAA_b(id,jd) + real*8 , intent(out) :: QAA_b(id,jd) !EOP !--------------------------------------------------------------------------- !BOC ! Get effective radius associated with aerosol type - bRAA(:,:) = RAA(:,:) !<----- Check the dimensions. used to be 2D now 1D + RAA_b(1:id,1:jd) = RAA(1:id,1:jd) ! Get aerosol scattering phase functions - bQAA(:,:) = QAA(:,:) + QAA_b(1:id,1:jd) = QAA(1:id,1:jd) RETURN diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/fastj_control.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/fastj_control.F90 deleted file mode 100644 index 199ec055..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/fastj_control.F90 +++ /dev/null @@ -1,335 +0,0 @@ -! $Id$ - module fastj - - use GmiPrintError_mod, only : GmiPrintError - use GmiASCIIoperations_mod, only : AsciiOpenRead - - private - public :: Control_Fastj - public :: InitializeFastj - public :: GetQAA_RAAinFastj - contains -!============================================================================= -! -! -! CODE DEVELOPER -! Original code by Philip Cameron-Smith, LLNL -! (Adapted from standalone.f in Fast-J v3 distributed by Oliver Wild, UCI) -! cameronsmith1@llnl.gov -! -! FILE -! fastj_control.F -! -! ROUTINES -! Control_Fastj -! -! HISTORY -! - January 28, 2005 * Jules Kouatchou -! Added "ODAER_ij" and "ODMDUST_ij" as arguments of Control_Fastj. -! Assigned ODAER_ij to "optaer" and "ODMDUST_ij" to "optdust". -!============================================================================= - - -!----------------------------------------------------------------------------- -! -! ROUTINE -! Control_Fastj -! -! DESCRIPTION -! This routine acts as the interface between the GMI model and Fast-J. -! -! ARGUMENTS -! -! INPUTS -! cross_section_file : X-Section quantum yield -! rate_file : Master rate file -! T_O3_climatology_file : T & O3 climatology -! k1 : first interface index [lpar = k2 - k1 + 1] -! k2 : last interface index [lpar = k2 - k1 + 1] -! chem_mask_khi : number of chemistry levels [jpnl] -! num_qjs : number of photolysis reactions [jppj] -! month_gmi : number of month (1- 12) [month] -! jday : day of year (1-365) [iday] -! time_sec : time of day in model (s, GMT) [tau (hrs)] -! fastj_offset_sec : offset from tau at which to do photolysis (s) -! [timej (hrs)] -! londeg_i : longitude (midpoint, deg) [xgrd (rad)] -! latdeg_j : latitude (midpoint, deg) [ygrd (rad), ydgrd (deg)] -! press3e_ij : pressure at box edge (mb) [p] -! kel_ij : temperature at box centers (degK) [t] -! optdepth_ij : optical depth in box (unitless) [od] -! surf_alb_ij : surface albedo (fraction 0-1) [sa] -! ODAER_ij : optical depth for aerosol -! ODMDUST_ij : optical depth for mineral dust -! sza_ij : solar zenith angle -! OUTPUTS -! qjgmi_ij : jvalues at grid centers (s^-1?) [zpj] -! n_qj_O3_2OH : index of O3 -> O1d photolysis IF it is actually -! intended to be corrected to be O3 -> 2OH photolysis -! -!----------------------------------------------------------------------------- - - subroutine Control_Fastj & - & (k1, k2, chem_mask_khi, num_qjs, & - & month_gmi, jday, time_sec, fastj_offset_sec, sza_ij, & - & press3e_ij, kel_ij, optdepth_ij, & - & surf_alb_ij, qjgmi_ij, overheadO3col_ij, ODAER_ij, ODMDUST_ij) - - implicit none - -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_cmn_w.h" -# include "fastj_jv_cmn.h" - - -! ---------------------- -! Argument declarations. -! ---------------------- - - integer, intent(in) :: k1 - integer, intent(in) :: k2 - integer, intent(in) :: chem_mask_khi - integer, intent(in) :: num_qjs - integer, intent(in) :: month_gmi - integer, intent(in) :: jday - real*8, intent(in) :: time_sec - real*8, intent(in) :: fastj_offset_sec - real*8, intent(in) :: sza_ij - real*8, intent(in) :: press3e_ij(k1-1:k2) - real*8, intent(in) :: kel_ij(k1:k2) - real*8, intent(in) :: optdepth_ij(k1:k2) - real*8, intent(in) :: surf_alb_ij -! - real*8, intent(in) :: ODAER_ij(k1:k2,NSADaer*nrh_b) - real*8, intent(in) :: ODMDUST_ij(k1:k2,NSADdust) -! - real*8, intent(out) :: overheadO3col_ij(k1:k1) - real*8, intent(out) :: qjgmi_ij(k1:chem_mask_khi, num_qjs) - - -! ---------------------- -! Variable declarations. -! ---------------------- - - character (len=75) :: err_msg - - logical, save :: first = .true. - - integer :: il, ik - - real*8 :: pi - real*8 :: timej - - real*8 :: zpj(chem_mask_khi-k1+1, num_qjs) - - -! ---------------- -! Begin execution. -! ---------------- - -!c if (pr_diag) then -!c Write (6,*) 'Control_Fastj called by ', loc_proc -!c end if - - -! ------------------------- -! Just do one column {PJC}. -! ------------------------- - -! nslat = 1 -! nslon = 1 - - pi = 3.141592653589793d0 ! FLAG {PJC} - - -! ----------------------------------------------------- -! Check that k1=1, otherwise Fast-J may not work {PJC}. -! ----------------------------------------------------- - - if (k1 /= 1) then - err_msg = & - & 'Control_Fastj: Fast-J may not work correctly if k1 /= 1.' - call GmiPrintError (err_msg, .true., 1, k1, 0, 0, 0.0d0, 0.0d0) - end if - -! ---------------------------------------------------------------- -! Check dimensions against dimension maximums specified in include -! files {PJC}. -! ---------------------------------------------------------------- - - if (lpar > LPAR_MAX) then - err_msg = 'Control_Fastj: lpar exceeds LPAR_MAX. '// & - & 'Increase LPAR_MAX and recompile.' - call GmiPrintError & - & (err_msg, .true., 2, lpar, LPAR_MAX, 0, 0.0d0, 0.0d0) - end if - - if (jpnl > JPNL_MAX) then - err_msg = 'Control_Fastj: jpnl exceeds JPNL_MAX. '// & - & 'Increase JPNL_MAX and recompile.' - call GmiPrintError & - & (err_msg, .true., 2, jpnl, JPNL_MAX, 0, 0.0d0, 0.0d0) - end if - - if (jppj > JPPJ_MAX) then - err_msg = 'Control_Fastj: jppj exceeds JPPJ_MAX. '// & - & 'Increase JPPJ_MAX and recompile.' - call GmiPrintError & - & (err_msg, .true., 2, jppj, JPPJ_MAX, 0, 0.0d0, 0.0d0) - end if - - if (nb > NB_MAX) then - err_msg = 'Control_Fastj: nb exceeds NB_MAX. '// & - & 'Increase NB_MAX and recompile.' - call GmiPrintError & - & (err_msg, .true., 2, nb, NB_MAX, 0, 0.0d0, 0.0d0) - end if - - if (nc > NC_MAX) then - err_msg = 'Control_Fastj: nc exceeds NC_MAX. '// & - & 'Increase NC_MAX and recompile.' - call GmiPrintError & - & (err_msg, .true., 2, nc, NC_MAX, 0, 0.0d0, 0.0d0) - end if - - -! ------------------------------------------------- -! Set up Fast-J variables from GMI variables {PJC}. -! ------------------------------------------------- - - month = month_gmi - iday = jday - tau = time_sec / 3600.0d0 ! convert to hours {PJC} - timej = fastj_offset_sec / 3600.0d0 ! convert to hours {PJC} - - !xgrd (nslon) = londeg_i * pi / 180.0d0 - !ygrd (nslat) = latdeg_j * pi / 180.0d0 - !ydgrd(nslat) = latdeg_j - - pj(1:NB) = press3e_ij(k1-1:k2) - pj(NB+1) = 0.0d0 - - t (nslon, nslat, 1:lpar) = kel_ij (k1:k2) - od(nslon, nslat, 1:lpar) = optdepth_ij(k1:k2) - sa(nslon, nslat) = surf_alb_ij - - ! Aerosol OD profile [unitless] - !optaer(nslon, nslat, 1:lpar,:) = ODAER_ij(k1:k2,:) - optaer(1:lpar,:) = ODAER_ij(k1:k2,:) - - ! Mineral dust OD profile [unitless] - ! optdust(nslon, nslat, 1:lpar,:) =ODMDUST_ij(k1:k2,:) - optdust(1:lpar,:) =ODMDUST_ij(k1:k2,:) - - zpj(:,:) = -1.0d0 - -! ---------------------------------- -! Call main Fast-J routine (Photoj). -! ---------------------------------- - -!c Open (2, file = 'output') - - -!c Write (6,900) 1, iday, tau - - -! -------------------------------------------------------------------- -! Call main Fast-J routine, which actually calulates photolysis rates. -! -------------------------------------------------------------------- - -!c Write (6,*) 'Calling Photoj.' - - sza = sza_ij ! Oloso added sza_ij 12/2010 - -! =========== - call Photoj (zpj, timej) -! =========== - - qjgmi_ij(:,:) = zpj(:,:) -!c qjgmi_ij(:,:) = 0.0d0 -!!!! -!!!! Overhead ozone column -!!!! - overheadO3col_ij = 0.0d0 - overheadO3col_ij(k2) = DO3(k2) - do il = k1, k2-1 - do ik = il+1, k2 - overheadO3col_ij(il) = overheadO3col_ij(il) + DO3(ik) - end do - end do - - - return - end subroutine Control_Fastj - -! --------------------------------------------------------------------- -! --------------------------------------------------------------------- - - subroutine InitializeFastj & - & (cross_section_file, rate_file, T_O3_climatology_file, & - & n_qj_O3_2OH, num_qjs, chem_mask_khi, k2, k1) - - implicit none - - integer :: n_qj_O3_2OH, num_qjs, chem_mask_khi, k2, k1 - character (len=128), intent(in) :: cross_section_file - character (len=128), intent(in) :: rate_file - character (len=128), intent(in) :: T_O3_climatology_file - -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_jv_cmn.h" - - nslat = 1 - nslon = 1 - -! ---------------------------------------- -! Initial call to Fast-J to set things up. -! ---------------------------------------- - - lpar = k2 - k1 + 1 - - jpnl = chem_mask_khi - jppj = num_qjs - - nb = lpar + 1 - nc = 2 * nb - - n_qj_O3_2OH = 0 - -! =========== - call Inphot & -! =========== - & (cross_section_file, rate_file, & - & T_O3_climatology_file, n_qj_O3_2OH) - - return - - end subroutine InitializeFastj - -! --------------------------------------------------------------------- - - subroutine GetQAA_RAAinFastj (bRAA, bQAA) - - implicit none - -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - - real*8 , intent(out) :: bRAA(:,:), bQAA(:,:) - - bRAA(:,:) = RAA(:,:) - bQAA(:,:) = QAA(:,:) - - return - - end subroutine GetQAA_RAAinFastj - -! --------------------------------------------------------------------- -# include "newcol.code" - - end module fastj - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/newcol.code b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/newcol.code deleted file mode 100644 index e6f3b4cf..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/fastj/newcol.code +++ /dev/null @@ -1,2164 +0,0 @@ -! $Id$ - -!---(pphot.f)-------generic CTM shell from UCIrvine (p-code 4.0, 7/99) -!---------PPHOT calculates photolysis rates with the Fast-J scheme -!---------subroutines: inphot, photoj, Fast-J schemes... -!----------------------------------------------------------------------- -! - subroutine inphot(cross_section_file, rate_file, & - & T_O3_climatology_file, n_qj_O3_2OH) -!----------------------------------------------------------------------- -! Routine to initialise photolysis rate data, called directly from the -! cinit routine in ASAD. Currently use it to read the JPL spectral data -! and standard O3 and T profiles and to set the appropriate reaction index. -!----------------------------------------------------------------------- -! -! iph Channel number for reading all data files -! rad Radius of Earth (cm) -! zzht Effective scale height above top of atmosphere (cm) -! dtaumax Maximum opt.depth above which a new level should be inserted -! dtausub No. of opt.depths at top of cloud requiring subdivision -! dsubdiv Number of additional levels to add at top of cloud -! szamax Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" -!c - character (len=128),intent(in) :: cross_section_file ! Added for GMI {AOO,10/04} - character (len=128),intent(in) :: rate_file ! Added for GMI {AOO, 10/04} - character (len=128),intent(in) :: T_O3_climatology_file ! Added for GMI {AOO, 10/04} - integer, intent(out) :: n_qj_O3_2OH ! Added for GMI {PJC} -!c - integer iph -! -! Use channel 8 to read files at the moment -! iph=8 -! -! Defaults & constants - RAD = 6375.d5 - ZZHT = 5.d5 -! -! Calculate new levels if tau exceeds DTAUMAX - dtaumax = 1.d0 -! Add dsubdiv additional levels in first dtausub of cloud - dtausub = 1.0d0 - dsubdiv = 10.d0 -! -! Maximum Zenith Angle (98 degrees at 63 km; 99 degrees at 80 km) - szamax = 98.0d0 -! -! Read in labels of photolysis rates required - call Rd_Js (iph, rate_file, n_qj_O3_2OH) -! -! Read in JPL spectral data set - call Rd_Tjpl (iph, cross_section_file) -! -! Read in T & O3 climatology - call Rd_Prof (iph, T_O3_climatology_file) -! -! Select Aerosol/Cloud types to be used - CALL SET_AER -! - return - end subroutine inphot - - subroutine rd_js(nj1,namfil, n_qj_O3_2OH) -!----------------------------------------------------------------------- -! Reread the ratj.d file to map photolysis rate to reaction -! Read in quantum yield 'jfacta' and fastj label 'jlabel' -!----------------------------------------------------------------------- -! -! jfacta Quantum yield (or multiplication factor) for photolysis -! jlabel Reference label identifying appropriate J-value to use -! ipr Photolysis reaction counter - should total 'jppj' -! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" -! - integer, intent(out) :: n_qj_O3_2OH ! Added for GMI {PJC} - integer nj1, ipr -!c integer i ! Only used for diagnostics {PJC} -!c character*6 namfil - character (len=128) :: namfil - character*120 cline -! -! Reread the ratj.d file to map photolysis rate to reaction -! Read in quantum yield jfacta and fastj label jlabel - ipr=0 - n_qj_O3_2OH = 0 ! Added for GMI {PJC} -!c open(nj1,file=namfil,status='old',form='formatted') - call AsciiOpenRead (nj1,namfil) - - 10 read(nj1,'(a)',err=20) cline - if(cline(2:5).eq.'9999') then - go to 20 - elseif(cline(1:1).eq.'#') then - go to 10 - elseif(cline(5:5).eq.'$') then - go to 10 - else - ipr=ipr+1 - read(cline(79:83),'(f5.1)') jfacta(ipr) - read(cline(86:92),'(a7)') jlabel(ipr) - jfacta(ipr)=jfacta(ipr)/100.d0 - if ( jlabel(ipr) == "O3_1dOH" ) then ! Added for GMI {PJC} - jlabel(ipr) = "O3_1d" ! Catch O3 -> O1d for later - n_qj_O3_2OH = ipr ! Correction to provide - endif ! Effective J for O3 -> 2OH. - go to 10 - endif - 20 close(nj1) - if(ipr.ne.jppj) then - write(6,1000) ipr,jppj - STOP "Fastj" - endif -! -! Print details to standard output -!c write(6,1100) ipr -!c write(6,1200) (i, jlabel(i), jfacta(i),i=1,ipr) -! - return - 1000 format(' Error: ',i3,' photolysis labels but ',i3,' reactions') -!1100 format(' Fast-J Photolysis Scheme: considering ',i2,' reactions') -!1200 format(3x,10(3(i2,': ',a7,' (Q.Y. ',f5.3,') '),/,3x)) - end subroutine rd_js - - - subroutine photoj(zpj,timej) -!----------------------------------------------------------------------- -!----jv_trop.f: new FAST J-Value code, troposphere only (mjprather 6/96) -!---- uses special wavelength quadrature spectral data (jv_spec.dat) -!--- that includes only 289 nm - 800 nm (later a single 205 nm add-on) -!--- uses special compact Mie code based on Feautrier/Auer/Prather vers. -!----------------------------------------------------------------------- -! -! zpj External array providing J-values to main CTM code -! timej Offset in hours from start of timestep to time J-values -! required for - take as half timestep for mid-step Js. -! solf Solar distance factor, for scaling; normally given by: -! 1.0-(0.034*cos(real(iday-186)*2.0*pi/365.)) -! -!----------basic common blocks:----------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_jv_cmn.h" -# include "gmi_phys_constants.h" - real*8 zpj(jpnl,jppj),timej,solf - integer i,j -!----------------------------------------------------------------------- -! - do i=1,jpnl - do j=1,jppj - zj(i,j)=0.D0 - zpj(i,j)=0.D0 - enddo - enddo -! -!---Calculate new solar zenith angle - CALL SOLAR2(timej) - if(SZA.gt.szamax) go to 10 -! -!---Set up profiles on model levels - CALL SET_PROF -! -!---Print out atmosphere -! CALL PRTATM(3) - -! -!----------------------------------------------------------------------- -!c WRITE(6,*) 'calling JVALUE.' - CALL JVALUE -!----------------------------------------------------------------------- -!---Print solar flux terms -! WRITE(6,'(A16,I5,20I9)') ' wave (beg/end)',(i,i=1,jpnl) -! DO j=NW1,NW2 -! WRITE(6,'(2F8.2,20F9.6)') WBIN(j),WBIN(j+1), -! $ (FFF(j,i)/FL(j),i=1,jpnl) -! ENDDO -! -!---Include variation in distance to sun - solf=1.d0-(0.034d0*cos(dble(iday-186)*2.d0*GMI_PI/365.d0)) -! solf=1.d0 -!----------------------------------------------------------------------- -!c WRITE(6,*) 'calling JRATET.' - CALL JRATET(solf) -!----------------------------------------------------------------------- -! -! "zj" updated in JRATET - pass this back to ASAD as "zpj" - do i=1,jpnl - do j=1,jppj - zpj(i,j)= zj(i,j) - enddo - enddo -!c write(6,'(2(1x,i2),10(1pe10.3))') nslon,nslat,(zj(i,1),i=1,jpnl) -! -!---Output selected values - 10 if((.not.ldeg45.and.nslon.eq.37.and.nslat.eq.36).or. & - & (ldeg45.and.nslon.eq.19.and.nslat.eq.18)) then - i=min(jppj,8) -!c write(6,1000) iday, tau+timej, sza, jlabel(i), zpj(1,i) - endif -! -!c WRITE(6,*) 'finished Photoj.' - return -!1000 format(' Photolysis on day ',i4,' at ',f4.1,' hrs: SZA = ',f7.3, -!c $ ' J',a7,'= ',1pE10.3) - end subroutine photoj - - -!----------------------------------------------------------------------- - subroutine set_prof -!----------------------------------------------------------------------- -! Routine to set up atmospheric profiles required by Fast-J using a -! doubled version of the level scheme used in the CTM. First pressure -! and z* altitude are defined, then O3 and T are taken from the supplied -! climatology and integrated to the CTM levels (may be overwritten with -! values directly from the CTM, if desired) and then black carbon and -! aerosol profiles are constructed. -! Oliver (04/07/99) -! -! HISTORY -! January 5, 2005 - Jules Kouatchou -! Added the include file "gmi_AerDust_const.h" and "setkin_par.h". -! Modified the section on "Add Aerosol Column". -!----------------------------------------------------------------------- -! -! pj Pressure at boundaries of model levels (hPa) -! z Altitude of boundaries of model levels (cm) -! odcol Optical depth at each model level -! masfac Conversion factor for pressure to column density -! -! TJ Temperature profile on model grid -! DM Air column for each model level (molecules.cm-2) -! DO3 Ozone column for each model level (molecules.cm-2) -! DBC Mass of Black Carbon at each model level (g.cm-3) ! .....! -! PSTD Approximate pressures of levels for supplied climatology -! -!----------------------------------------------------------------------- - implicit none - -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_cmn_w.h" -# include "fastj_jv_cmn.h" - integer i, k, l, m, N - real*8 odcol(lpar),dlogp,f0,t0,b0,pb,pc,xc,masfac,scaleh - real*8 pstd(52),oref2(51),tref2(51),bref2(51) -! -! First calculate pressure at boundaries of CTM levels (lpar+1) -! do i=1,NB -! pj(i) = etaa(i) + etab(i)*P(nslon,nslat) -! enddo -! pj(NB+1) = 0.d0 -! -! Set up cloud and surface properties - call CLDSRF(odcol) -! -! Set up pressure levels for O3/T climatology - assume that value -! given for each 2 km z* level applies from 1 km below to 1 km above, -! so select pressures at these boundaries. Surface level values at -! 1000 mb are assumed to extend down to the actual P(nslon,nslat). -! - pstd(1) = max(pj(1),1000.d0) - pstd(2) = 1000.d0*10.d0**(-1.d0/16.d0) - dlogp = 10.d0**(-2.d0/16.d0) - do i=3,51 - pstd(i) = pstd(i-1)*dlogp - enddo - pstd(52) = 0.d0 -! -! Mass factor - delta-Pressure (mbars) to delta-Column (molecules.cm-2) - masfac=100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) -! -! Select appropriate monthly and latitudinal profiles - m = max(1,min(12,month)) - l = max(1,min(18,(int(ydgrd(nslat))+99)/10)) -! -! Temporary arrays for climatology data - do i=1,51 - oref2(i)=oref(i,l,m) - tref2(i)=tref(i,l,m) - bref2(i)=bref(i) - enddo -! -! Apportion O3 and T on supplied climatology z* levels onto CTM levels -! with mass (pressure) weighting, assuming constant mixing ratio and -! temperature half a layer on either side of the point supplied. -! - do i = 1,NB - F0 = 0.d0 - T0 = 0.d0 - B0 = 0.d0 - do k = 1,51 - PC = min(pj(i),pstd(k)) - PB = max(pj(i+1),pstd(k+1)) - if(PC.gt.PB) then - XC = (PC-PB)/(pj(i)-pj(i+1)) - F0 = F0 + oref2(k)*XC - T0 = T0 + tref2(k)*XC - B0 = B0 + bref2(k)*XC - endif - enddo - TJ(i) = T0 - DO3(i)= F0*1.d-6 - DBC(i)= B0 - enddo -! -! Insert model values here to replace or supplement climatology. -! Note that CTM temperature is always used in x-section calculations -! (see JRATET); TJ is used in actinic flux calculation only. -! -! do i=1,lpar -! DO3(i) = my_ozone(i) ! Volume Mixing Ratio -! TJ(i) = T(nslon,nslat,I) ! Kelvin -! enddo -! DO3(lpar+1) = my_ozone*exp() ! Above top of model (or use climatology) -! TJ(lpar+1) = my_temp(lpar) ! Above top of model (or use climatology) -! -! -! Calculate effective altitudes using scale height at each level - z(1) = 0.d0 - do i=1,lpar - scaleh=1.3806d-19*masfac*TJ(i) - z(i+1) = z(i)-(log(pj(i+1)/pj(i))*scaleh) - enddo -! -! Add Aerosol Column - include aerosol types here. Currently use soot -! water and ice; assume black carbon x-section of 10 m2/g, independent -! of wavelength; assume limiting temperature for ice of -40 deg C. -! -!!!! -!Beg: Bryan & Jules -!!!! - do i=1,lpar - AER(1,i) = DBC(i)*10.d0*(z(i+1)-z(i)) - - ! Turn off uniform black carbon profile (rvm, bmy, 2/27/02) - AER(1,I) = 0D0 - - if(T(nslon,nslat,I).gt.233.d0) then - AER(2,i) = odcol(i) - AER(3,i) = 0.d0 - else - AER(2,i) = 0.d0 - AER(3,i) = odcol(i) - endif - - ! Also add in aerosol optical depth columns (rvm, bmy, 9/30/00) - DO N = 1, NSADdust - AER(3+N,I) = OPTDUST(I,N) - ENDDO - - ! Also add in other aerosol optical depth columns (rvm, bmy, 2/27/02) - DO N = 1, NSADaer*NRH_b - AER(3+N+NSADdust,I) = OPTAER(I,N) - ENDDO - - enddo - - do k=1,MX - AER(k,lpar+1) = 0.d0 - enddo -!!!! -!End: Bryan & Jules -!!!! -! -! Calculate column quantities for Fast-J - do i=1,NB - DM(i) = (PJ(i)-PJ(i+1))*masfac - DO3(i) = DO3(i)*DM(i) - enddo -! - return - end subroutine set_prof - - - SUBROUTINE CLDSRF(odcol) -!----------------------------------------------------------------------- -! Routine to set cloud and surface properties -!----------------------------------------------------------------------- -! rflect Surface albedo (Lambertian) -! odmax Maximum allowed optical depth, above which they are scaled -! odcol Optical depth at each model level -! odsum Column optical depth -! nlbatm Level of lower photolysis boundary - usually surface -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_cmn_w.h" -# include "fastj_jv_cmn.h" - integer i, j, k - real*8 odcol(lpar), odsum, odmax, odtot -! -! Default lower photolysis boundary as bottom of level 1 - nlbatm = 1 -! -! Set surface albedo - RFLECT = dble(SA(nslon,nslat)) - RFLECT = max(0.d0,min(1.d0,RFLECT)) -! -! Zero aerosol column - do k=1,MX - do i=1,NB - AER(k,i) = 0.d0 - enddo - enddo -! -! Scale optical depths as appropriate - limit column to 'odmax' - odmax = 200.d0 - odsum = 0.d0 - do i=1,lpar - odcol(i) = dble(OD(nslon,nslat,i)) - odsum = odsum + odcol(i) - enddo - if(odsum.gt.odmax) then - odsum = odmax/odsum - do i=1,lpar - odcol(i) = odcol(i)*odsum - enddo - odsum = odmax - endif -! -! Use clear-sky conditions -! do i=1,jpnl -! odcol(i)=0.d0 -! enddo -! -! Set sub-division switch if appropriate - odtot=0.d0 - jadsub(nb)=0 - jadsub(nb-1)=0 - do i=nb-1,1,-1 - k=2*i - jadsub(k)=0 - jadsub(k-1)=0 - odtot=odtot+odcol(i) - if(odcol(i).gt.0.d0.and.dtausub.gt.0.d0) then - if(odtot.le.dtausub) then - jadsub(k)=1 - jadsub(k-1)=1 - elseif(odtot.gt.dtausub) then - jadsub(k)=1 - jadsub(k-1)=0 - do j=1,2*(i-1) - jadsub(j)=0 - enddo - go to 20 - endif - endif - enddo - 20 continue -! - return - end SUBROUTINE CLDSRF - - - subroutine solar2(timej) -!----------------------------------------------------------------------- -! Routine to set up SZA for given lat, lon and time -!----------------------------------------------------------------------- -! timej Offset in hours from start of timestep to time J-values -! required for - take as half timestep for mid-step Js. -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_jv_cmn.h" - real*8 pi, pi180, loct, timej - real*8 sindec, soldek, cosdec, sinlat, sollat, coslat, cosz -! - pi=3.141592653589793D0 - pi180=pi/180.d0 - !sindec=0.3978d0*sin(0.9863d0*(dble(iday)-80.d0)*pi180) - !soldek=asin(sindec) - !cosdec=cos(soldek) - !sinlat=sin(ygrd(nslat)) - !sollat=asin(sinlat) - !coslat=cos(sollat) -! - !loct = (((tau+timej)*15.d0)-180.d0)*pi180 + xgrd(nslon) - !cosz = cosdec*coslat*cos(loct) + sindec*sinlat - !sza = acos(cosz)/pi180 - U0 = cos(SZA*pi180) -! - return - end subroutine solar2 - - - subroutine rd_prof(nj2,namfil) -!----------------------------------------------------------------------- -! Routine to input T and O3 reference profiles -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer ia, i, m, l, lat, mon, ntlats, ntmons, n216, nj2 - real*8 ofac,ofak -!c character*11 namfil - character (len=128) :: namfil -! -!c open(NJ2,file=namfil) - call AsciiOpenRead (NJ2, namfil) - read(NJ2,'(A)') TITLE0 -!c write(6,'(1X,A)') TITLE0 - read(NJ2,'(2I5)') NTLATS,NTMONS -!c write(6,1000) NTLATS,NTMONS -!c N216 = MIN0(216, NTLATS*NTMONS) - N216 = MIN(216, NTLATS*NTMONS) - do IA=1,N216 - read(NJ2,'(1X,I3,3X,I2)') LAT, MON - M = MIN(12, MAX(1, MON)) - L = MIN(18, MAX(1, (LAT+95)/10)) - read(NJ2,'(3X,11F7.1)') (TREF(I,L,M), I=1,41) - read(NJ2,'(3X,11F7.4)') (OREF(I,L,M), I=1,31) - enddo - close(NJ2) -! -! Extend climatology to 100 km - ofac=exp(-2.d5/ZZHT) - do i=32,51 - ofak=ofac**(i-31) - do m=1,ntmons - do l=1,ntlats - oref(i,l,m)=oref(31,l,m)*ofak - enddo - enddo - enddo - do l=1,ntlats - do m=1,ntmons - do i=42,51 - tref(i,l,m)=tref(41,l,m) - enddo - enddo - enddo -! - return -!1000 format(1x,'Data: ',i3,' Lats x ',i2,' Months') - end subroutine rd_prof - - -!----------------------------------------------------------------------- - subroutine set_aer -!----------------------------------------------------------------------- -! Set aerosol/cloud types and define black carbon profile -!----------------------------------------------------------------------- -! MX Number of different types of aerosol to be considered -! MIEDX Index of aerosol types in jv_spec.dat - hardwire in here -! HISTORY -! January 5, 2004 - Jules Kouatchou -! Added more values to the array MIEDX (index 4 to 35) -! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer i -! -! Initialise aerosol index - do i=1,MX - MIEDX(i) = 0 - enddo -! -! Select Aerosol/Cloud types to be used - define types here - MIEDX(1) = 3 ! Black carbon absorber - MIEDX(2) = 10 ! Water Cloud (Deirmenjian 8 micron) - MIEDX(3) = 14 ! Irregular Ice Cloud (Mishchenko) -!!!! -!Beg: Bryan & Jules -!!!! - MIEDX(4) = 15 ! Mineral Dust .15 micron (rvm, 9/30/00) - MIEDX(5) = 16 ! Mineral Dust .25 micron (rvm, 9/30/00) - MIEDX(6) = 17 ! Mineral Dust .4 micron (rvm, 9/30/00) - MIEDX(7) = 18 ! Mineral Dust .8 micron (rvm, 9/30/00) - MIEDX(8) = 19 ! Mineral Dust 1.5 micron (rvm, 9/30/00) - MIEDX(9) = 20 ! Mineral Dust 2.5 micron (rvm, 9/30/00) - MIEDX(10) = 21 ! Mineral Dust 4.0 micron (rvm, 9/30/00) - MIEDX(11) = 22 ! Tropospheric Sulfate, RH=0 (rvm, bmy, 2/27/02) - MIEDX(12) = 23 ! Tropospheric Sulfate, RH=50 (rvm, bmy, 2/27/02) - MIEDX(13) = 24 ! Tropospheric Sulfate, RH=70 (rvm, bmy, 2/27/02) - MIEDX(14) = 25 ! Tropospheric Sulfate, RH=80 (rvm, bmy, 2/27/02) - MIEDX(15) = 26 ! Tropospheric Sulfate, RH=90 (rvm, bmy, 2/27/02) - MIEDX(16) = 29 ! Black Carbon, RH=0 (rvm, bmy, 2/27/02) - MIEDX(17) = 30 ! Black Carbon, RH=50 (rvm, bmy, 2/27/02) - MIEDX(18) = 31 ! Black Carbon, RH=70 (rvm, bmy, 2/27/02) - MIEDX(19) = 32 ! Black Carbon, RH=80 (rvm, bmy, 2/27/02) - MIEDX(20) = 33 ! Black Carbon, RH=90 (rvm, bmy, 2/27/02) - MIEDX(21) = 36 ! Organic Carbon, RH=0 (rvm, bmy, 2/27/02) - MIEDX(22) = 37 ! Organic Carbon, RH=50 (rvm, bmy, 2/27/02) - MIEDX(23) = 38 ! Organic Carbon, RH=70 (rvm, bmy, 2/27/02) - MIEDX(24) = 39 ! Organic Carbon, RH=80 (rvm, bmy, 2/27/02) - MIEDX(25) = 40 ! Organic Carbon, RH=90 (rvm, bmy, 2/27/02) - MIEDX(26) = 43 ! Sea Salt (accum), RH=0 (rvm, bmy, 2/27/02) - MIEDX(27) = 44 ! Sea Salt (accum), RH=50 (rvm, bmy, 2/27/02) - MIEDX(28) = 45 ! Sea Salt (accum), RH=70 (rvm, bmy, 2/27/02) - MIEDX(29) = 46 ! Sea Salt (accum), RH=80 (rvm, bmy, 2/27/02) - MIEDX(30) = 47 ! Sea Salt (accum), RH=90 (rvm, bmy, 2/27/02) - MIEDX(31) = 50 ! Sea Salt (coarse), RH=0 (rvm, bmy, 2/27/02) - MIEDX(32) = 51 ! Sea Salt (coarse), RH=50 (rvm, bmy, 2/27/02) - MIEDX(33) = 52 ! Sea Salt (coarse), RH=70 (rvm, bmy, 2/27/02) - MIEDX(34) = 53 ! Sea Salt (coarse), RH=80 (rvm, bmy, 2/27/02) - MIEDX(35) = 54 ! Sea Salt (coarse), RH=90 (rvm, bmy, 2/27/02) -!!!! -!End: Bryan & Jules -!!!! -! -! Ensure all 'MX' types are valid selections - do i=1,MX -!c write(6,1000) MIEDX(i),TITLEA(MIEDX(i)) - if(MIEDX(i).gt.NAA.or.MIEDX(i).le.0) then -!c write(6,1200) MIEDX(i),NAA - STOP "Fastj" - endif - enddo -! -! Approximate Black Carbon up to 10 km; surface 200 ng/m3 (Liousse et al) -! Scale: 1 ng/m3 = 1.0d-15 g/cm3 (1.0d-11 g/m2/cm as BREF is in cm)) -! -! Simple place-holder profile - do i=1,51 - BREF(i)=10.d0*1.0d-11 - if(i.gt.6) BREF(i)=0.d0 - enddo -! - return -!1000 format('Using Aerosol type: ',i2,1x,a) -!1200 format('Aerosol type ',i1,' unsuitable; supplied values must be ', -! $ 'between 1 and ',i1) - end subroutine set_aer - - - SUBROUTINE JRATET(SOLF) -!----------------------------------------------------------------------- -! Calculate and print J-values. Note that the loop in this routine -! only covers the jpnl levels actually needed by the CTM. -!----------------------------------------------------------------------- -! -! FFF Actinic flux at each level for each wavelength bin -! QQQ Cross sections for species (read in in RD_TJPL) -! SOLF Solar distance factor, for scaling; normally given by: -! 1.0-(0.034*cos(real(iday-186)*2.0*pi/365.)) -! Assumes aphelion day 186, perihelion day 3. -! TQQ Temperatures at which QQQ cross sections supplied -! -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_cmn_w.h" -# include "fastj_jv_cmn.h" -# include "gmi_phys_constants.h" - - integer L ! Added for pressure-dependence {PJC} - integer i, j, k - real*8 qo2tot, qo3tot, qo31d, qo33p, qqqt -! real*8 xseco2, xseco3, xsec1d, solf, tfact - real*8 solf, tfact -! - do I=1,jpnl - VALJ(1) = 0.d0 - VALJ(2) = 0.d0 - VALJ(3) = 0.d0 - do K=NW1,NW2 ! Using model 'T's here - QO2TOT= XSECO2(K,dble(T(nslon,nslat,I))) - VALJ(1) = VALJ(1) + QO2TOT*FFF(K,I) - QO3TOT= XSECO3(K,dble(T(nslon,nslat,I))) - QO31D = XSEC1D(K,dble(T(nslon,nslat,I)))*QO3TOT - QO33P = QO3TOT - QO31D - VALJ(2) = VALJ(2) + QO33P*FFF(K,I) - VALJ(3) = VALJ(3) + QO31D*FFF(K,I) - enddo -!------Calculate remaining J-values with T-dep X-sections - do J=4,NJVAL - VALJ(J) = 0.d0 - TFACT = 0.d0 - L = jpdep(J) ! Added to implement Pressure-Dependence {PJC} - if(TQQ(2,J).gt.TQQ(1,J)) TFACT = max(0.d0,min(1.d0, & - & (T(nslon,nslat,I)-TQQ(1,J))/(TQQ(2,J)-TQQ(1,J)) )) - do K=NW1,NW2 - QQQT = QQQ(K,1,J-3) + (QQQ(K,2,J-3) - QQQ(K,1,J-3))*TFACT - if(L.eq.0) then - VALJ(J) = VALJ(J) + QQQT*FFF(K,I) - else -!---------------------------------------------------------------------- -! Prior to 9/17/99 -! Original form for acetaldehyde P-dep -- believed to be incorrect (pjc) -! VALJ(J) = VALJ(J) + QQQT*FFF(K,I)* -! $ (1.d0+zpdep(K,L)*(pj(i)+pj(i+1))*0.5d0) -!---------------------------------------------------------------------- -! Essentially the change is the replacement of the factor -! -! (1 + a P) with 1 -! --------------------- -! (1 + b density) -! -! where a and b are constants, P is pressure, and density is the -! density of air in molec-cm(-3) (pjc, 9/17/99) -!---------------------------------------------------------------------- - VALJ(J)=VALJ(J)+QQQT*FFF(K,I)/(1 + & - & ( zpdep(K,L)*AVOGAD*1d-6 / & - & (GAS_CONST_J*T(nslon,nslat,I))) * & - & (pj(i)+pj(i+1))*0.5d0*1d2 ) - - endif -!c------Additional code for pressure dependencies (Fast-J v3) -!c if(jpdep(J).ne.0) then -!c VALJ(J) = VALJ(J) + QQQT*FFF(K,I)* -!c $ (zpdep(K,L)*(pj(i)+pj(i+1))*0.5d0) -!c endif - enddo - enddo - do j=1,jppj - zj(i,j)=VALJ(jind(j))*jfacta(j)*SOLF - enddo -! Herzberg bin - do j=1,nhz - zj(i,hzind(j))=hztoa(j)*fhz(i)*SOLF - enddo -!c write(6,'(I5,1P,7E10.3/(5X,7E10.3))') I, (VALJ(J), J=1,NJVAL) - enddo - return - end SUBROUTINE JRATET - - - SUBROUTINE RD_TJPL(NJ1,NAMFIL) -!----------------------------------------------------------------------- -! Read in wavelength bins, solar fluxes, Rayleigh parameters, temperature- -! dependent cross sections and Rayleigh/aerosol scattering phase functions -! with temperature dependences. Current data originates from JPL'97 -!----------------------------------------------------------------------- -! -! NAMFIL Name of spectral data file (jv_spec.dat) -! NJ1 Channel number for reading data file -! NJVAL Number of species to calculate J-values for -! NWWW Number of wavelength bins, from NW1:NW2 -! WBIN Boundaries of wavelength bins -! WL Centres of wavelength bins - 'effective wavelengh' -! FL Solar flux incident on top of atmosphere (cm-2.s-1) -! QRAYL Rayleigh parameters (effective cross-section) (cm2) -! QBC Black Carbon absorption extinct. (specific cross-sect.) (m2/g) -! QO2 O2 cross-sections -! QO3 O3 cross-sections -! Q1D O3 => O(1D) quantum yield -! TQQ Temperature for supplied cross sections -! QQQ Supplied cross sections in each wavelength bin (cm2) -! NAA Number of categories for scattering phase functions -! QAA Aerosol scattering phase functions -! NK Number of wavelengths at which functions supplied (set as 4) -! WAA Wavelengths for the NK supplied phase functions -! PAA Phase function: first 8 terms of expansion -! RAA Effective radius associated with aerosol type -! SSA Single scattering albedo -! -! npdep Number of pressure dependencies -! zpdep Pressure dependencies by wavelength bin -! jpdep Index of cross sections requiring pressure dependence -! lpdep Label for pressure dependence -! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer i, j, k, iw, nk, nqqq, nwww, nj1 - character*7 lpdep(3) -!c character*11 NAMFIL - character (len=128) namfil - REAL*8 hztmp(nh) - do J=1,NS - do K=1,3 - TQQ(K,J) = 0.d0 - enddo - enddo -!-------------spectral data--------------------------------------------- -!c open(NJ1, FILE=NAMFIL) - call AsciiOpenRead (NJ1, NAMFIL) - read(NJ1,'(A)') TITLE0 -!c write(6,'(1X,A)') TITLE0 - read(NJ1,'(10X,14I5)') NJVAL,NWWW,NW1,NW2 - if(NJVAL.gt.NS) then -!c write(6,300) NJVAL,NS - STOP "Fastj" - endif -!------------NQQQ = no. additional J-values from X-sects (O2,O3P,O3D+NQQQ) - NQQQ = NJVAL-3 - read(NJ1,102) (WBIN(IW),IW=1,NWWW) - read(NJ1,102) (WBIN(IW+1),IW=1,NWWW) - read(NJ1,102) (WL(IW),IW=1,NWWW) - read(NJ1,102) (FL(IW),IW=1,NWWW) - read(NJ1,102) (QRAYL(IW),IW=1,NWWW) - read(NJ1,102) (QBC(IW),IW=1,NWWW) ! From Loiusse et al. [JGR, 1996] -! -!---Read O2 X-sects, O3 X-sects, O3=>O(1D) quant yields (each at 3 temps) - do K=1,3 - read(NJ1,103) TITLEJ(K,1),TQQ(K,1), (QO2(IW,K),IW=1,NWWW) - enddo - do K=1,3 - read(NJ1,103) TITLEJ(K,2),TQQ(K,2), (QO3(IW,K),IW=1,NWWW) - enddo - do K=1,3 - read(NJ1,103) TITLEJ(K,3),TQQ(K,3), (Q1D(IW,K),IW=1,NWWW) - enddo - do K=1,3 -!c write(6,200) titlej(1,k),(tqq(i,k),i=1,3) - enddo -! -!---Read remaining species: X-sections at 2 T's - do J=1,NQQQ - read(NJ1,103) TITLEJ(1,J+3),TQQ(1,J+3),(QQQ(IW,1,J),IW=1,NWWW) - read(NJ1,103) TITLEJ(2,J+3),TQQ(2,J+3),(QQQ(IW,2,J),IW=1,NWWW) -!c write(6,200) titlej(1,j+3),(tqq(i,j+3),i=1,2) - enddo - read(NJ1,'(A)') TITLE0 -! - npdep=0 -!---Pressure dependencies - see utils/pdep if required - read(NJ1,104) npdep - do k=1,npdep - read(NJ1,105) lpdep(k),(zpdep(iw,k),iw=1,nwww) -!c write(6,201) lpdep(k),(zpdep(iw,k),iw=1,nwww) - enddo - read(NJ1,'(A)') TITLE0 - -!---Read aerosol phase functions: - read(NJ1,'(A10,I5,/)') TITLE0,NAA - if(NAA.gt.NP) then -!c write(6,350) NAA - STOP "Fastj" - endif - NK=4 ! Fix number of wavelengths at 4 - do j=1,NAA - read(NJ1,110) TITLEA(j) - do k=1,NK - read(NJ1,*) WAA(k,j),QAA(k,j),RAA(k,j),SSA(k,j), & - & (PAA(i,k,j),i=1,8) - enddo - enddo -! -!c write(6,*) 'Aerosol phase functions & wavelengths' - do J=1,NAA -!c write(6,'(1x,A8,I2,A,9F8.1)') -!c $ TITLEA(J),J,' wavel=',(WAA(K,J),K=1,NK) -!c write(6,'(9x,I2,A,9F8.4)') J,' Qext =',(QAA(K,J),K=1,NK) - enddo -! -!---Read Herzberg section, if required - read(NJ1,'(/)') - read(NJ1,104) NHZ - read(NJ1,102) HZO2 - read(NJ1,102) HZO3 - read(NJ1,102) QRAYL(NWWW+1) - do J=1,NHZ - read(NJ1,'(a6,4x,E10.3)') hzlab(j),hztmp(j) - enddo -! -!---Zero index arrays - do j=1,jppj - jind(j)=0 - enddo - do j=1,NJVAL - jpdep(j)=0 - enddo - do j=1,nh - hzind(j)=0 - enddo - -! -!---Set mapping index - do j=1,NJVAL - do k=1,jppj - if(jlabel(k).eq.titlej(1,j)) jind(k)=j - enddo - do k=1,npdep - if(lpdep(k).eq.titlej(1,j)) jpdep(j)=k - enddo - enddo - do k=1,jppj -!c if(jfacta(k).eq.0.d0) -!c & write(6,*) 'Not using photolysis reaction ',k - if(jind(k).eq.0) then - if(jfacta(k).eq.0.d0) then - jind(k)=1 - else -!c write(6,*) 'Which J-rate for photolysis reaction ',k,' ?' - STOP "Fastj" - endif - endif - enddo -! Herzberg index - i=0 - do j=1,nhz - do k=1,jppj - if(jlabel(k).eq.hzlab(j)) then - i=i+1 - hzind(i)=k - hztoa(i)=hztmp(j)*jfacta(k) - endif - enddo - enddo - nhz=i - if(nhz.eq.0) then -!c write(6,400) - else -!c write(6,420) (jlabel(hzind(i)),i=1,nhz) - endif -! -!-------- -!c101 FORMAT(8E10.3) - 102 FORMAT(10X,7E10.3) - 103 FORMAT(A7,F3.0,7E10.3) -!c103 FORMAT(A7,F3.0,7E10.3/(10X,7E10.3)) - 104 FORMAT(13x,i2) - 105 FORMAT(A7,3x,7E10.3) - 110 format(3x,a20) -!c200 format(1x,' x-sect:',a10,3(3x,f6.2)) -!c201 format(1x,' pr.dep:',a10,7(1pE10.3)) -!c300 format(' Number of x-sections supplied to Fast-J: ',i3,/, -!c & ' Maximum number allowed (NS) only set to: ',i3, -!c & ' - increase in jv_cmn.h') -!c350 format(' Too many phase functions supplied; increase NP to ',i2) -!c400 format(' Not using Herzberg bin') -!c420 format(' Using Herzberg bin for: ',10a7) - close(NJ1) - return - end SUBROUTINE RD_TJPL - - - SUBROUTINE PRTATM(N) -!----------------------------------------------------------------------- -! Print out the atmosphere and calculate appropriate columns -! N=1 Print out column totals only -! N=2 Print out full columns -! N=3 Print out full columns and climatology -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_jv_cmn.h" - integer n, i, k, l, m - real*8 COLO3(NB),COLO2(NB),COLAX(MX,NB),PJC - real*8 ZKM,ZSTAR ! Modified to make Flint happy {PJC} - real*8 climat(9),masfac,dlogp - if(N.eq.0) return -!---Calculate columns, for diagnostic output only: - COLO3(NB) = DO3(NB) - COLO2(NB) = DM(NB)*0.20948d0 - do K=1,MX - COLAX(K,NB) = AER(K,NB) - enddo - do I=NB-1,1,-1 - COLO3(i) = COLO3(i+1)+DO3(i) - COLO2(i) = COLO2(i+1)+DM(i)*0.20948d0 - do K=1,MX - COLAX(k,i) = COLAX(k,i+1)+AER(k,i) - enddo - enddo - write(6,1200) ' Tau=',tau,' SZA=',sza - write(6,1200) ' O3-column(DU)=',COLO3(1)/2.687d16, & - & ' column aerosol @1000nm=',(COLAX(K,1),K=1,MX) -!---Print out atmosphere - if(N.gt.1) then - write(6,1000) (' AER-X ','col-AER',k=1,mx) - do I=NB,1,-1 - PJC= PJ(I) - ZKM =1.d-5*Z(I) ! For diagnostics only {PJC} - ZSTAR = 16.d0*LOG10(1000.d0/PJC) ! For diagnostics only {PJC} - write(6,1100) I,ZKM,ZSTAR,DM(I),DO3(I),1.d6*DO3(I)/DM(I), & - & TJ(I),PJC,COLO3(I),COLO2(I),(AER(K,I),COLAX(K,I),K=1,MX) - enddo - endif -! -!---Print out climatology - if(N.gt.2) then - do i=1,9 - climat(i)=0.d0 - enddo - m = max(1,min(12,month)) - l = max(1,min(18,(int(ydgrd(nslat))+99)/10)) - masfac=100.d0*6.022d+23/(28.97d0*9.8d0*10.d0) - write(6,*) 'Specified Climatology' - write(6,1000) - do i=51,1,-1 - dlogp=10.d0**(-1.d0/16.d0) - PJC = 1000.d0*dlogp**(2*i-2) - climat(1) = 16.d0*LOG10(1000.D0/PJC) - climat(2) = climat(1) - climat(3) = PJC*(1.d0/dlogp-dlogp)*masfac - if(i.eq.1) climat(3)=PJC*(1.d0-dlogp)*masfac - climat(4)=climat(3)*oref(i,l,m)*1.d-6 - climat(5)=oref(i,l,m) - climat(6)=tref(i,l,m) - climat(7)=PJC - climat(8)=climat(8)+climat(4) - climat(9)=climat(9)+climat(3)*0.20948d0 - write(6,1100) I,(climat(k),k=1,9) - enddo - write(6,1200) ' O3-column(DU)=',climat(8)/2.687d16 - endif - return - 1000 format(5X,'Zkm',3X,'Z*',8X,'M',8X,'O3',6X,'f-O3',5X,'T',7X,'P',6x, & - & 'col-O3',3X,'col-O2',2X,10(a7,2x)) - 1100 format(1X,I2,0P,2F6.2,1P,2E10.3,0P,F7.3,F8.2,F10.4,1P,10E9.2) - 1200 format(A,F8.1,A,10(1pE10.3)) - end SUBROUTINE PRTATM - - SUBROUTINE JVALUE -!----------------------------------------------------------------------- -! Calculate the actinic flux at each level for the current SZA value. -! quit when SZA > 98.0 deg ==> tangent height = 63 km -! or 99. 80 km -!----------------------------------------------------------------------- -! -! AVGF Attenuation of beam at each level for each wavelength -! FFF Actinic flux at each desired level -! FHZ Actinic flux in Herzberg bin -! WAVE Effective wavelength of each wavelength bin -! XQO2 Absorption cross-section of O2 -! XQO3 Absorption cross-section of O3 -! -!----------------------------------------------------------------------- -# include "gmi_AerDust_const.h" -# include "setkin_par.h" -# include "fastj_cmn_h.h" -# include "fastj_cmn_t.h" -# include "fastj_cmn_w.h" -# include "fastj_jv_cmn.h" - integer j, k -! real*8 wave, xseco3, xseco2 - real*8 wave - real*8 AVGF(lpar),XQO3(NB),XQO2(NB) -! - do J=1,jpnl - do K=NW1,NW2 - FFF(K,J) = 0.d0 - enddo - FHZ(J) = 0.d0 - enddo -! -!---SZA check -! write(6,1000) SZA, RFLECT, (OD(nslon,nslat,j),j=1,lpar) - if(SZA.gt.szamax) GOTO 99 -! -!---Calculate spherical weighting functions - CALL SPHERE -! -!---Loop over all wavelength bins - do K=NW1,NW2 - WAVE = WL(K) - do J=1,NB - XQO3(J) = XSECO3(K,dble(TJ(J))) - enddo - do J=1,NB - XQO2(J) = XSECO2(K,dble(TJ(J))) - enddo -!----------------------------------------- - CALL OPMIE(K,WAVE,XQO2,XQO3,AVGF) -!----------------------------------------- - do J=1,jpnl - FFF(K,J) = FFF(K,J) + FL(K)*AVGF(J) - enddo - enddo -! -!---Herzberg continuum bin above 10 km, if required - if(NHZ.gt.0) then - K=NW2+1 - WAVE = 204.d0 - do J=1,NB - XQO3(J) = HZO3 - XQO2(J) = HZO2 - enddo - CALL OPMIE(K,WAVE,XQO2,XQO3,AVGF) - do J=1,jpnl - if(z(j).gt.1.d6) FHZ(J)=AVGF(J) - enddo - endif -! - 99 continue -!1000 format(' SZA=',f6.1,' Reflectvty=',f6.3,' OD=',10(1pe10.3)) - return - end SUBROUTINE JVALUE - - FUNCTION XSECO3(K,TTT) -!----------------------------------------------------------------------- -! Cross-sections for O3 for all processes interpolated across 3 temps -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer k -! real*8 ttt, flint, xseco3 - real*8 ttt, xseco3 - XSECO3 = & - & FLINT(TTT,TQQ(1,2),TQQ(2,2),TQQ(3,2),QO3(K,1),QO3(K,2),QO3(K,3)) - return - end FUNCTION XSECO3 - - FUNCTION XSEC1D(K,TTT) -!----------------------------------------------------------------------- -! Quantum yields for O3 --> O2 + O(1D) interpolated across 3 temps -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer k -! real*8 ttt, flint, xsec1d - real*8 ttt, xsec1d - XSEC1D = & - & FLINT(TTT,TQQ(1,3),TQQ(2,3),TQQ(3,3),Q1D(K,1),Q1D(K,2),Q1D(K,3)) - return - end FUNCTION XSEC1D - - FUNCTION XSECO2(K,TTT) -!----------------------------------------------------------------------- -! Cross-sections for O2 interpolated across 3 temps; No S_R Bands yet! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer k -! real*8 ttt, flint, xseco2 - real*8 ttt, xseco2 - XSECO2 = & - & FLINT(TTT,TQQ(1,1),TQQ(2,1),TQQ(3,1),QO2(K,1),QO2(K,2),QO2(K,3)) - return - end FUNCTION XSECO2 - - REAL*8 FUNCTION FLINT (TINT,T1,T2,T3,F1,F2,F3) -!----------------------------------------------------------------------- -! Three-point linear interpolation function -!----------------------------------------------------------------------- - real*8 TINT,T1,T2,T3,F1,F2,F3 - IF (TINT .LE. T2) THEN - IF (TINT .LE. T1) THEN - FLINT = F1 - ELSE - FLINT = F1 + (F2 - F1)*(TINT -T1)/(T2 -T1) - ENDIF - ELSE - IF (TINT .GE. T3) THEN - FLINT = F3 - ELSE - FLINT = F2 + (F3 - F2)*(TINT -T2)/(T3 -T2) - ENDIF - ENDIF - return - end FUNCTION FLINT - - SUBROUTINE SPHERE -!----------------------------------------------------------------------- -! Calculation of spherical geometry; derive tangent heights, slant path -! lengths and air mass factor for each layer. Not called when -! SZA > 98 degrees. Beyond 90 degrees, include treatment of emergent -! beam (where tangent height is below altitude J-value desired at). -!----------------------------------------------------------------------- -! -! GMU MU, cos(solar zenith angle) -! RZ Distance from centre of Earth to each point (cm) -! RQ Square of radius ratios -! TANHT Tangent height for the current SZA -! XL Slant path between points -! AMF Air mass factor for slab between level and level above -! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" - integer i, j, k, ii - real*8 airmas, gmu, xmu1, xmu2, xl, diff - REAL*8 Ux,H,RZ(NB),RQ(NB),ZBYR -! -! Inlined air mass factor function for top of atmosphere - AIRMAS(Ux,H) = (1.0d0+H)/SQRT(Ux*Ux+2.0d0*H*(1.0d0- & - & 0.6817d0*EXP(-57.3d0*ABS(Ux)/SQRT(1.0d0+5500.d0*H))/ & - & (1.0d0+0.625d0*H))) -! - GMU = U0 - RZ(1)=RAD+Z(1) - ZBYR = ZZHT/RAD - DO 2 II=2,NB - RZ(II) = RAD + Z(II) - RQ(II-1) = (RZ(II-1)/RZ(II))**2 - 2 CONTINUE - IF (GMU.LT.0.0D0) THEN - TANHT = RZ(nlbatm)/SQRT(1.0D0-GMU**2) - ELSE - TANHT = RZ(nlbatm) - ENDIF -! -! Go up from the surface calculating the slant paths between each level -! and the level above, and deriving the appropriate Air Mass Factor - DO 16 J=1,NB - DO K=1,NB - AMF(K,J)=0.D0 - ENDDO -! -! Air Mass Factors all zero if below the tangent height - IF (RZ(J).LT.TANHT) GOTO 16 -! Ascend from layer J calculating AMFs - XMU1=ABS(GMU) - DO 12 I=J,lpar - XMU2=SQRT(1.0D0-RQ(I)*(1.0D0-XMU1**2)) - XL=RZ(I+1)*XMU2-RZ(I)*XMU1 - AMF(I,J)=XL/(RZ(I+1)-RZ(I)) - XMU1=XMU2 - 12 CONTINUE -! Use function and scale height to provide AMF above top of model - AMF(NB,J)=AIRMAS(XMU1,ZBYR) -! -! Twilight case - Emergent Beam - IF (GMU.GE.0.0D0) GOTO 16 - XMU1=ABS(GMU) -! Descend from layer J - DO 14 II=J-1,1,-1 - DIFF=RZ(II+1)*SQRT(1.0D0-XMU1**2)-RZ(II) - if(II.eq.1) DIFF=max(DIFF,0.d0) ! filter -! Tangent height below current level - beam passes through twice - IF (DIFF.LT.0.0D0) THEN - XMU2=SQRT(1.0D0-(1.0D0-XMU1**2)/RQ(II)) - XL=ABS(RZ(II+1)*XMU1-RZ(II)*XMU2) - AMF(II,J)=2.d0*XL/(RZ(II+1)-RZ(II)) - XMU1=XMU2 -! Lowest level intersected by emergent beam - ELSE - XL=RZ(II+1)*XMU1*2.0D0 -! WTING=DIFF/(RZ(II+1)-RZ(II)) -! AMF(II,J)=(1.0D0-WTING)*2.D0**XL/(RZ(II+1)-RZ(II)) - AMF(II,J)=XL/(RZ(II+1)-RZ(II)) - GOTO 16 - ENDIF - 14 CONTINUE -! - 16 CONTINUE - RETURN - END SUBROUTINE SPHERE - - - SUBROUTINE OPMIE(KW,WAVEL,XQO2,XQO3,FMEAN) -!----------------------------------------------------------------------- -! NEW Mie code for J's, only uses 8-term expansion, 4-Gauss pts -! Currently allow up to NP aerosol phase functions (at all altitudes) to -! be associated with optical depth AER(1:NC) = aerosol opt.depth @ 1000 nm -! -! Pick Mie-wavelength with phase function and Qext: -! -! 01 RAYLE = Rayleigh phase -! 02 ISOTR = isotropic -! 03 ABSRB = fully absorbing 'soot', wavelength indep. -! 04 S_Bkg = backgrnd stratospheric sulfate (n=1.46,log-norm:r=.09um/sigma=.6) -! 05 S_Vol = volcanic stratospheric sulfate (n=1.46,log-norm:r=.08um/sigma=.8) -! 06 W_H01 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.1um /alpha=2) -! 07 W_H04 = water haze (H1/Deirm.) (n=1.335, gamma: r-mode=0.4um /alpha=2) -! 08 W_C02 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=2.0um /alpha=6) -! 09 W_C04 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=4.0um /alpha=6) -! 10 W_C08 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=8.0um /alpha=6) -! 11 W_C13 = water cloud (C1/Deirm.) (n=1.335, gamma: r-mode=13.3um /alpha=6) -! 12 W_L06 = water cloud (Lacis) (n=1.335, r-mode=5.5um / alpha=11/3) -! 13 Ice-H = hexagonal ice cloud (Mishchenko) -! 14 Ice-I = irregular ice cloud (Mishchenko) -! -! Choice of aerosol index MIEDX is made in SET_AER; optical depths are -! apportioned to the AER array in SET_PROF -! -!----------------------------------------------------------------------- -! FUNCTION RAYLAY(WAVE)---RAYLEIGH CROSS-SECTION for wave > 170 nm -! WSQI = 1.E6/(WAVE*WAVE) -! REFRM1 = 1.0E-6*(64.328+29498.1/(146.-WSQI)+255.4/(41.-WSQI)) -! RAYLAY = 5.40E-21*(REFRM1*WSQI)**2 -!----------------------------------------------------------------------- -! -! DTAUX Local optical depth of each CTM level -! PIRAY Contribution of Rayleigh scattering to extinction -! PIAER Contribution of Aerosol scattering to extinction -! TTAU Optical depth of air vertically above each point (to top of atm) -! FTAU Attenuation of solar beam -! POMEGA Scattering phase function -! FMEAN Mean actinic flux at desired levels -! -!----------------------------------------------------------------------- -# include "fastj_cmn_h.h" -# include "fastj_jv_cmn.h" -# include "fastj_jv_mie.h" - integer jndlev(lpar),jaddlv(nc),jaddto(nc+1) - integer KW,km,i,j,k,l,ix,j1 - real*8 QXMIE(MX),XLAER(MX),SSALB(MX) - real*8 xlo2,xlo3,xlray,xltau,zk,taudn,tauup,zk2 - real*8 WAVEL,XQO2(NB),XQO3(NB),FMEAN(lpar),POMEGAJ(2*M__,NC+1) - real*8 DTAUX(NB),PIRAY(NB),PIAER(MX,NB),TTAU(NC+1),FTAU(NC+1) - real*8 ftaulog,dttau,dpomega(2*M__) - real*8 ftaulog2,dttau2,dpomega2(2*M__) -! -!---Pick nearest Mie wavelength, no interpolation-------------- - KM=1 - if( WAVEL .gt. 355.d0 ) KM=2 - if( WAVEL .gt. 500.d0 ) KM=3 -! if( WAVEL .gt. 800.d0 ) KM=4 !drop the 1000 nm wavelength -! -!---For Mie code scale extinction at 1000 nm to wavelength WAVEL (QXMIE) - do I=1,MX - QXMIE(I) = QAA(KM,MIEDX(I))/QAA(4,MIEDX(I)) - SSALB(I) = SSA(KM,MIEDX(I)) - enddo -! -!---Reinitialize arrays - do j=1,nc+1 - ttau(j)=0.d0 - ftau(j)=0.d0 - enddo -! -!---Set up total optical depth over each CTM level, DTAUX - J1 = NLBATM - do J=J1,NB - XLO3=DO3(J)*XQO3(J) - XLO2=DM(J)*XQO2(J)*0.20948d0 - XLRAY=DM(J)*QRAYL(KW) -! Zero absorption for testing purposes -! call NOABS(XLO3,XLO2,XLRAY,AER(1,j),RFLECT) - do I=1,MX - XLAER(I)=AER(I,J)*QXMIE(I) - enddo -! Total optical depth from all elements - DTAUX(J)=XLO3+XLO2+XLRAY - do I=1,MX - DTAUX(J)=DTAUX(J)+XLAER(I) - enddo -! Fractional extinction for Rayleigh scattering and each aerosol type - PIRAY(J)=XLRAY/DTAUX(J) - do I=1,MX - PIAER(I,J)=SSALB(I)*XLAER(I)/DTAUX(J) - enddo - enddo -! -!---Define the scattering phase fn. with mix of Rayleigh(1) & Mie(MIEDX) -! No. of quadrature pts fixed at 4 (M__), expansion of phase fn @ 8 - N = M__ - MFIT = 2*M__ - do j=j1,NB - do i=1,MFIT - pomegaj(i,j) = PIRAY(J)*PAA(I,KM,1) - do k=1,MX - pomegaj(i,j) = pomegaj(i,j) + PIAER(K,J)*PAA(I,KM,MIEDX(K)) - enddo - enddo - enddo -! -!---Calculate attenuated incident beam EXP(-TTAU/U0) and flux on surface - do J=J1,NB - if(AMF(J,J).gt.0.0D0) then - XLTAU=0.0D0 - do I=1,NB - XLTAU=XLTAU + DTAUX(I)*AMF(I,J) - enddo - if(XLTAU.gt.450.d0) then ! for compilers with no underflow trapping - FTAU(j)=0.d0 - else - FTAU(J)=EXP(-XLTAU) - endif - else - FTAU(J)=0.0D0 - endif - enddo - if(U0.gt.0.D0) then - -! NOTE: Apply U0 to the diffuse UV/Vis albedo (ALBVF) from GEOS-5 -!---------------------------------------------------------------- - ZFLUX = U0*FTAU(J1)*RFLECT/(1.d0+RFLECT) - - else - ZFLUX = 0.d0 - endif -! -!------------------------------------------------------------------------ -! Take optical properties on CTM layers and convert to a photolysis -! level grid corresponding to layer centres and boundaries. This is -! required so that J-values can be calculated for the centre of CTM -! layers; the index of these layers is kept in the jndlev array. -!------------------------------------------------------------------------ -! -! Set lower boundary and levels to calculate J-values at - J1=2*J1-1 - do j=1,lpar - jndlev(j)=2*j - enddo -! -! Calculate column optical depths above each level, TTAU - TTAU(NC+1)=0.0D0 - do J=NC,J1,-1 - I=(J+1)/2 - TTAU(J)=TTAU(J+1) + 0.5d0*DTAUX(I) - jaddlv(j)=int(0.5d0*DTAUX(I)/dtaumax) -! Subdivide cloud-top levels if required - if(jadsub(j).gt.0) then - jadsub(j)=min(jaddlv(j)+1,nint(dtausub))*(nint(dsubdiv)-1) - jaddlv(j)=jaddlv(j)+jadsub(j) - endif - enddo -! -! Calculate attenuated beam, FTAU, level boundaries then level centres - FTAU(NC+1)=1.0D0 - do J=NC-1,J1,-2 - I=(J+1)/2 - FTAU(J)=FTAU(I) - enddo - do J=NC,J1,-2 - FTAU(J)=sqrt(FTAU(J+1)*FTAU(J-1)) - enddo -! -! Calculate scattering properties, level centres then level boundaries -! using an inverse interpolation to give correctly-weighted values - do j=NC,J1,-2 - do i=1,MFIT - pomegaj(i,j) = pomegaj(i,j/2) - enddo - enddo - do j=J1+2,nc,2 - taudn = ttau(j-1)-ttau(j) - tauup = ttau(j)-ttau(j+1) - do i=1,MFIT - pomegaj(i,j) = (pomegaj(i,j-1)*taudn + & - & pomegaj(i,j+1)*tauup) / (taudn+tauup) - enddo - enddo -! Define lower and upper boundaries - do i=1,MFIT - pomegaj(i,J1) = pomegaj(i,J1+1) - pomegaj(i,nc+1) = pomegaj(i,nc) - enddo -! -!------------------------------------------------------------------------ -! Calculate cumulative total and define levels we want J-values at. -! Sum upwards for levels, and then downwards for Mie code readjustments. -! -! jaddlv(i) Number of new levels to add between (i) and (i+1) -! jaddto(i) Total number of new levels to add to and above level (i) -! jndlev(j) Level needed for J-value for CTM layer (j) -! -!------------------------------------------------------------------------ -! -! Reinitialize level arrays - do j=1,nc+1 - jaddto(j)=0 - enddo -! - jaddto(J1)=jaddlv(J1) - do j=J1+1,nc - jaddto(j)=jaddto(j-1)+jaddlv(j) - enddo - if((jaddto(nc)+nc).gt.nl) then - write(6,1500) jaddto(nc)+nc, 'NL',NL - write(6,*) xgrd(1),ygrd(1) - STOP "Fastj" - endif -! write(6,1300) jndlev -! write(6,1300) jaddto - do i=1,lpar - jndlev(i)=jndlev(i)+jaddto(jndlev(i)-1) - enddo - jaddto(nc)=jaddlv(nc) - do j=nc-1,J1,-1 - jaddto(j)=jaddto(j+1)+jaddlv(j) - enddo -! write(6,1300) jndlev -! write(6,1300) jaddto -! -!---------------------SET UP FOR MIE CODE------------------------------- -! -! Transpose the ascending TTAU grid to a descending ZTAU grid. -! Double the resolution - TTAU points become the odd points on the -! ZTAU grid, even points needed for asymm phase fn soln, contain 'h'. -! Odd point added at top of grid for unattenuated beam (Z='inf') -! -! Surface: TTAU(1) now use ZTAU(2*NC+1) -! Top: TTAU(NC) now use ZTAU(3) -! Infinity: now use ZTAU(1) -! -! Mie scattering code only used from surface to level NC -!------------------------------------------------------------------------ -! -! Initialise all Fast-J optical property arrays - do k=1,N__ - do i=1,MFIT - pomega(i,k) = 0.d0 - enddo - ztau(k) = 0.d0 - fz(k) = 0.d0 - enddo -! -! Ascend through atmosphere transposing grid and adding extra points - do j=J1,nc+1 - k = 2*(nc+1-j)+2*jaddto(j)+1 - ztau(k)= ttau(j) - fz(k) = ftau(j) - do i=1,MFIT - pomega(i,k) = pomegaj(i,j) - enddo - enddo -! -! Check profiles if desired -! ND = 2*(NC+jaddto(J1)-J1) + 3 -! if(kw.eq.1) call CH_PROF -! -!------------------------------------------------------------------------ -! Insert new levels, working downwards from the top of the atmosphere -! to the surface (down in 'j', up in 'k'). This allows ztau and pomega -! to be incremented linearly (in a +ve sense), and the flux fz to be -! attenuated top-down (avoiding problems where lower level fluxes are -! zero). -! -! zk fractional increment in level -! dttau change in ttau per increment (linear, positive) -! dpomega change in pomega per increment (linear) -! ftaulog change in ftau per increment (exponential, normally < 1) -! -!------------------------------------------------------------------------ -! - do j=nc,J1,-1 - zk = 0.5d0/(1.d0+dble(jaddlv(j)-jadsub(j))) - dttau = (ttau(j)-ttau(j+1))*zk - do i=1,MFIT - dpomega(i) = (pomegaj(i,j)-pomegaj(i,j+1))*zk - enddo -! Filter attenuation factor - set minimum at 1.0d-05 - if(ftau(j+1).eq.0.d0) then - ftaulog=0.d0 - else - ftaulog = ftau(j)/ftau(j+1) - if(ftaulog.lt.1.d-150) then - ftaulog=1.0d-05 - else - ftaulog=exp(log(ftaulog)*zk) - endif - endif - k = 2*(nc-j+jaddto(j)-jaddlv(j))+1 ! k at level j+1 - l = 0 -! Additional subdivision of first level if required - if(jadsub(j).ne.0) then - l=jadsub(j)/nint(dsubdiv-1) - zk2=1.d0/dsubdiv - dttau2=dttau*zk2 - ftaulog2=ftaulog**zk2 - do i=1,MFIT - dpomega2(i)=dpomega(i)*zk2 - enddo - do ix=1,2*(jadsub(j)+l) - ztau(k+1) = ztau(k) + dttau2 - fz(k+1) = fz(k)*ftaulog2 - do i=1,MFIT - pomega(i,k+1) = pomega(i,k) + dpomega2(i) - enddo - k = k+1 - enddo - endif - l = 2*(jaddlv(j)-jadsub(j)-l)+1 -! -! Add values at all intermediate levels - do ix=1,l - ztau(k+1) = ztau(k) + dttau - fz(k+1) = fz(k)*ftaulog - do i=1,MFIT - pomega(i,k+1) = pomega(i,k) + dpomega(i) - enddo - k = k+1 - enddo -! -! Alternate method to attenuate fluxes, fz, using 2nd-order finite -! difference scheme - just need to comment in section below -! ix = 2*(jaddlv(j)-jadsub(j))+1 -! if(l.le.0) then -! l=k-ix-1 -! else -! l=k-ix -! endif -! call efold(ftau(j+1),ftau(j),ix+1,fz(l)) -! if(jadsub(j).ne.0) then -! k = 2*(nc-j+jaddto(j)-jaddlv(j))+1 ! k at level j+1 -! ix=2*(jadsub(j)+(jadsub(j)/nint(dsubdiv-1))) -! call efold(ftau(j+1),fz(k+ix),ix,fz(k)) -! endif -! - enddo -! -!---Update total number of levels and check doesn't exceed N__ - ND = 2*(NC+jaddto(J1)-J1) + 3 - if(nd.gt.N__) then - write(6,1500) ND, 'N__',N__ - write(6,*) xgrd(1),ygrd(1) - STOP "Fastj" - endif -! -!---Add boundary/ground layer to ensure no negative J's caused by -!---too large a TTAU-step in the 2nd-order lower b.c. - ZTAU(ND+1) = ZTAU(ND)*1.000005d0 - ZTAU(ND+2) = ZTAU(ND)*1.000010d0 - zk=max(abs(U0),0.01d0) - zk=exp(-ZTAU(ND)*5.d-6/zk) - FZ(ND+1) = FZ(ND)*zk - FZ(ND+2) = FZ(ND+1)*zk - do I=1,MFIT - POMEGA(I,ND+1) = POMEGA(I,ND) - POMEGA(I,ND+2) = POMEGA(I,ND) - enddo - ND = ND+2 -! - ZU0 = U0 - ZREFL = RFLECT -! -!----------------------------------------- - CALL MIESCT -!----------------------------------------- -! Accumulate attenuation for selected levels - l=2*(NC+jaddto(J1))+3 - do j=1,lpar - k=l-(2*jndlev(j)) - if(k.gt.ND-2) then - FMEAN(j) = 0.d0 - else - FMEAN(j) = FJ(k) - endif - enddo -! - return -!1000 format(1x,i3,3(2x,1pe10.4),1x,i3) -!1300 format(1x,50(i3)) - 1500 format(' Too many levels in photolysis code: need ',i3,' but ',a, & - & ' dimensioned as ',i3) - END SUBROUTINE OPMIE - - - subroutine EFOLD (F0, F1, N, F) -!----------------------------------------------------------------------- -!--- calculate the e-fold between two boundaries, given the value -!--- at both boundaries F0(x=0) = top, F1(x=1) = bottom. -!--- presume that F(x) proportional to exp[-A*x] for x=0 to x=1 -!--- d2F/dx2 = A*A*F and thus expect F1 = F0 * exp[-A] -!--- alternatively, could define A = ln[F0/F1] -!--- let X = A*x, d2F/dX2 = F -!--- assume equal spacing (not necessary, but makes this easier) -!--- with N-1 intermediate points (and N layers of thickness dX = A/N) -!--- -!--- 2nd-order finite difference: (F(i-1) - 2F(i) + F(i+1)) / dX*dX = F(i) -!--- let D = 1 / dX*dX: -! -! 1 | 1 0 0 0 0 0 | | F0 | -! | | | 0 | -! 2 | -D 2D+1 -D 0 0 0 | | 0 | -! | | | 0 | -! 3 | 0 -D 2D+1 -D 0 0 | | 0 | -! | | | 0 | -! | 0 0 -D 2D+1 -D 0 | | 0 | -! | | | 0 | -! N | 0 0 0 -D 2D+1 -D | | 0 | -! | | | 0 | -! N+1 | 0 0 0 0 0 1 | | F1 | -! -!----------------------------------------------------------------------- -! Advantage of scheme over simple attenuation factor: conserves total -! number of photons - very useful when using scheme for heating rates. -! Disadvantage: although reproduces e-folds very well for small flux -! differences, starts to drift off when many orders of magnitude are -! involved. -!----------------------------------------------------------------------- - implicit none - real*8 F0,F1,F(250) !F(N+1) - integer N - integer I - real*8 A,DX,D,DSQ,DDP1, B(101),R(101) - real*8 ftmp -! - if(F0.eq.0.d0) then - do I=1,N - F(I)=0.d0 - enddo - return - elseif(F1.eq.0.d0) then - A = LOG(F0/1.d-250) - else - A = LOG(F0/F1) - endif -! -! DX = float(N)/A - ftmp = n - DX = ftmp/A - D = DX*DX - DSQ = D*D - DDP1 = D+D+1.d0 -! - B(2) = DDP1 - R(2) = +D*F0 - do I=3,N - B(I) = DDP1 - DSQ/B(I-1) - R(I) = +D*R(I-1)/B(I-1) - enddo - F(N+1) = F1 - do I=N,2,-1 - F(I) = (R(I) + D*F(I+1))/B(I) - enddo - F(1) = F0 - return - end subroutine EFOLD - - - subroutine CH_PROF -!----------------------------------------------------------------------- -! Check profiles to be passed to MIESCT -!----------------------------------------------------------------------- - implicit none -# include "fastj_jv_mie.h" - integer i,j - write(6,1100) 'lev','ztau','fz ','pomega( )' - do i=1,ND - if(ztau(i).ne.0.d0) then - write(6,1200) i,ztau(i),fz(i),(pomega(j,i),j=1,8) - endif - enddo - return - 1100 format(1x,a3,4(a9,2x)) - 1200 format(1x,i3,11(1x,1pe9.3)) - end subroutine CH_PROF - - - SUBROUTINE MIESCT -!----------------------------------------------------------------------- -! This is an adaption of the Prather radiative transfer code, (mjp, 10/95) -! Prather, 1974, Astrophys. J. 192, 787-792. -! Sol'n of inhomogeneous Rayleigh scattering atmosphere. -! (original Rayleigh w/ polarization) -! Cochran and Trafton, 1978, Ap.J., 219, 756-762. -! Raman scattering in the atmospheres of the major planets. -! (first use of anisotropic code) -! Jacob, Gottlieb and Prather, 1989, J.Geophys.Res., 94, 12975-13002. -! Chemistry of a polluted cloudy boundary layer, -! (documentation of extension to anisotropic scattering) -! -! takes atmospheric structure and source terms from std J-code -! ALSO limited to 4 Gauss points, only calculates mean field! -! -! mean rad. field ONLY (M=1) -! initialize variables FIXED/UNUSED in this special version: -! FTOP = 1.0 = astrophysical flux (unit of pi) at SZA, -ZU0, use for scaling -! FBOT = 0.0 = external isotropic flux on lower boundary -! SISOTP = 0.0 = Specific Intensity of isotropic radiation incident from top -! -! SUBROUTINES: MIESCT needs 'jv_mie.cmn' -! BLKSLV needs 'jv_mie.cmn' -! GEN (ID) needs 'jv_mie.cmn' -! LEGND0 (X,PL,N) -! MATIN4 (A) -! GAUSSP (N,XPT,XWT) -!----------------------------------------------------------------------- - IMPLICIT NONE -# include "fastj_jv_mie.h" - integer i, id, im - real*8 cmeq1 -!----------------------------------------------------------------------- -!---fix scattering to 4 Gauss pts = 8-stream - CALL GAUSSP (N,EMU,WT) -!---solve eqn of R.T. only for first-order M=1 -! ZFLUX = (ZU0*FZ(ND)*ZREFL+FBOT)/(1.0d0+ZREFL) - -! NOTE: Apply U0 to the diffuse UV/Vis albedo (ALBVF) from GEOS-5 -!---------------------------------------------------------------- - ZFLUX = (ZU0*FZ(ND)*ZREFL)/(1.0d0+ZREFL) - - M=1 - DO I=1,N - CALL LEGND0 (EMU(I),PM0,MFIT) - DO IM=M,MFIT - PM(I,IM) = PM0(IM) - ENDDO - ENDDO -! - CMEQ1 = 0.25D0 - CALL LEGND0 (-ZU0,PM0,MFIT) - DO IM=M,MFIT - PM0(IM) = CMEQ1*PM0(IM) - ENDDO -! - CALL BLKSLV -! - DO ID=1,ND,2 - FJ(ID) = 4.0d0*FJ(ID) + FZ(ID) - ENDDO - - RETURN - END SUBROUTINE MIESCT - - SUBROUTINE BLKSLV -!----------------------------------------------------------------------- -! Solves the block tri-diagonal system: -! A(I)*X(I-1) + B(I)*X(I) + C(I)*X(I+1) = H(I) -!----------------------------------------------------------------------- - IMPLICIT NONE -# include "fastj_jv_mie.h" - integer i, j, k, id - real*8 sum -!-----------UPPER BOUNDARY ID=1 - CALL GEN(1) - CALL MATIN4 (B) - DO I=1,N - RR(I,1) = 0.0d0 - DO J=1,N - SUM = 0.0d0 - DO K=1,N - SUM = SUM - B(I,K)*CC(K,J) - ENDDO - DD(I,J,1) = SUM - RR(I,1) = RR(I,1) + B(I,J)*H(J) - ENDDO - ENDDO -!----------CONTINUE THROUGH ALL DEPTH POINTS ID=2 TO ID=ND-1 - DO ID=2,ND-1 - CALL GEN(ID) - DO I=1,N - DO J=1,N - B(I,J) = B(I,J) + A(I)*DD(I,J,ID-1) - ENDDO - H(I) = H(I) - A(I)*RR(I,ID-1) - ENDDO - CALL MATIN4 (B) - DO I=1,N - RR(I,ID) = 0.0d0 - DO J=1,N - RR(I,ID) = RR(I,ID) + B(I,J)*H(J) - DD(I,J,ID) = - B(I,J)*C1(J) - ENDDO - ENDDO - ENDDO -!---------FINAL DEPTH POINT: ND - CALL GEN(ND) - DO I=1,N - DO J=1,N - SUM = 0.0d0 - DO K=1,N - SUM = SUM + AA(I,K)*DD(K,J,ND-1) - ENDDO - B(I,J) = B(I,J) + SUM - H(I) = H(I) - AA(I,J)*RR(J,ND-1) - ENDDO - ENDDO - CALL MATIN4 (B) - DO I=1,N - RR(I,ND) = 0.0d0 - DO J=1,N - RR(I,ND) = RR(I,ND) + B(I,J)*H(J) - ENDDO - ENDDO -!-----------BACK SOLUTION - DO ID=ND-1,1,-1 - DO I=1,N - DO J=1,N - RR(I,ID) = RR(I,ID) + DD(I,J,ID)*RR(J,ID+1) - ENDDO - ENDDO - ENDDO -!----------MEAN J & H - DO ID=1,ND,2 - FJ(ID) = 0.0d0 - DO I=1,N - FJ(ID) = FJ(ID) + RR(I,ID)*WT(I) - ENDDO - ENDDO - DO ID=2,ND,2 - FJ(ID) = 0.0d0 - DO I=1,N - FJ(ID) = FJ(ID) + RR(I,ID)*WT(I)*EMU(I) - ENDDO - ENDDO -! Output fluxes for testing purposes -! CALL CH_FLUX -! - RETURN - END SUBROUTINE BLKSLV - - - SUBROUTINE CH_FLUX -!----------------------------------------------------------------------- -! Diagnostic routine to check fluxes at each level - makes most sense -! when running a conservative atmosphere (zero out absorption in -! OPMIE by calling the NOABS routine below) -!----------------------------------------------------------------------- - IMPLICIT NONE -# include "fastj_jv_mie.h" - integer I,ID - real*8 FJCHEK(N__),FZMEAN -! -! Odd (h) levels held as actinic flux, so recalculate irradiances - DO ID=1,ND,2 - FJCHEK(ID) = 0.0d0 - DO I=1,N - FJCHEK(ID) = FJCHEK(ID) + RR(I,ID)*WT(I)*EMU(i) - ENDDO - ENDDO -! -! Even (j) levels are already held as irradiances - DO ID=2,ND,2 - DO I=1,N - FJCHEK(ID) = FJ(ID) - ENDDO - ENDDO -! -! Output Downward and Upward fluxes down through atmosphere - WRITE(6,1200) - DO ID=2,ND,2 - FZMEAN=sqrt(FZ(ID)*FZ(ID-1)) - WRITE(6,1000) ID, ZU0*FZMEAN-2.0*(FJCHEK(id)-FJCHEK(id-1)), & - & 2.0*(FJCHEK(id)+FJCHEK(id-1)), & - & 2.0*(FJCHEK(id)+FJCHEK(id-1))/ & - & (ZU0*FZMEAN-2.0*(FJCHEK(id)-FJCHEK(id-1))) - ENDDO - RETURN - 1000 FORMAT(1x,i3,1p,2E12.4,1x,0p,f9.4) - 1200 FORMAT(1x,'Lev',3x,'Downward',4x,'Upward',7x,'Ratio') - END SUBROUTINE CH_FLUX - - SUBROUTINE NOABS(XLO3,XLO2,XLRAY,BCAER,RFLECT) -!----------------------------------------------------------------------- -! Zero out absorption terms to check scattering code. Leave a little -! Rayleigh to provide a minimal optical depth, and set surface albedo -! to unity. -!----------------------------------------------------------------------- - IMPLICIT NONE - real*8 XLO3,XLO2,XLRAY,BCAER,RFLECT - XLO3=0.d0 - XLO2=0.d0 - XLRAY=XLRAY*1.d-10 - BCAER=0.d0 - RFLECT=1.d0 - RETURN - END SUBROUTINE NOABS - - - SUBROUTINE GEN(ID) -!----------------------------------------------------------------------- -! Generates coefficient matrices for the block tri-diagonal system: -! A(I)*X(I-1) + B(I)*X(I) + C(I)*X(I+1) = H(I) -!----------------------------------------------------------------------- - IMPLICIT NONE -# include "fastj_jv_mie.h" - integer id, id0, id1, im, i, j, k, mstart - real*8 sum0, sum1, sum2, sum3 - real*8 deltau, d1, d2, surfac -!--------------------------------------------- - IF(ID.EQ.1 .OR. ID.EQ.ND) THEN -!---------calculate generic 2nd-order terms for boundaries - ID0 = ID - ID1 = ID+1 - IF(ID.GE.ND) ID1 = ID-1 - DO 10 I=1,N - SUM0 = 0.0d0 - SUM1 = 0.0d0 - SUM2 = 0.0d0 - SUM3 = 0.0d0 - DO IM=M,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID0)*PM(I,IM)*PM0(IM) - SUM2 = SUM2 + POMEGA(IM,ID1)*PM(I,IM)*PM0(IM) - ENDDO - DO IM=M+1,MFIT,2 - SUM1 = SUM1 + POMEGA(IM,ID0)*PM(I,IM)*PM0(IM) - SUM3 = SUM3 + POMEGA(IM,ID1)*PM(I,IM)*PM0(IM) - ENDDO - H(I) = 0.5d0*(SUM0*FZ(ID0) + SUM2*FZ(ID1)) - A(I) = 0.5d0*(SUM1*FZ(ID0) + SUM3*FZ(ID1)) - DO J=1,I - SUM0 = 0.0d0 - SUM1 = 0.0d0 - SUM2 = 0.0d0 - SUM3 = 0.0d0 - DO IM=M,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID0)*PM(I,IM)*PM(J,IM) - SUM2 = SUM2 + POMEGA(IM,ID1)*PM(I,IM)*PM(J,IM) - ENDDO - DO IM=M+1,MFIT,2 - SUM1 = SUM1 + POMEGA(IM,ID0)*PM(I,IM)*PM(J,IM) - SUM3 = SUM3 + POMEGA(IM,ID1)*PM(I,IM)*PM(J,IM) - ENDDO - S(I,J) = - SUM2*WT(J) - S(J,I) = - SUM2*WT(I) - W(I,J) = - SUM1*WT(J) - W(J,I) = - SUM1*WT(I) - UX1(I,J) = - SUM3*WT(J) - UX1(J,I) = - SUM3*WT(I) - SUM0 = 0.5d0*(SUM0 + SUM2) - B(I,J) = - SUM0*WT(J) - B(J,I) = - SUM0*WT(I) - ENDDO - S(I,I) = S(I,I) + 1.0d0 - W(I,I) = W(I,I) + 1.0d0 - UX1(I,I) = UX1(I,I) + 1.0d0 - B(I,I) = B(I,I) + 1.0d0 - 10 CONTINUE - DO I=1,N - SUM0 = 0.0d0 - DO J=1,N - SUM0 = SUM0 + S(I,J)*A(J)/EMU(J) - ENDDO - C1(I) = SUM0 - ENDDO - DO I=1,N - DO J=1,N - SUM0 = 0.0d0 - SUM2 = 0.0d0 - DO K=1,N - SUM0 = SUM0 + S(J,K)*W(K,I)/EMU(K) - SUM2 = SUM2 + S(J,K)*UX1(K,I)/EMU(K) - ENDDO - A(J) = SUM0 - VX1(J) = SUM2 - ENDDO - DO J=1,N - W(J,I) = A(J) - UX1(J,I) = VX1(J) - ENDDO - ENDDO - IF (ID.EQ.1) THEN -!-------------upper boundary, 2nd-order, C-matrix is full (CC) - DELTAU = ZTAU(2) - ZTAU(1) - D2 = 0.25d0*DELTAU - DO I=1,N - D1 = EMU(I)/DELTAU - DO J=1,N - B(I,J) = B(I,J) + D2*W(I,J) - CC(I,J) = D2*UX1(I,J) - ENDDO - B(I,I) = B(I,I) + D1 - CC(I,I) = CC(I,I) - D1 -! H(I) = H(I) + 2.0d0*D2*C1(I) + D1*SISOTP - H(I) = H(I) + 2.0d0*D2*C1(I) - A(I) = 0.0d0 - ENDDO - ELSE -!-------------lower boundary, 2nd-order, A-matrix is full (AA) - DELTAU = ZTAU(ND) - ZTAU(ND-1) - D2 = 0.25d0*DELTAU - SURFAC = 4.0d0*ZREFL/(1.0d0 + ZREFL) - DO I=1,N - D1 = EMU(I)/DELTAU - H(I) = H(I) - 2.0d0*D2*C1(I) - SUM0 = 0.0d0 - DO J=1,N - SUM0 = SUM0 + W(I,J) - ENDDO - SUM0 = D1 + D2*SUM0 - SUM1 = SURFAC*SUM0 - DO J=1,N - B(I,J) = B(I,J) + D2*W(I,J) - SUM1*EMU(J)*WT(J) - ENDDO - B(I,I) = B(I,I) + D1 - H(I) = H(I) + SUM0*ZFLUX - DO J=1,N - AA(I,J) = - D2*UX1(I,J) - ENDDO - AA(I,I) = AA(I,I) + D1 - C1(I) = 0.0d0 - ENDDO - ENDIF -!------------intermediate points: can be even or odd, A & C diagonal - ELSE - DELTAU = ZTAU(ID+1) - ZTAU(ID-1) - MSTART = M + MOD(ID+1,2) - DO I=1,N - A(I) = EMU(I)/DELTAU - C1(I) = -A(I) - SUM0 = 0.0d0 - DO IM=MSTART,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID)*PM(I,IM)*PM0(IM) - ENDDO - H(I) = SUM0*FZ(ID) - DO J=1,I - SUM0 = 0.0d0 - DO IM=MSTART,MFIT,2 - SUM0 = SUM0 + POMEGA(IM,ID)*PM(I,IM)*PM(J,IM) - ENDDO - B(I,J) = - SUM0*WT(J) - B(J,I) = - SUM0*WT(I) - ENDDO - B(I,I) = B(I,I) + 1.0d0 - ENDDO - ENDIF - RETURN - END SUBROUTINE GEN - - SUBROUTINE LEGND0 (X,PL,N) -!---Calculates ORDINARY LEGENDRE fns of X (real) -!--- from P[0] = PL(1) = 1, P[1] = X, .... P[N-1] = PL(N) - IMPLICIT NONE - INTEGER N,I - REAL*8 X,PL(N),DEN -!---Always does PL(2) = P[1] - PL(1) = 1.D0 - PL(2) = X - DO I=3,N - DEN = (I-1) - PL(I) = PL(I-1)*X*(2.d0-1.D0/DEN) - PL(I-2)*(1.d0-1.D0/DEN) - ENDDO - RETURN - END SUBROUTINE LEGND0 - - SUBROUTINE MATIN4 (A) -!----------------------------------------------------------------------- -! invert 4x4 matrix A(4,4) in place with L-U decomposition (mjp, old...) -!----------------------------------------------------------------------- - IMPLICIT NONE - REAL*8 A(4,4) -!---SETUP L AND U - A(2,1) = A(2,1)/A(1,1) - A(2,2) = A(2,2)-A(2,1)*A(1,2) - A(2,3) = A(2,3)-A(2,1)*A(1,3) - A(2,4) = A(2,4)-A(2,1)*A(1,4) - A(3,1) = A(3,1)/A(1,1) - A(3,2) = (A(3,2)-A(3,1)*A(1,2))/A(2,2) - A(3,3) = A(3,3)-A(3,1)*A(1,3)-A(3,2)*A(2,3) - A(3,4) = A(3,4)-A(3,1)*A(1,4)-A(3,2)*A(2,4) - A(4,1) = A(4,1)/A(1,1) - A(4,2) = (A(4,2)-A(4,1)*A(1,2))/A(2,2) - A(4,3) = (A(4,3)-A(4,1)*A(1,3)-A(4,2)*A(2,3))/A(3,3) - A(4,4) = A(4,4)-A(4,1)*A(1,4)-A(4,2)*A(2,4)-A(4,3)*A(3,4) -!---INVERT L - A(4,3) = -A(4,3) - A(4,2) = -A(4,2)-A(4,3)*A(3,2) - A(4,1) = -A(4,1)-A(4,2)*A(2,1)-A(4,3)*A(3,1) - A(3,2) = -A(3,2) - A(3,1) = -A(3,1)-A(3,2)*A(2,1) - A(2,1) = -A(2,1) -!---INVERT U - A(4,4) = 1.D0/A(4,4) - A(3,4) = -A(3,4)*A(4,4)/A(3,3) - A(3,3) = 1.D0/A(3,3) - A(2,4) = -(A(2,3)*A(3,4)+A(2,4)*A(4,4))/A(2,2) - A(2,3) = -A(2,3)*A(3,3)/A(2,2) - A(2,2) = 1.D0/A(2,2) - A(1,4) = -(A(1,2)*A(2,4)+A(1,3)*A(3,4)+A(1,4)*A(4,4))/A(1,1) - A(1,3) = -(A(1,2)*A(2,3)+A(1,3)*A(3,3))/A(1,1) - A(1,2) = -A(1,2)*A(2,2)/A(1,1) - A(1,1) = 1.D0/A(1,1) -!---MULTIPLY (U-INVERSE)*(L-INVERSE) - A(1,1) = A(1,1)+A(1,2)*A(2,1)+A(1,3)*A(3,1)+A(1,4)*A(4,1) - A(1,2) = A(1,2)+A(1,3)*A(3,2)+A(1,4)*A(4,2) - A(1,3) = A(1,3)+A(1,4)*A(4,3) - A(2,1) = A(2,2)*A(2,1)+A(2,3)*A(3,1)+A(2,4)*A(4,1) - A(2,2) = A(2,2)+A(2,3)*A(3,2)+A(2,4)*A(4,2) - A(2,3) = A(2,3)+A(2,4)*A(4,3) - A(3,1) = A(3,3)*A(3,1)+A(3,4)*A(4,1) - A(3,2) = A(3,3)*A(3,2)+A(3,4)*A(4,2) - A(3,3) = A(3,3)+A(3,4)*A(4,3) - A(4,1) = A(4,4)*A(4,1) - A(4,2) = A(4,4)*A(4,2) - A(4,3) = A(4,4)*A(4,3) - RETURN - END SUBROUTINE MATIN4 - - SUBROUTINE GAUSSP (N,XPT,XWT) -!----------------------------------------------------------------------- -! Loads in pre-set Gauss points for 4 angles from 0 to +1 in cos(theta)=mu -!----------------------------------------------------------------------- - IMPLICIT NONE - INTEGER N,I - REAL*8 XPT(N),XWT(N) - REAL*8 GPT4(4),GWT4(4) - DATA GPT4/.06943184420297D0,.33000947820757D0,.66999052179243D0, & - & .93056815579703D0/ - DATA GWT4/.17392742256873D0,.32607257743127D0,.32607257743127D0, & - & .17392742256873D0/ - N = 4 - DO I=1,N - XPT(I) = GPT4(I) - XWT(I) = GWT4(I) - ENDDO - RETURN - END SUBROUTINE GAUSSP diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_JVdat.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_JVdat.h deleted file mode 100644 index 4ac774c0..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_JVdat.h +++ /dev/null @@ -1,24 +0,0 @@ -!----------------------------------------------------------------------- -! include 'cmn_JVdat.f' for fast-JX code v5.3 (prather 6/05) -! -! NB - ALL of these common variables are set paramters, -! They are NOT to be used as variables for a local solution -! Thus this entire set is 'in' only after it is initialized -!----------------------------------------------------------------------- - real*8 RAD,ZZHT,ATAU,ATAU0 - real*8 WBIN(W_+1),WL(W_),FL(W_),QO2(W_,3),QO3(W_,3),Q1D(W_,3) - real*8 QQQ(W_,2,X_),QRAYL(W_+1),TQQ(3,X_) - real*8 WAA(4,A_),QAA(4,A_),PAA(8,4,A_),RAA(4,A_), & - & SSA(4,A_) - real*8 JFACTA(MAX_JVN_) - integer JIND(MAX_JVN_),NRATJ,NJVAL,NW1,NW2,NAA,JTAUMX - character*20 TITLEA(A_) - character*78 TITLE0 - character*7 TITLEJ(X_),TITLEJ2,TITLEJ3,JLABEL(MAX_JVN_) -! - common /jvchem_JX53b/JFACTA,JIND,NRATJ,JLABEL,TITLEA -! - common /jvdat_JX53b/WBIN,WL,FL,QO2,QO3,Q1D,QQQ,QRAYL,TQQ, & - & WAA,QAA,PAA,RAA,SSA,RAD,ZZHT,ATAU,ATAU0, & - & JTAUMX, NJVAL,NW1,NW2,NAA ,TITLE0,TITLEJ -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_metdat.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_metdat.h deleted file mode 100644 index 21d0d0e9..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_cmn_metdat.h +++ /dev/null @@ -1,43 +0,0 @@ -!----------------------------------------------------------------------- -! include 'cmn_metdat.f' for fast-JX code v5.3 (prather 6/05) -! -! needs 'parm_ctm.f' for dimensions -! delivers p, T, Surf Albedo, and Optical Depth from CTM to fastJX -! >>>>this is for standalone fast-JX ver 5.3 (6.05) -!----------------------------------------------------------------------- -! - real*8 P(I_,J_) ! Surface pressure - real*8 T(I_,J_,MAX_L_) ! Temperature profile -! real*8 OD(I_,J_,LWE_) ! Optical Depth profile -! - real*8 XGRD(I_) ! Longitude (midpoint, radians) - real*8 XDGRD(I_) - real*8 YGRD(J_) ! Latitude (midpoint, radians) - real*8 YDGRD(J_) - real*8 ETAA(MAX_L_+1) ! Eta(a) value for level boundaries - real*8 ETAB(MAX_L_+1) ! Eta(b) value for level boundaries - real*8 AREAXY(I_,J_) ! area (m^2) - integer MONTH - integer NSLAT ! Latitude(J) index of current column - integer NSLON ! Longitude(I) index of current column - - real*8 PJ(MAX_L_+1) - - real*8, dimension(I_,J_,MAX_L1_) :: TJ, DM, DO3, ZH - real*8, dimension(I_,J_,MAX_L1_) :: DAER1, DAER2, DAER3, ODCLD - integer,dimension(I_,J_,MAX_L1_) :: NAER1, NAER2, NAER3, NCLDX - real*8, dimension(I_,J_) :: PMEAN, SA -! - real*8 STT(I_,J_,MAX_L_,NTR_) - real*8 TREF(51,18,12),OREF(51,18,12) - character*10 TCNAME(NTR_) -! common/metdat/P,T,OD, STT, - common/metdat_JX53b/P,T,STT, & - & XGRD,YGRD,XDGRD,YDGRD,ETAA,ETAB,AREAXY, & - & TREF,OREF,PMEAN,SA, MONTH,NSLAT,NSLON, TCNAME -! - common /jvdatIJ_JX53b/TJ,DM,DO3,ZH, PJ, & - & DAER1,DAER2,DAER3,ODCLD, & - & NAER1,NAER2,NAER3,NCLDX -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_CTM.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_CTM.h deleted file mode 100644 index 44d5d869..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_CTM.h +++ /dev/null @@ -1,27 +0,0 @@ -! include 'parm_CTM.f' for fast-JX code v5.3 (prather 6/05) -! -! I_ = longitude dim of CTM grid -! J_ = latitude dim of CTM grid -! L_ = altitude(levels) dim of CTM grid -! LWE_ = altitude(level) dim for trop processes (clouds, rain) -! JVL_ = vertical(levels) dim for J-values -! L2_ = 2*L1_ = 2*L_ + 2 = no. levels in the basic Fast-JX grid (mid-level_ -! JVN_ = no. of J-values -! W_ = dim = no. of Wavelength bins -! X_ = dim = no. of X-section data sets (input data) -! A_ = dim = no. of Aerosol/cloud Mie sets (input data) -! MX = no. of aerosol/cloud types supplied from CTM -! NTR_ = no. of CTM tracers -! SZAMAX Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! integer, parameter :: I_=128, J_=64, L_=37, LWE_=37 !for EC T42L37 - integer, parameter :: I_=1, J_=1, MAX_L_=70 !for EC T42L37 - integer, parameter :: MAX_JVL_=70, MAX_JVN_=82, W_=18, X_=64, A_=21 - integer, parameter :: MAX_L1_=MAX_L_+1, MAX_L2_=2*MAX_L_+2 - integer, parameter :: MX=4, NTR_=1 - real*8, parameter :: SZAMAX=98.0d0 - integer :: L_, JVL_, JVN_, L1_, L2_ - common /dims/ L_, JVL_, JVN_, L1_, L2_ -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_MIE.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_MIE.h deleted file mode 100644 index 81109a21..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53b_parm_MIE.h +++ /dev/null @@ -1,10 +0,0 @@ -! include 'parm_mie.f' for fast-JX code v5.3 (prather 6/05) -! -! N_ = no. of levels in Mie scattering arrays -! = 2*NC+1 = 4*LPAR + 5 + 2*sum(JADDLV) -! M_ = no. of Gauss points used, must = 4 in fast_JX (no option) -! -!----------------------------------------------------------------------- - integer, parameter :: N_=501, M_=4 -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_JVdat.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_JVdat.h deleted file mode 100644 index 22131dd9..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_JVdat.h +++ /dev/null @@ -1,24 +0,0 @@ -!----------------------------------------------------------------------- -! include 'cmn_JVdat.f' for fast-JX code v5.3 (prather 6/05) -! -! NB - ALL of these common variables are set paramters, -! They are NOT to be used as variables for a local solution -! Thus this entire set is 'in' only after it is initialized -!----------------------------------------------------------------------- - real*8 RAD,ZZHT,ATAU,ATAU0 - real*8 WBIN(W_+1),WL(W_),FL(W_),QO2(W_,3),QO3(W_,3),Q1D(W_,3) - real*8 QQQ(W_,2,X_),QRAYL(W_+1),TQQ(3,X_) - real*8 WAA(4,A_),QAA(4,A_),PAA(8,4,A_),RAA(4,A_), & - & SSA(4,A_) - real*8 JFACTA(MAX_JVN_) - integer JIND(MAX_JVN_),NRATJ,NJVAL,NW1,NW2,NAA,JTAUMX - character*20 TITLEA(A_) - character*78 TITLE0 - character*7 TITLEJ(X_),TITLEJ2,TITLEJ3,JLABEL(MAX_JVN_) -! - common /jvchem_JX53c/JFACTA,JIND,NRATJ,JLABEL,TITLEA -! - common /jvdat_JX53c/WBIN,WL,FL,QO2,QO3,Q1D,QQQ,QRAYL,TQQ, & - & WAA,QAA,PAA,RAA,SSA,RAD,ZZHT,ATAU,ATAU0, & - & JTAUMX, NJVAL,NW1,NW2,NAA ,TITLE0,TITLEJ -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_metdat.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_metdat.h deleted file mode 100644 index 03a92a17..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_cmn_metdat.h +++ /dev/null @@ -1,52 +0,0 @@ -!----------------------------------------------------------------------- -! include 'cmn_metdat.f' for fast-JX code v5.3 (prather 6/05) -! -! needs 'parm_ctm.f' for dimensions -! delivers p, T, Surf Albedo, and Optical Depth from CTM to fastJX -! >>>>this is for standalone fast-JX ver 5.3 (6.05) -!----------------------------------------------------------------------- -! - real*8 P(I_,J_) ! Surface pressure - real*8 T(I_,J_,MAX_L_) ! Temperature profile -! real*8 OD(I_,J_,LWE_) ! Optical Depth profile -! - real*8 XGRD(I_) ! Longitude (midpoint, radians) - real*8 XDGRD(I_) - real*8 YGRD(J_) ! Latitude (midpoint, radians) - real*8 YDGRD(J_) - real*8 PJ(MAX_L_+1) - real*8 ETAA(MAX_L_+1) ! Eta(a) value for level boundaries - real*8 ETAB(MAX_L_+1) ! Eta(b) value for level boundaries - real*8 AREAXY(I_,J_) ! area (m^2) - integer MONTH - integer NSLAT ! Latitude(J) index of current column - integer NSLON ! Longitude(I) index of current column - - real*8, dimension(I_,J_,MAX_L1_) :: TJ, DM, DO3, ZH - real*8, dimension(I_,J_,MAX_L1_) :: DAER1, DAER2, DAER3, ODCLD - integer,dimension(I_,J_,MAX_L1_) :: NAER1, NAER2, NAER3, NCLDX - real*8, dimension(I_,J_) :: PMEAN, SA -! - real*8 STT(I_,J_,MAX_L_,NTR_) - real*8 TREF(51,18,12),OREF(51,18,12) - character*10 TCNAME(NTR_) - - real*8, pointer :: optDust(:,:) - real*8, pointer :: optAer (:,:) - real*8, pointer :: AER (:,:) - integer, pointer :: ADX (:,:) - real*8, dimension(MAX_L1_) :: ODCOL - - common/metdatAerosol/optDust, optAer, AER, ADX - -! common/metdat/P,T,OD, STT, - common/metdat_JX53c/P,T,STT, & - & XGRD,YGRD,XDGRD,YDGRD,ETAA,ETAB,AREAXY, & - & TREF,OREF,PMEAN,SA, MONTH,NSLAT,NSLON, TCNAME -! - common /jvdatIJ_JX53c/TJ,DM,DO3,ZH, PJ, & - & DAER1,DAER2,DAER3,ODCLD, & - & NAER1,NAER2,NAER3,NCLDX, & - & ODCOL -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_CTM.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_CTM.h deleted file mode 100644 index 7d163072..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_CTM.h +++ /dev/null @@ -1,30 +0,0 @@ -! include 'parm_CTM.f' for fast-JX code v5.3 (prather 6/05) -! -! I_ = longitude dim of CTM grid -! J_ = latitude dim of CTM grid -! L_ = altitude(levels) dim of CTM grid -! LWE_ = altitude(level) dim for trop processes (clouds, rain) -! JVL_ = vertical(levels) dim for J-values -! L2_ = 2*L1_ = 2*L_ + 2 = no. levels in the basic Fast-JX grid (mid-level_ -! JVN_ = no. of J-values -! W_ = dim = no. of Wavelength bins -! X_ = dim = no. of X-section data sets (input data) -! A_ = dim = no. of Aerosol/cloud Mie sets (input data) -! MX = no. of aerosol/cloud types supplied from CTM -! NTR_ = no. of CTM tracers -! SZAMAX Solar zenith angle cut-off, above which to skip calculation -! -!----------------------------------------------------------------------- -! integer, parameter :: I_=128, J_=64, L_=37, LWE_=37 !for EC T42L37 - integer, parameter :: I_=1, J_=1, MAX_L_=70 !for EC T42L37 - integer, parameter :: MAX_JVL_=70, MAX_JVN_=82, W_=18, X_=64 -! integer, parameter :: A_=21 - integer, parameter :: A_=56 - integer, parameter :: MAX_L1_=MAX_L_+1, MAX_L2_=2*MAX_L_+2 - integer, parameter :: MX=4, NTR_=1 - real*8, parameter :: SZAMAX=98.0d0 - integer :: L_, JVL_, JVN_, L1_, L2_ - integer :: NCTA - common /dims/ L_, JVL_, JVN_, L1_, L2_, NCTA -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_MIE.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_MIE.h deleted file mode 100644 index 81109a21..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastJX53c_parm_MIE.h +++ /dev/null @@ -1,10 +0,0 @@ -! include 'parm_mie.f' for fast-JX code v5.3 (prather 6/05) -! -! N_ = no. of levels in Mie scattering arrays -! = 2*NC+1 = 4*LPAR + 5 + 2*sum(JADDLV) -! M_ = no. of Gauss points used, must = 4 in fast_JX (no option) -! -!----------------------------------------------------------------------- - integer, parameter :: N_=501, M_=4 -!----------------------------------------------------------------------- - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_h.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_h.h deleted file mode 100644 index 946c1db7..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_h.h +++ /dev/null @@ -1,57 +0,0 @@ -! -! Main header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -!----------------------------------------------------------------------- -! - integer ipar, jpar, lpar - integer lpar_max, jpnl_max, jppj_max !Added for GMI {AOO, 8/04} - integer jpnl, jppj - logical ldeg45 - parameter(ipar=1,jpar=1) ! Number of lat/lon points in CTM - -!cc Use lpar=9 for GISS 9-layer CTM -!cc parameter(lpar=9,jpnl=9) ! Number of levels in CTM and number -!cc parameter(lpar=9,jpnl=8) ! Number of levels in CTM and number - -!cc Use lpar=23 for the GISS 23-layer CTM -!cc parameter(lpar=23,jpnl=23) ! of levels requiring chemistry - -!cc Use lpar=40 to do US std atmosphere - parameter(lpar_max=72) ! of levels requiring chemistry - parameter(jpnl_max = lpar_max) - -!ccc parameter(jppj=46) ! Number of photolytic reactions supplied - parameter(jppj_max=82) ! Number of photolytic reactions supplied - - - parameter(ldeg45=.false.) ! Logical flag for degraded CTM resolution -! - real*8 xgrd(ipar) ! Longitude (midpoint, radians) - real*8 ygrd(jpar) ! Latitude (midpoint, radians) - real*8 ydgrd(jpar) ! Latitude (midpoint, degrees) -! real*8 etaa(lpar+1) ! Eta(a) value for level boundaries -! real*8 etab(lpar+1) ! Eta(b) value for level boundaries - real*8 etaa(lpar_max+1) ! Eta(a) value for level boundaries - real*8 etab(lpar_max+1) ! Eta(b) value for level boundaries -! - real*8 tau ! Time of Day (hours, GMT) - integer month ! Number of month (1-12) - integer iday ! Day of year - - logical do_model_clima ! determines if climatology data come - ! from the model. - -! real*8 DUSSTD,OUSSTD,TUSSTD,PUSSTD - -! - common/dims/lpar, jpnl, jppj ! Added for GMI. {AOO, 8/04} - common/grid/xgrd,ygrd,ydgrd,etaa,etab - common/fast_JX_time/tau,month,iday - common/fast_JX_clima/do_model_clima - -! common/usstd/ DUSSTD(52),OUSSTD(52),TUSSTD(52),PUSSTD(52) - -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_t.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_t.h deleted file mode 100644 index 4002e714..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_t.h +++ /dev/null @@ -1,13 +0,0 @@ -! -! Tracer header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -!----------------------------------------------------------------------- -! - integer nslat ! Latitude of current profile point - integer nslon ! Longitude of current profile point -! - common/point/nslat,nslon -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_w.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_w.h deleted file mode 100644 index a456eee3..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_cmn_w.h +++ /dev/null @@ -1,23 +0,0 @@ -! -! Wind data header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -!----------------------------------------------------------------------- -! - real*8 P(ipar,jpar) ! Surface pressure -! real*8 T(ipar,jpar,lpar+1) ! Temperature profile - real*8 T(ipar,jpar,lpar_max+1) ! Temperature profile -! -! real*8 OD(ipar,jpar,lpar+1) ! Optical Depth profile - real*8 OD(ipar,jpar,lpar_max) ! Optical Depth profile - real*8 SA(ipar,jpar) ! Surface Albedo -! -!! real*8 optaer(ipar,jpar,lpar_max,NSADaer*nrh_b) ! Opt. Depth profile for aerosols -!! real*8 optdust(ipar,jpar,lpar_max,NSADdust) ! Opt. Depth profile for dust - real*8 optaer(lpar_max,NSADaer*nrh_b) ! Opt. Depth profile for aerosols - real*8 optdust(lpar_max,NSADdust) ! Opt. Depth profile for dust -! - common/metdat/P,T,OD,SA, optaer, optdust -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_cmn.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_cmn.h deleted file mode 100644 index 4c27bd5a..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_cmn.h +++ /dev/null @@ -1,59 +0,0 @@ -!----jv_cmn.h---COMMON BLOCKS for new FAST-J code (wild/prather 7/99) -! -! Parameters -! ---------- -! -! NB Number of levels in CTM plus one for above model top -! NC Number of levels in the fundamental Fast-J grid -! NS Maximum number of species which require J-values calculating -! NW Maximum number of wavelength bins that can be used -! NP Maximum number of aerosol/cloud types that can be used -! NH Maximum number of Herzberg X-sections that can be used -! MX Number of aerosol/cloud types supplied from CTM -! -! Note: THETA(NL) no longer used -! -! HISTORY -! * February 24, 2004 - Jules Kouatchou -! Modified the value of NP (from 21 to 56) -! Modified the value of MX (from 3 to 35) -!----------------------------------------------------------------------- - INTEGER NB, NC, NS, NW, NP, NH, MX -! PARAMETER (NB=LPAR+1, NC=2*NB, NS=61, NW=18, NP=21, NH=7, MX=3) -! PARAMETER (NS=61, NW=18, NP=21, NH=7, MX=3) - PARAMETER (NS=61, NW=18, NP=56, NH=7, MX=35) - INTEGER, parameter :: NB_MAX = LPAR_MAX+1 ! Added for GMI {AOO, 8/04} - INTEGER, parameter :: NC_MAX = 2*NB_MAX ! Added for GMI {AOO, 8/04} - CHARACTER*20 TITLEA(NP) - CHARACTER*78 TITLE0 - CHARACTER*7 TITLEJ(3,NS), jlabel(jppj_max), hzlab(nh) - INTEGER jind(jppj_max),jadsub(nc_max),nhz,hzind(nh) - INTEGER NJVAL,NW1,NW2,MIEDX,NAA,NLBATM,npdep,jpdep(NS) - REAL*8 TJ,PJ,DM,DO3,Z,AER,AMF,RAD,RFLECT,SZA,U0,TANHT,ZZHT - REAL*8 WBIN,WL,FL,QO2,QO3,Q1D,QQQ,QRAYL,TQQ,FFF,VALJ,WAA,QAA,PAA - REAL*8 RAA,SSA,TREF,OREF,BREF,QBC,DBC,zpdep(NW,3) - REAL*8 dtaumax,szamax,zj(jpnl_max,jppj_max),jfacta(jppj_max) - REAL*8 dtausub,dsubdiv - integer :: ncat_acetone_trop,ncat_acetone_stra ! Added for GMI to {AOO, 8/04} - integer :: ncat_met_vinyl_ketone ! Added for GMI to {AOO, 8/04} - integer :: ncat_met_ethyl_ketone ! Added for GMI to {AOO, 8/04} - integer :: ncat_methyl_glyoxal ! Added for GMI to {AOO, 8/04} - COMMON /TITLS/TITLE0,TITLEJ,TITLEA - COMMON /ATMOS/TJ(NB_MAX),PJ(NB_MAX+1),DM(NB_MAX),DO3(NB_MAX), & - & DBC(NB_MAX),Z(NB_MAX),AER(MX,NB_MAX), & - & AMF(NB_MAX,NB_MAX),RAD,RFLECT,SZA,U0,TANHT,ZZHT - COMMON /CCWVL/WBIN(NW+1),WL(NW),FL(NW),QO2(NW,3),QO3(NW,3), & - & Q1D(NW,3),QQQ(NW,2,NS-3),QRAYL(NW+1),TQQ(3,NS), & - & FFF(NW,jpnl_max),VALJ(NS),WAA(4,NP),QAA(4,NP), & - & PAA(8,4,NP),RAA(4,NP),SSA(4,NP),QBC(NW), & - & NJVAL,NW1,NW2,MIEDX(MX),NAA,NLBATM - COMMON /CLIM/ TREF(51,18,12),OREF(51,18,12),BREF(51) - COMMON /JCNTR/dtaumax,szamax - COMMON /JVALS/zj,jfacta,zpdep,npdep,jpdep,jind,jlabel - COMMON /JVSUB/jadsub,dtausub,dsubdiv - COMMON /dims2/ NB, NC ! Added for GMI {AOO, 8/04} - common /acetone_cat/ ncat_acetone_trop,ncat_acetone_stra ! Added for GMI to {AOO, 8/04} - common /met_vinyl_ketone/ ncat_met_vinyl_ketone ! Added for GMI to {AOO, 8/04} - common /met_ethyl_ketone/ ncat_met_ethyl_ketone ! Added for GMI to {AOO, 8/04} - common /methyl_glyoxal/ ncat_methyl_glyoxal ! Added for GMI to {AOO, 8/04} -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_mie.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_mie.h deleted file mode 100644 index 31bcf620..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fast_JX_jv_mie.h +++ /dev/null @@ -1,22 +0,0 @@ -!----jv_mie.h-----COMMON BLOCKS for FAST-J code: 4x4x85 (prather 4/96) -! -! Parameters -! ---------- -! -! NL Maximum number of levels after insertion of extra Mie levels -! N__ Number of levels in Mie grid: 2*(2*lpar+2+jaddto(1))+3 -! M__ Number of Gauss points used -! -!----------------------------------------------------------------------- - INTEGER NL, N__, M__ - PARAMETER (NL=1000, N__=2*NL, M__=4) - REAL*8 A,B,C1,H,AA,CC,S,W,U1,V1,WT,EMU,PM,PM0,POMEGA - REAL*8 ZTAU,FZ,FJ,DD,RR,ZREFL,ZFLUX,RADIUS,ZU0 - INTEGER ND,N,M,MFIT - COMMON/MIEBLK/ A(M__),B(M__,M__),C1(M__),H(M__),AA(M__,M__), & - & CC(M__,M__),S(M__,M__),W(M__,M__),U1(M__,M__),V1(M__),WT(M__), & - & EMU(M__),PM(M__,2*M__),PM0(2*M__),POMEGA(2*M__,N__),ZTAU(N__), & - & FZ(N__),FJ(N__),DD(M__,M__,N__),RR(M__,N__), & - & ZREFL,ZFLUX,RADIUS,ZU0 - COMMON/MINDEX/ ND,N,M,MFIT -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_h.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_h.h deleted file mode 100644 index 54d7caac..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_h.h +++ /dev/null @@ -1,38 +0,0 @@ -! -! Main header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -!----------------------------------------------------------------------- -! - integer ipar, jpar, lpar - integer lpar_max, jpnl_max, jppj_max !Added for GMI {PJC} - integer jpnl, jppj - logical ldeg45 - parameter(ipar=1,jpar=1) ! Number of lat/lon points in CTM. -! parameter(lpar=9,jpnl=8) ! Number of levels in CTM and number. -!c parameter(lpar=23,jpnl=14) ! of levels requiring chemistry. - parameter(lpar_max = 70) ! Max number of levels in CTM. - parameter(jpnl_max = lpar_max) ! Max num. of levels doing chemistry. -! parameter(jppj=3) ! Number of photolytic reactions supplied. - parameter(jppj_max = 55) ! Max number of photolysis reactions. - parameter(ldeg45=.false.) ! Logical flag for degraded CTM resolution. - -! - real*8 xgrd(ipar) ! Longitude (midpoint, radians) - real*8 ygrd(jpar) ! Latitude (midpoint, radians) - real*8 ydgrd(jpar) ! Latitude (midpoint, degrees) -! real*8 etaa(lpar+1) ! Eta(a) value for level boundaries -! real*8 etab(lpar+1) ! Eta(b) value for level boundaries - real*8 etaa(lpar_max+1) ! Eta(a) value for level boundaries - real*8 etab(lpar_max+1) ! Eta(b) value for level boundaries -! - real*8 tau ! Time of Day (hours, GMT) - integer month ! Number of month (1-12) - integer iday ! Day of year -! - common/dims/lpar, jpnl, jppj ! Added for GMI. {PJC} - common/grid/xgrd,ygrd,ydgrd,etaa,etab - common/fastj_time/tau,month,iday -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_t.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_t.h deleted file mode 100644 index 4002e714..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_t.h +++ /dev/null @@ -1,13 +0,0 @@ -! -! Tracer header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -!----------------------------------------------------------------------- -! - integer nslat ! Latitude of current profile point - integer nslon ! Longitude of current profile point -! - common/point/nslat,nslon -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_w.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_w.h deleted file mode 100644 index 73ff4d90..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_cmn_w.h +++ /dev/null @@ -1,28 +0,0 @@ -!----------------------------------------------------------------------- -! -! Wind data header file required by CTM - provide just enough stuff here -! to allow model subroutines to be run as a stand-alone code. -! -! Oliver (9 July 99) -! -! HISTORY -! January 5, 2005 - Jules Kouatchou -! Added the variables "optaer" and "optdust" -!----------------------------------------------------------------------- -! - real*8 P(ipar,jpar) ! Surface pressure -! real*8 T(ipar,jpar,lpar) ! Temperature profile - real*8 T(ipar,jpar,lpar_max) ! Temperature profile -! -! real*8 OD(ipar,jpar,lpar) ! Optical Depth profile - real*8 OD(ipar,jpar,lpar_max) ! Optical Depth profile - real*8 SA(ipar,jpar) ! Surface Albedo - -!! real*8 optaer(ipar,jpar,lpar_max,NSADaer*nrh_b) ! Opt. Depth profile for aerosols -!! real*8 optdust(ipar,jpar,lpar_max,NSADdust) ! Opt. Depth profile for dust - real*8 optaer(lpar_max,NSADaer*nrh_b) ! Opt. Depth profile for aerosols - real*8 optdust(lpar_max,NSADdust) ! Opt. Depth profile for dust -! - common/metdat/P,T,OD,SA, optaer, optdust -! -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_cmn.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_cmn.h deleted file mode 100644 index 769c8899..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_cmn.h +++ /dev/null @@ -1,51 +0,0 @@ -!----jv_cmn.h---COMMON BLOCKS for new FAST-J code (wild/prather 7/99) -! -! Parameters -! ---------- -! -! NB Number of levels in CTM plus one for above model top -! NC Number of levels in the fundamental Fast-J grid -! NS Maximum number of species which require J-values calculating -! NW Maximum number of wavelength bins that can be used -! NP Maximum number of aerosol/cloud types that can be used -! NH Maximum number of Herzberg X-sections that can be used -! MX Number of aerosol/cloud types supplied from CTM -! -! Note: THETA(NL) no longer used -! HISTORY -! January 5, 2005 - Jules Kouatchou -! Changed the values of NW and MX. -!----------------------------------------------------------------------- - INTEGER NB, NC, NS, NW, NP, NH, MX -! PARAMETER (NB=LPAR+1, NC=2*NB, NS=51, NW=15, NP=21, NH=7, MX=3) -! PARAMETER (NS=51, NW=7, NP=21, NH=7, MX=3) - PARAMETER (NS=51, NW=15, NP=56, NH=7, MX=35) - INTEGER, parameter :: NB_MAX = LPAR_MAX+1 ! Added for GMI {PJC} - INTEGER, parameter :: NC_MAX = 2*NB_MAX ! Added for GMI {PJC} - CHARACTER*20 TITLEA(NP) - CHARACTER*78 TITLE0 - CHARACTER*7 TITLEJ(3,NS), jlabel(jppj_max), hzlab(nh) - INTEGER jind(jppj_max),jadsub(nc_max),nhz,hzind(nh) - INTEGER NJVAL,NW1,NW2,MIEDX,NAA,NLBATM,npdep,jpdep(NS) - REAL*8 TJ,PJ,DM,DO3,Z,AER,AMF,RAD,RFLECT,SZA,U0,TANHT,ZZHT - REAL*8 WBIN,WL,FL,QO2,QO3,Q1D,QQQ,QRAYL,TQQ,FFF,VALJ,WAA,QAA,PAA - REAL*8 RAA,SSA,TREF,OREF,BREF,QBC,DBC,zpdep(NW,3) - REAL*8 dtaumax,szamax,zj(jpnl_max,jppj_max),jfacta(jppj_max) - REAL*8 dtausub,dsubdiv - REAL*8 hzo2,hzo3,hztoa(nh),fhz(jpnl_max) - COMMON /TITLS/TITLE0,TITLEJ,TITLEA - COMMON /ATMOS/TJ(NB_MAX),PJ(NB_MAX+1),DM(NB_MAX),DO3(NB_MAX), & - & DBC(NB_MAX),Z(NB_MAX),AER(MX,NB_MAX), & - & AMF(NB_MAX,NB_MAX),RAD,RFLECT,SZA,U0,TANHT,ZZHT - COMMON /CCWVL/WBIN(NW+1),WL(NW),FL(NW),QO2(NW,3),QO3(NW,3), & - & Q1D(NW,3),QQQ(NW,2,NS-3),QRAYL(NW+1),TQQ(3,NS), & - & FFF(NW,jpnl_max),VALJ(NS),WAA(4,NP),QAA(4,NP), & - & PAA(8,4,NP),RAA(4,NP),SSA(4,NP),QBC(NW), & - & NJVAL,NW1,NW2,MIEDX(MX),NAA,NLBATM - COMMON /CLIM/ TREF(51,18,12),OREF(51,18,12),BREF(51) - COMMON /JCNTR/dtaumax,szamax - COMMON /JVALS/zj,jfacta,zpdep,npdep,jpdep,jind,jlabel - COMMON /JVSUB/jadsub,dtausub,dsubdiv - COMMON /HERZ/hzo2,hzo3,hztoa,fhz,nhz,hzind,hzlab - COMMON /dims2/ NB, NC ! Added for GMI -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_mie.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_mie.h deleted file mode 100644 index b674c60a..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/fastj_jv_mie.h +++ /dev/null @@ -1,22 +0,0 @@ -!----jv_mie.h-----COMMON BLOCKS for FAST-J code: 4x4x85 (prather 4/96) -! -! Parameters -! ---------- -! -! NL Maximum number of levels after insertion of extra Mie levels -! N__ Number of levels in Mie grid: 2*(2*lpar+2+jaddto(1))+3 -! M__ Number of Gauss points used -! -!----------------------------------------------------------------------- - INTEGER NL, N__, M__ - PARAMETER (NL=1000, N__=2*NL, M__=4) - REAL*8 A,B,C1,H,AA,CC,S,W,UX1,VX1,WT,EMU,PM,PM0,POMEGA - REAL*8 ZTAU,FZ,FJ,DD,RR,ZREFL,ZFLUX,RADIUS,ZU0 - INTEGER ND,N,M,MFIT - COMMON/MIEBLK/ A(M__),B(M__,M__),C1(M__),H(M__),AA(M__,M__), & - & CC(M__,M__),S(M__,M__),W(M__,M__),UX1(M__,M__),VX1(M__),WT(M__), & - & EMU(M__),PM(M__,2*M__),PM0(2*M__),POMEGA(2*M__,N__),ZTAU(N__), & - & FZ(N__),FJ(N__),DD(M__,M__,N__),RR(M__,N__), & - & ZREFL,ZFLUX,RADIUS,ZU0 - COMMON/MINDEX/ ND,N,M,MFIT -!----------------------------------------------------------------------- diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup.h deleted file mode 100644 index 53aabc40..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup.h +++ /dev/null @@ -1,39 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! Dan Bergmann, LLNL -! dbergmann@llnl.gov -! -! FILE -! phot_lookup.h -! -! DESCRIPTION -! This include file contains the declarations of the photolysis reaction -! numbers. -! -!============================================================================= - - -! ---------------------------------------------------- -! All of the declarations below are "read from table." -! ---------------------------------------------------- - - integer :: & - & num_qj_acet, & ! photolysis reaction number for ACET - & num_qj_ch2o, & ! photolysis reaction number for CH2O - & num_qj_hacn, & ! photolysis reaction number for HACN - & num_qj_mgly, & ! photolysis reaction number for MGLY - & num_qj_no, & ! photolysis reaction number for NO - & num_qj_o2, & ! photolysis reaction number for O2 - & n_qj_O3_2OH ! photolysis reaction number for O3 + hv = 2OH - - -! ==================== - common / gmipl_i1 / & -! ==================== - & num_qj_acet, num_qj_ch2o, num_qj_hacn, num_qj_mgly, & - & num_qj_no, num_qj_o2, n_qj_O3_2OH - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_arrays.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_arrays.h deleted file mode 100644 index 9a7a0a56..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_arrays.h +++ /dev/null @@ -1,77 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! Dan Bergmann, LLNL -! dbergmann@llnl.gov -! -! FILE -! phot_lookup_arrays.h -! -! DESCRIPTION -! This include file contains the declarations of the arrays for the -! photolysis lookup code. -! -! HISTORY -! * September 23, 2004 - Jules Kouatchou -! Introduced the variable "o1d_coef" needed for the combined -! strat/trop chemical mechanism. -! -!============================================================================= - - -! ------------------------------------------------------------------ -! o3_clim_prs : ozone climatology pressure coordinate (phot_opt=5) -! -! prs_phot : pressure values for lookup table -! sza_phot : solar zenith angle values for lookup table -! -! col_o3 : column ozone values for lookup table -! (which vary with pressure) -! -! no_qj : photolysis rates for NO -! o2_qj : photolysis rates for O2 -! -! cross_section : cross_sections for lookup table -! (as a function of temperature and wavelength) -! ------------------------------------------------------------------ - - real*8 :: o3_clim_prs(NUM_O3CLIM_PRS) - - real*8 :: prs_phot(NUMPRS) - real*8 :: sza_phot(NUMSZA) - - real*8 :: col_o3(NUMO3, NUMPRS) - - real*8 :: no_qj(NUMSZA, NUMO3, NUMPRS) - real*8 :: o2_qj(NUMSZA, NUMO3, NUMPRS) - - real*8 :: cross_section(NUMLAM, NUMTMP, MAX_NUMQJ_PL) - -! ===================== - common / gmipla_r1 / & -! ===================== - & o3_clim_prs, & - & prs_phot, sza_phot, & - & col_o3, & - & no_qj, o2_qj, & - & cross_section - - -! ------------------------------------------------------- -! o3_clim : ozone climatology (phot_opt=5) -! rad_source : radiative source function for lookup table -! o1d_coef : table of adjustment factors for O3 + hv -! ------------------------------------------------------- - - real*8, pointer :: o3_clim (:,:,:,:) - real*8, pointer :: rad_source(:,:,:,:) - real*8, pointer :: o1d_coef (:,:,:,:,:) - -! ===================== - common / gmipla_r2 / & -! ===================== - & o3_clim, rad_source, o1d_coef - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_constants.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_constants.h deleted file mode 100644 index 60fad7f9..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_lookup_constants.h +++ /dev/null @@ -1,68 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! Dan Bergmann, LLNL -! dbergmann@llnl.gov -! -! FILE -! phot_lookup_constants.h -! -! DESCRIPTION -! This include file contains the declarations of the constants for the -! photolysis lookup code. -! -!============================================================================= - - - integer, parameter :: & - & MAX_NUMQJ_PL = 200 ! maximum number of qj (photolysis) rxns - - integer, parameter :: & - & NUMLAM = 79, & ! number of "lambdas" (wavelengths) for the radiative - ! source function and the photolysis cross-sections - & NUMO3 = 12, & ! number of column ozone coords. in lookup table - & NUMPRS = 35, & ! number of pressure coords. in lookup table - & NUMSZA = 20, & ! number of solar zenith angle coords. in lookup table - & NUMTMP = 200 ! number of temperature values in lookup table - - integer, parameter :: & - & NUM_O3CLIM_MON = 12, & ! number of months in the ozone climatology - & NUM_O3CLIM_PRS = 30 ! number of pressures in the ozone climatology - - - real*8, parameter :: ACET_CONST_1(47:58) = & - & (/ 1.21363d+00, 1.46791d+00, 1.72995d+00, 2.78158d+00, & - & 4.88461d+00, 7.02881d+00, 9.17301d+00, 1.13172d+01, & - & 1.34614d+01, 1.34614d+01, 1.34614d+01, 1.34614d+01 /) - - real*8, parameter :: ACET_CONST_2(47:58) = & - & (/ 8.69881d-20, 1.70934d-19, 3.42893d-19, 5.63761d-19, & - & 7.02667d-19, 8.79584d-19, 1.10104d-18, 1.37826d-18, & - & 1.72528d-18, 1.72528d-18, 1.72528d-18, 1.72528d-18 /) - - - real*8, parameter :: CH2O_CONST_1(55:59) = & - & (/ 0.9679353d+00, 0.9943720d+00, 0.9990122d+00, 0.9998249d+00, & - & 0.9999690d+00 /) - - real*8, parameter :: CH2O_CONST_2(55:59) = & - & (/ 0.2069d+00, 0.4583d+00, 0.8421d+00, 1.5000d+00, 2.8889d+00 /) - - - real*8, parameter :: MGLY_CONST_1(53:76) = & - & (/ 0.000d+00, 0.000d+00, 0.000d+00, 0.000d+00, 0.000d+00, & - & 0.000d+00, 0.000d+00, 0.000d+00, 0.000d+00, 0.000d+00, & - & 0.000d+00, 0.000d+00, 1.109d+00, 1.406d+00, 1.772d+00, & - & 2.221d+00, 2.767d+00, 3.430d+00, 4.230d+00, 5.190d+00, & - & 6.337d+00, 7.702d+00, 9.320d+00, 1.123d+01 /) - - real*8, parameter :: MGLY_CONST_2(53:76) = & - & (/ 7.485d-21, 1.128d-20, 1.679d-20, 2.469d-20, 3.592d-20, & - & 5.170d-20, 7.364d-20, 1.039d-19, 1.452d-19, 2.010d-19, & - & 2.760d-19, 3.757d-19, 5.074d-19, 6.800d-19, 9.046d-19, & - & 1.195d-18, 1.567d-18, 2.042d-18, 2.645d-18, 3.403d-18, & - & 4.354d-18, 5.538d-18, 7.006d-18, 8.815d-18 /) - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_monthly.h b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_monthly.h deleted file mode 100644 index ad3f59cc..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/include/phot_monthly.h +++ /dev/null @@ -1,30 +0,0 @@ -!============================================================================= -! -! CODE DEVELOPER -! Huisheng bian, GSFC -! bian@code916.gsfc.nasa.gov -! -! FILE -! phot_monthly.h -! -! DESCRIPTION -! This include file contains the declarations of the arrays for the -! monthly photolysis rate. -! -! HISTORY -! -!============================================================================= - - -! ------------------------------------------------------------------ -! qjmon : monthly photolysis rate (phot_opt=2) -! -! ------------------------------------------------------------------ - - real*8, pointer :: qjmon (:,:,:,:,:) - -! ===================== - common / gmipr_mon / & -! ===================== - & qjmon - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/lookup/phot_lookup.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/lookup/phot_lookup.F90 deleted file mode 100644 index 3dcabc42..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/lookup/phot_lookup.F90 +++ /dev/null @@ -1,785 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! Dan Bergmann & John Tannahill, LLNL -! -! FILE -! phot_lookup.F -! -! ROUTINES -! Lookup_Qj -! -! HISTORY -! * September 23, 2004 - Jules Kouatchou -! Modifications to accomodate for the combined strat/trop chemical -! mechanism. New variables are: o1d_a, o1d_b, qj_adjust, o1d_T. -! New calculations are carried out to: -! - Interpolate the O(1D) correlation factor in solar zenith angle, -! column ozone, and pressure (see 1d_a, o1d_b, and o1d_T) -! - Nudge O3 photolysis to represent higher resolution around the -! O(1D) falloff region (308-328 nm) (see qj_adjust). -!============================================================================= - - -!----------------------------------------------------------------------------- -! -! ROUTINE -! Lookup_Qj -! -! DESCRIPTION -! This is the LLNL implementation of Randy Kawa's photolysis lookup table. -! It requires a NetCDF file which has the radiative source as a function -! of wavelength, pressure, column ozone, and solar zenith angle. This -! NetCDF file also contains cross sections as a function of species, -! temperature, and wavelength. -! -! ARGUMENTS -! do_clear_sky : do clear sky photolysis? -! phot_opt : photolysis option -! io3_num : const array index for ozone -! nymd : current year/month/day (YYYYMMDD) -! photintv : photolysis time step (s) -! rsec_jan1 : seconds from Jan. 1st (s) -! press3c : atmospheric pressure at the center of each grid box (mb) -! kel : temperature (degK) -! const : species concentration, known at zone centers (mixing ratio) -! latdeg : latitude (deg) -! mcor : area of grid box (m^2) -! mass : total mass of the atmosphere within each grid box (kg) -! fracCloudCover: fractional cloud cover -! qjgmi : photolysis rate constants (s^-1) -! -!----------------------------------------------------------------------------- - - subroutine Lookup_Qj (chem_mecha, do_clear_sky, phot_opt, io3_num, nymd, & - photintv, rsec_jan1, press3c, kel, concentration, & - solarZenithAngle, mcor, mass, fracCloudCover, qjgmi, & - pr_diag, loc_proc, num_species, num_qjs, num_qjo, & - ilo, ihi, julo, jhi, i1, i2, ju1, j2, k1, k2) - - use GmiInterpolation_mod , only : Interp - use GmiArrayBundlePointer_mod, only : t_GmiArrayBundle - use solar_cycle_mod - use GmiTimeControl_mod , only : GmiSplitDateTime - use GmiPrintError_mod, only : GmiPrintError - - implicit none - -# include "gmi_time_constants.h" -# include "gmi_phys_constants.h" -# include "phot_lookup_constants.h" -# include "phot_lookup.h" -# include "phot_lookup_arrays.h" - -! ---------------------- -! Argument declarations. -! ---------------------- - - CHARACTER(LEN=*), INTENT(IN) :: chem_mecha - logical, intent(in) :: pr_diag - integer, intent(in) :: loc_proc - integer, intent(in) :: num_species, num_qjs, num_qjo - integer, intent(in) :: ilo, ihi, julo, jhi - integer, intent(in) :: i1, i2, ju1, j2, k1, k2 - logical :: do_clear_sky - integer :: phot_opt - integer :: io3_num - integer :: nymd - real*8 :: photintv - real*8 :: rsec_jan1 - real*8 :: press3c (ilo:ihi, julo:jhi, k1:k2) - real*8 :: kel (ilo:ihi, julo:jhi, k1:k2) - real*8 :: solarZenithAngle (i1:i2, ju1:j2) - real*8 :: mcor (i1:i2, ju1:j2) - real*8 :: mass (i1:i2, ju1:j2, k1:k2) - real*8 , intent(in ) :: fracCloudCover(i1:i2, ju1:j2) - type (t_GmiArrayBundle) :: qjgmi(num_qjo) - type (t_GmiArrayBundle), intent(in) :: concentration(num_species) - - -! ---------------------- -! Variable declarations. -! ---------------------- - - character (len=75) :: err_msg - - logical, save :: first = .true. - - integer :: idumday, idumyear - integer :: iik, ilam, io3 - integer :: isza - integer :: il, ij, ik, iq - integer :: month - integer :: o3_pl_ind, o3_ph_ind - integer :: o3_pl_indp1, o3_ph_indp1 - integer :: p_ind, p_ind_old, p_indm1 - integer :: sza_ind, t_index -!... variable containing index corresponding to current model year/month, -!... repeats last 11 years after 2001 - integer :: iscyr - integer :: inyr, inmon - - real*8 :: days - real*8 :: decl - real*8 :: half_the_box - real*8 :: loc_col_o3 - real*8 :: o3_ph_frac, o3_pl_frac - real*8 :: p_frac - real*8 :: rdistsq, ri2_gl, ril - real*8 :: stime_loc, time - real*8 :: sza, sza_frac - real*8 :: total - - real*8, save :: cos94 - - real*8 :: cossza(1) - real*8 :: loc_col_o3ary(1) - real*8 :: minary(1) - - real*8 :: rsf(NUMLAM) - - real*8, save :: lon_dummy(1) = 0.0d0 - - real*8 :: o1d_a, o1d_b, qj_adjust - real*8 :: o1d_T(5) - -! ---------------- -! Begin execution. -! ---------------- - - if (pr_diag) then - Write (6,*) 'Lookup_Qj called by ', loc_proc - end if - - -! ========== - if (first) then -! ========== - - first = .false. - - cos94 = Cos (RADPDEG * 94.0d0) - - end if - -!... figure out index for solar cycle array from year and month - inyr = int(nymd/10000) - inmon = int(nymd/100)-100*inyr - if(inyr.ge.70) then - iscyr = 12*(inyr-47)+inmon - else - iscyr = 12*(inyr+100-47)+inmon - endif -!... recycle last 11 years if beyond end of data - DO WHILE ((iscyr.gt.NUM_SOLAR_CYC_MON)) - iscyr = iscyr-11*12 - enddo -!... recycle previous 11 years if before beginning of data - DO WHILE ((iscyr.lt.1)) - iscyr = iscyr+11*12 - enddo - if (pr_diag) then - print *,'Solar cycle debug: ',iscyr, loc_proc,s_cycle(3,iscyr) - end if - - - time = rsec_jan1 + (0.5d0 * photintv) - -! ri2_gl = i2_gl - - call GmiSplitDateTime (nymd, idumyear, month, idumday) - - -! ====================== - illoop: do il = i1, i2 -! ====================== - -! ril = il -! -! stime_loc = time + (SECPDY * (ril - 1.0d0) / ri2_gl) -! -! days = stime_loc / SECPDY -! -!! ============ -! call Solrpos & -!! ============ -! & (days, decl, rdistsq) - - -! ======================= - ijloop: do ij = ju1, j2 -! ======================= - -! ----------------------------------------------- -! Calculate solar zenith angle and index into the -! radiative source function table. -! ----------------------------------------------- - -!! =========== -! call Solrza & -!! =========== -! & (days, decl, latdeg(ij), lon_dummy, 1, cossza) - - cossza(1) = cos(solarZenithAngle(il,ij)) - - -! --------------------------------------------------------- -! If the solar zenith angle exceeds 94 degrees, set all qjs -! to zero and exit loop. -! --------------------------------------------------------- - - if (cossza(1) < cos94) then - - do ik = k1, k2 - do iq = 1, num_qjs - qjgmi(iq)%pArray3D(il,ij,ik) = 0.0d0 - end do - end do - -! ============ - cycle ijloop -! ============ - - end if - - - sza = Acos (cossza(1)) / RADPDEG - - isza_loop: do isza = 2, NUMSZA - - if (sza <= sza_phot(isza)) then - - sza_ind = isza - 1 - -! ============== - exit isza_loop -! ============== - - end if - - if (isza == NUMSZA) then - err_msg = & - & 'Error finding solar zenith angle index in Lookup_Qj.' - call GmiPrintError & - & (err_msg, .true., 0, 0, 0, 0, 0.0d0, 0.0d0) - end if - - end do isza_loop - - - sza_frac = (sza_phot(sza_ind+1) - sza) / & - & (sza_phot(sza_ind+1) - sza_phot(sza_ind)) - - -! --------------------------------------------------- -! Initialize pressure index into the radiative source -! function table. -! --------------------------------------------------- - - p_ind = NUMPRS - - loc_col_o3 = 0.0d0 - - -! ========================== - ikloop: do ik = k2, k1, -1 -! ========================== - - if (phot_opt == 5) then - -! ------------------------------------------------- -! Find the column ozone from the climatology in the -! lookup table. -! ------------------------------------------------- - - minary(1) = Min (press3c(il,ij,ik), o3_clim_prs(1)) - - loc_col_o3ary(1) = loc_col_o3 - -! =========== - call Interp & -! =========== - & (o3_clim_prs(:), o3_clim(:,il,ij,month), NUM_O3CLIM_PRS, & - & minary(:), loc_col_o3ary(:), 1) - - loc_col_o3 = loc_col_o3ary(1) - - else - -! ----------------------- -! Calculate column ozone. -! ----------------------- - - half_the_box = & - & 0.5d0 * concentration(io3_num)%pArray3D(il,ij,ik) * mass(il,ij,ik) * & - & AVOGAD / (mcor(il,ij) * MWTAIR * 10.0d0) - - loc_col_o3 = loc_col_o3 + half_the_box - - end if - - -! ------------------------------------- -! Find new pressure index in the table. -! ------------------------------------- - - p_ind_old = p_ind - - iik_loop: do iik = p_ind_old, 1, -1 - - p_indm1 = iik - - if (prs_phot(iik) >= press3c(il,ij,ik)) then -! ============= - exit iik_loop -! ============= - end if - - end do iik_loop - - - if (p_indm1 == 1) then - - p_frac = 0.0d0 - p_ind = p_indm1 - - else if (p_indm1 == NUMPRS) then - - p_frac = 1.0d0 - p_ind = NUMPRS - - else - - p_ind = p_indm1 + 1 - p_frac = (prs_phot(p_indm1) - press3c(il,ij,ik)) / & - & (prs_phot(p_indm1) - prs_phot(p_ind)) - - end if - - -! ----------------------------------------------------------- -! Find new column ozone indices in the table for both -! pressure levels surrounding the pressure for this grid box. -! ----------------------------------------------------------- - - io3_loop1: do io3 = 2, NUMO3 - - if (loc_col_o3 < col_o3(io3, p_ind)) then - - o3_pl_ind = io3 - 1 - o3_pl_indp1 = io3 - - o3_pl_frac = & - & (col_o3(o3_pl_indp1,p_ind) - loc_col_o3) / & - & (col_o3(o3_pl_indp1,p_ind) - col_o3(o3_pl_ind,p_ind)) - - o3_pl_frac = Max (o3_pl_frac, 0.0d0) - -! ============== - exit io3_loop1 -! ============== - - end if - - if (io3 == NUMO3) then - o3_pl_ind = NUMO3 - o3_pl_indp1 = NUMO3 - o3_pl_frac = 1.0d0 - end if - - end do io3_loop1 - - - io3_loop2: do io3 = 2, NUMO3 - - if (loc_col_o3 < col_o3(io3,p_indm1)) then - - o3_ph_ind = io3 - 1 - o3_ph_indp1 = io3 - - o3_ph_frac = & - & (col_o3(o3_ph_indp1,p_indm1) - loc_col_o3) / & - & (col_o3(o3_ph_indp1,p_indm1) - & - & col_o3(o3_ph_ind,p_indm1)) - - o3_ph_frac = Max (o3_ph_frac, 0.0d0) - -! ============== - exit io3_loop2 -! ============== - - end if - - if (io3 == NUMO3) then - o3_ph_ind = NUMO3 - o3_ph_indp1 = NUMO3 - o3_ph_frac = 1.0d0 - end if - - end do io3_loop2 - - -! -------------------------------------------------- -! Interpolate the radiative source function in solar -! zenith angle, column ozone, and pressure. -! -------------------------------------------------- - - do ilam = 1, NUMLAM - - rsf(ilam) = & - & sza_frac * & - & (p_frac * & - & ((o3_pl_frac) * & - & rad_source(ilam,sza_ind,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & rad_source(ilam,sza_ind,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & rad_source(ilam,sza_ind,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & rad_source(ilam,sza_ind,o3_ph_indp1,p_indm1))) + & - & (1.0d0 - sza_frac) * & - & (p_frac * & - & ((o3_pl_frac) * & - & rad_source(ilam,sza_ind+1,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & rad_source(ilam,sza_ind+1,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & rad_source(ilam,sza_ind+1,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & rad_source(ilam,sza_ind+1,o3_ph_indp1,p_indm1))) - - end do - - if (TRIM(chem_mecha) == 'strat_trop' .OR. TRIM(chem_mecha) == 'strat_trop_aerosol') then - -! -------------------------------------------------- -! Interpolate the O(1D) correlation factor in solar -! zenith angle, column ozone, and pressure. -! -------------------------------------------------- - - do ilam = 1, 5 - - o1d_a = & - & sza_frac * & - & (p_frac * & - & ((o3_pl_frac) * & - & o1d_coef(ilam,sza_ind,o3_pl_ind,p_ind,1) + & - & (1.0d0 - o3_pl_frac) * & - & o1d_coef(ilam,sza_ind,o3_pl_indp1,p_ind,1)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o1d_coef(ilam,sza_ind,o3_ph_ind,p_indm1,1) + & - & (1.0d0 - o3_ph_frac) * & - & o1d_coef(ilam,sza_ind,o3_ph_indp1,p_indm1,1))) + & - & (1.0d0 - sza_frac) * & - & (p_frac * & - & ((o3_pl_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_pl_ind,p_ind,1) + & - & (1.0d0 - o3_pl_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_pl_indp1,p_ind,1)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_ph_ind,p_indm1,1) + & - & (1.0d0 - o3_ph_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_ph_indp1,p_indm1,1))) - - o1d_b = & - & sza_frac * & - & (p_frac * & - & ((o3_pl_frac) * & - & o1d_coef(ilam,sza_ind,o3_pl_ind,p_ind,2) + & - & (1.0d0 - o3_pl_frac) * & - & o1d_coef(ilam,sza_ind,o3_pl_indp1,p_ind,2)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o1d_coef(ilam,sza_ind,o3_ph_ind,p_indm1,2) + & - & (1.0d0 - o3_ph_frac) * & - & o1d_coef(ilam,sza_ind,o3_ph_indp1,p_indm1,2))) + & - & (1.0d0 - sza_frac) * & - & (p_frac * & - & ((o3_pl_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_pl_ind,p_ind,2) + & - & (1.0d0 - o3_pl_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_pl_indp1,p_ind,2)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_ph_ind,p_indm1,2) + & - & (1.0d0 - o3_ph_frac) * & - & o1d_coef(ilam,sza_ind+1,o3_ph_indp1,p_indm1,2))) - - o1d_T(ilam) = o1d_a + (kel(il,ij,ik) - 298.0d0) * o1d_b - - end do - end if - -! ------------------------------------------- -! Interpolate the O2 photolysis rate in solar -! zenith angle, column ozone, and pressure. -! ------------------------------------------- -!... weighted by solar_cycle in bin 3 of wavelength bins (primarily 185-220 nm) - if (num_qj_o2 /= 0) then - - qjgmi(num_qj_o2)%pArray3D(il,ij,ik) = & - & sza_frac * s_cycle(3,iscyr) * & - & (p_frac * & - & ((o3_pl_frac) * & - & o2_qj(sza_ind,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & o2_qj(sza_ind,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o2_qj(sza_ind,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & o2_qj(sza_ind,o3_ph_indp1,p_indm1))) + & - & (1.0d0 - sza_frac) * & - & (p_frac * & - & ((o3_pl_frac) * & - & o2_qj(sza_ind+1,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & o2_qj(sza_ind+1,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & o2_qj(sza_ind+1,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & o2_qj(sza_ind+1,o3_ph_indp1,p_indm1))) - - end if - - -! ------------------------------------------- -! Interpolate the NO photolysis rate in solar -! zenith angle, column ozone, and pressure. -! ------------------------------------------- -!... weighted by solar_cycle in bin 6 of wavelength bins (primarily 190.9 and -!... 182.7 nm) in the middle atmosphere, best fit to average of bin 5 and 10. - - if (num_qj_no /= 0) then - - qjgmi(num_qj_no)%pArray3D(il,ij,ik) = & - & sza_frac * s_cycle(6,iscyr) * & - & (p_frac * & - & ((o3_pl_frac) * & - & no_qj(sza_ind,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & no_qj(sza_ind,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & no_qj(sza_ind,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & no_qj(sza_ind, o3_ph_indp1,p_indm1))) + & - & (1.0d0 - sza_frac) * & - & (p_frac * & - & ((o3_pl_frac) * & - & no_qj(sza_ind+1,o3_pl_ind,p_ind) + & - & (1.0d0 - o3_pl_frac) * & - & no_qj(sza_ind+1,o3_pl_indp1,p_ind)) + & - & (1.0d0 - p_frac) * & - & ((o3_ph_frac) * & - & no_qj(sza_ind+1,o3_ph_ind,p_indm1) + & - & (1.0d0 - o3_ph_frac) * & - & no_qj(sza_ind+1,o3_ph_indp1,p_indm1))) - - end if - - -! ------------------------------------------------------ -! Calculate the temperature index into the cross section -! data which lists coss sections for temperatures from -! 150 to 349 degrees K. Make sure the index is a value -! between 1 and 200. -! ------------------------------------------------------ - - t_index = kel(il,ij,ik) - 148.5d0 - - t_index = Min (200, Max (t_index, 1)) - - -! ------------------------------------------------------------------ -! For each species, integrate over the wavelengths to -! calculate a qj. -! -! There are special cases for: -! oxygen : photolytic rxn, O2 + hv = O + O -! nitric oxide : photolytic rxn, NO + hv = N + O -! formaldehyde : photolytic rxn, CH2O + hv = CO + H2 -! acetone : photolytic rxn, ACET + hv = MCO3 + MO2 -! methyl glyoxal : photolytic rxn, MGLY + hv = MCO3 + HO2 + CO -! hydroxy acetone : photolytic rxn, HACN + hv = MCO3 + HCHO + HO2 -! ------------------------------------------------------------------ - - do iq = 1, num_qjs - - if ((iq /= num_qj_o2) .and. (iq /= num_qj_no)) then - - total = 0.0d0 - - do ilam = 1, NUMLAM - - total = total + & - & (rsf(ilam) * s_cycle(ilam,iscyr) * & - & cross_section(ilam,t_index,iq)) - - end do - - qjgmi(iq)%pArray3D(il,ij,ik) = total - - end if - - end do - - if (TRIM(chem_mecha) == 'strat_trop' .OR. TRIM(chem_mecha) == 'strat_trop_aerosol') then -! -------------------------------------------------- -! Nudge O3 photolysis to represent higher resolution -! around the O(1D) falloff region (308-328 nm). -! -------------------------------------------------- - - qj_adjust = sum( rsf(49:53) * s_cycle(49:53,iscyr) * & - & cross_section(49:53,t_index,3) * & - & (o1d_T(:) - 1.0d0) & - & ,DIM = 1) - - qjgmi(2)%pArray3D(il,ij,ik) = qjgmi(2)%pArray3D(il,ij,ik) - qj_adjust - qjgmi(3)%pArray3D(il,ij,ik) = qjgmi(3)%pArray3D(il,ij,ik) + qj_adjust - end if - -! -------------------------------------------------- -! Patch up the pressure dependent quantum yields for -! formaldehyde (CH2O) photolytic reaction. -! -------------------------------------------------- - - if (num_qj_ch2o /= 0) then - - do ilam = 55, 59 - - qjgmi(num_qj_ch2o)%pArray3D(il,ij,ik) = & - & qjgmi(num_qj_ch2o)%pArray3D(il,ij,ik) - & - & ((rsf(ilam) * s_cycle(ilam,iscyr) * & - & cross_section(ilam,t_index,num_qj_ch2o)) * & - & (1.0d0 - CH2O_CONST_1(ilam) / & - & (1.0d0 + (press3c(il,ij,ik) / 1013.25d0) * & - & CH2O_CONST_2(ilam)))) - - end do - - end if - - -! ------------------------------------------------------------- -! Patch up the pressure dependent quantum yields for -! acetone (ACET) or hydroxy acetone (HACN) photolytic reaction. -! ------------------------------------------------------------- - - if (num_qj_acet /= 0) then - - do ilam = 47, 58 - - qjgmi(num_qj_acet)%pArray3D(il,ij,ik) = & - & qjgmi(num_qj_acet)%pArray3D(il,ij,ik) - & - & ((rsf(ilam) * s_cycle(ilam,iscyr) * & - & cross_section(ilam,t_index,num_qj_acet)) * & - & (1.0d0 - & - & (1.0d0 / & - & (ACET_CONST_1(ilam) + & - & ACET_CONST_2(ilam) * press3c(il,ij,ik) / & - & (kel(il,ij,ik) * BOLTZMN_E * BPMB))))) - - end do - - end if - - if (num_qj_hacn /= 0) then - - do ilam = 47, 58 - - qjgmi(num_qj_hacn)%pArray3D(il,ij,ik) = & - & qjgmi(num_qj_hacn)%pArray3D(il,ij,ik) - & - & ((rsf(ilam) * s_cycle(ilam,iscyr) * & - & cross_section(ilam,t_index,num_qj_hacn)) * & - & (1.0d0 - & - & (1.0d0 / & - & (ACET_CONST_1(ilam) + & - & ACET_CONST_2(ilam) * press3c(il,ij,ik) / & - & (kel(il,ij,ik) * BOLTZMN_E * BPMB))))) - - end do - - end if - - -! -------------------------------------------------- -! Patch up the pressure dependent quantum yields for -! methyl glyoxal (MGLY) photolytic reaction. -! -------------------------------------------------- - - if (num_qj_mgly /= 0) then - - do ilam = 53, 76 - - qjgmi(num_qj_mgly)%pArray3D(il,ij,ik) = & - & qjgmi(num_qj_mgly)%pArray3D(il,ij,ik) - & - & ((rsf(ilam) * s_cycle(ilam,iscyr) * & - & cross_section(ilam,t_index,num_qj_mgly)) * & - & (1.0d0 - & - & (1.0d0 / & - & (MGLY_CONST_1(ilam) + & - & MGLY_CONST_2(ilam) * press3c(il,ij,ik) / & - & (kel(il,ij,ik) * BOLTZMN_E * BPMB))))) - - end do - - end if - - -! ------------------------------------------------ -! Add in the bottom half of this box to the column -! ozone calculation. -! ------------------------------------------------ - - if (phot_opt /= 5) then - loc_col_o3 = loc_col_o3 + half_the_box - end if - -! ============= - end do ikloop -! ============= - -! ============= - end do ijloop -! ============= - -! ============= - end do illoop -! ============= - - -! ----------------------------------------------------------------------- -! Check to see if cloud fractions should be used to attenuate the -! photolysis rate constants. If so, calculate a clear sky fraction (csf). -! ----------------------------------------------------------------------- - - if (.not. do_clear_sky) then - - do ik = k1, k2 - - do iq = 1, num_qjs - - qjgmi(iq)%pArray3D(:,:,ik) = & - & qjgmi(iq)%pArray3D(:,:,ik) * & - & (0.5d0 * fracCloudCover(:,:) + 0.5d0) - - end do - - end do - - end if - - - return - - end - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrpos.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrpos.F90 deleted file mode 100644 index 4930c3f3..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrpos.F90 +++ /dev/null @@ -1,99 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! John Tannahill, LLNL (Original code from Keith Grant, LLNL) -! jrt@llnl.gov -! -! FILE -! solrpos.F -! -! ROUTINES -! Solrpos -! -!============================================================================= - - -!----------------------------------------------------------------------------- -! -! ROUTINE -! Solrpos -! -! DESCRIPTION -! Given the Julian day, this routine calculates the solar declination and -! the square of the ratio of the mean Earth-Sun distance to the current -! Earth-Sun distance. Refer to: Paltridge, G.W., and C.M.R. Platt, 1976: -! "Radiative Processes in Meteorology and Climatology", Elsevier, pp. 57-63. -! -! ARGUMENTS -! julday : Julian day counting ranging from 0 on Jan. 1st to 364 on -! Dec. 31st -! decl : solar declination (deg) -! rdistsq : the square of the ratio of the mean Earth-Sun distance -! to the current Earth-Sun distance -! -!----------------------------------------------------------------------------- - - subroutine Solrpos & - & (julday, decl, rdistsq) - - implicit none - -# include "gmi_phys_constants.h" - - -! ---------------------- -! Argument declarations. -! ---------------------- - - real*8 :: julday - real*8 :: decl - real*8 :: rdistsq - - -! ----------------------- -! Parameter declarations. -! ----------------------- - - real*8, parameter :: TWO_PI = 2.0d0 * GMI_PI - - -! ---------------------- -! Variable declarations. -! ---------------------- - - real*8 :: theta ! year angle on specified day - real*8 :: theta2, theta3 - - -! ---------------- -! Begin execution. -! ---------------- - -!c? Leap year? - theta = (TWO_PI * julday) / 365.0d0 - - theta2 = 2.0d0 * theta - theta3 = 3.0d0 * theta - - - decl = & - & (360.0d0 / TWO_PI) * & - & (0.006918d0 - & - & 0.399912d0 * Cos (theta) + 0.070257d0 * Sin (theta) - & - & 0.006758d0 * Cos (theta2) + 0.000907d0 * Sin (theta2) - & - & 0.002697d0 * Cos (theta3) + 0.001480d0 * Sin (theta3)) - - - rdistsq = & - & 1.000110d0 + & - & 0.034221d0 * Cos (theta) + 0.001280d0 * Sin (theta) + & - & 0.000719d0 * Cos (theta2) + 0.000077d0 * Sin (theta2) - - - return - - end - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrza.F90 b/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrza.F90 deleted file mode 100644 index bb3bec4e..00000000 --- a/GMIchem_GridComp/GMI_GridComp/GmiChemistry/photolysis/utils/solrza.F90 +++ /dev/null @@ -1,108 +0,0 @@ - -!============================================================================= -! -! $Id$ -! -! CODE DEVELOPER -! John Tannahill, LLNL (Original code from Keith Grant, LLNL) -! jrt@llnl.gov -! -! FILE -! solrza.F -! -! ROUTINES -! Solrza -! -!============================================================================= - - -!----------------------------------------------------------------------------- -! -! ROUTINE -! Solrza -! -! DESCRIPTION -! Given a Greenwich time, a solar declination and reference latitude and -! longitudes, this routine returns a corresponding list of cosines of solar -! zenith angles. Refer to: Paltridge, G.W., and C.M.R. Platt, 1976: -! "Radiative Processes in Meteorology and Climatology", Elsevier, p. 62. -! -! ARGUMENTS -! time : Greenwich time since Jan 1, counting zero from midnight (days) -! decl : solar declination (deg) -! lat : latitude (deg) -! lon : longitudes (deg) -! nn : number of longitudes for which to calculate cosines of the -! solar zenith angle -! cossza : cosines of the solar zenith angle (output) -! -!----------------------------------------------------------------------------- - - subroutine Solrza & - & (time, decl, lat, lon, nn, cossza) - - implicit none - -# include "gmi_phys_constants.h" - - -! ---------------------- -! Argument declarations. -! ---------------------- - - integer :: nn - real*8 :: time - real*8 :: decl - real*8 :: lat - real*8 :: lon (nn) - real*8 :: cossza(nn) - - -! ----------------------- -! Parameter declarations. -! ----------------------- - - real*8, parameter :: TWO_PI = 2.0d0 * GMI_PI - real*8, parameter :: PI_180 = TWO_PI / 360.0d0 - - -! ---------------------- -! Variable declarations. -! ---------------------- - - integer :: ii - - real*8 :: cosha - - -! ---------------- -! Begin execution. -! ---------------- - - do ii = 1, nn - -! ------------------------------------------------------------- -! Calculate the cosine of the hour angle which is referenced to -! noon. -! ------------------------------------------------------------- - - cosha = & - & Cos (TWO_PI * & - & (Mod (time + (lon(ii) / 360.d0), 1.0d0) - 0.5d0)) - - -! ----------------------------------------------- -! Calculate the cosine of the solar zenith angle. -! ----------------------------------------------- - - cossza(ii) = & - & Sin (PI_180 * lat) * Sin (PI_180 * decl) + & - & Cos (PI_180 * lat) * Cos (PI_180 * decl) * cosha - - end do - - - return - - end - diff --git a/GMIchem_GridComp/GMI_GridComp/GmiPhotolysis_GridCompClassMod.F90 b/GMIchem_GridComp/GMI_GridComp/GmiPhotolysis_GridCompClassMod.F90 index a3a081ea..d3245ce0 100755 --- a/GMIchem_GridComp/GMI_GridComp/GmiPhotolysis_GridCompClassMod.F90 +++ b/GMIchem_GridComp/GMI_GridComp/GmiPhotolysis_GridCompClassMod.F90 @@ -30,7 +30,6 @@ MODULE GmiPhotolysis_GCCMod use GmiStateFieldESMF_mod, ONLY : initDataInStateField use GmiSwapSpeciesBundlesMod, ONLY : SwapSpeciesBundles, speciesReg_for_CCM USE GmiFastJX_includeMod, ONLY : t_fastJXbundle - USE GmiFastJX_ParametersMod, ONLY : NW IMPLICIT NONE INTEGER, PARAMETER :: DBL = KIND(0.00D+00) @@ -42,6 +41,7 @@ MODULE GmiPhotolysis_GCCMod #include "setkin_lchem.h" #include "gmi_AerDust_const.h" #include "gmi_time_constants.h" +#include "parm_MIE_fastJX65.h" ! !TYPES: PRIVATE @@ -244,19 +244,14 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, USE GmiTimeControl_mod, ONLY : Set_begGmiDate, Set_begGmiTime USE GmiTimeControl_mod, ONLY : Set_numTimeSteps use GmiCheckNamelistFile_mod, only : CheckNamelistOptionRange - use fastj , only : InitializeFastj - use fast_JX , only : InitializeFastJX - use Fast_JX53b , only : InitializeFastJX53b - use Fast_JX53c , only : InitializeFastJX53c - use fastJX65_mod, only : initializeFastJX65 - use CloudJ_mod, only : initializeFastJX74 - USE ReadSolarCycle_mod, ONLY : readSolarCycleData +! + use fastJX65_mod, only : initializeFastJX65 + use CloudJ_mod, only : initializeFastJX74 + USE ReadSolarCycle_mod, ONLY : readSolarCycleData IMPLICIT none INTEGER, PARAMETER :: DBL = KIND(0.00D+00) -# include "phot_lookup.h" -# include "phot_monthly.h" ! ! !INPUT PARAMETERS: ! @@ -305,11 +300,11 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, INTEGER :: gmi_nborder INTEGER :: numSpecies INTEGER :: inyr,inmon,iscyr +! REAL, dimension(2628) :: s_cycle_dates ! 2628 months : 1882 - 2100 - REAL, dimension(NW,2628) :: s_cycle ! 2628 months : 1882 - 2100 + REAL, dimension(W_ ,2628) :: s_cycle ! 2628 months : 1882 - 2100 REAL(r8), POINTER :: fjx_solar_cycle_param(:) - INTEGER :: loc_proc, locGlobProc, commu_slaves LOGICAL :: one_proc, rootProc LOGICAL :: found @@ -424,14 +419,8 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, ! 0: no photolysis ! 1: set all qj values to qj_init_val ! 2: read in qj values -! 3: use fastj routine (for fastJ, fastJx, fastJx53b) +! 3: use fastj routine (for fastJX, CloudJ) ! This option should be combined with fastj_opt. -! 4: lookup table for qj (Kawa style) -! 5: lookup table for qj (Kawa style) + -! use ozone climatology for column ozone calc. -! 6: calculate from table and Gmimod data (Quadchem) -! 7: read in qj values (2-D, 12 months) -! 8: use fast-JX routine (troposphere/stratosphere) ! ----------------------------------------------------- call ESMF_ConfigGetAttribute(gmiConfigFile, self%phot_opt, & @@ -441,17 +430,13 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, ! ----------------------------------------------------- ! fastj_opt: set when phot_opt=3 -! 0: FastJ -! 1: FastJx (supported) -! 2: FastJx 5.3b -! 3: FastJx 5.3c ! 4: FastJx 6.5 (supported) ! 5: CloudJ (supported) (FastJX 7.4) ! ----------------------------------------------------- call ESMF_ConfigGetAttribute(gmiConfigFile, self%fastj_opt, & & label = "fastj_opt:", & - & default = 1, rc=STATUS ) + & default = 4, rc=STATUS ) VERIFY_(STATUS) call ESMF_ConfigGetAttribute(gmiConfigFile, value=self%do_clear_sky, label="do_clear_sky:", & @@ -689,7 +674,7 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, VERIFY_(STATUS) call CheckNamelistOptionRange ('phot_opt', self%phot_opt, 0, 7) - call CheckNamelistOptionRange ('fastj_opt', self%fastj_opt, 0, 5) + call CheckNamelistOptionRange ('fastj_opt', self%fastj_opt, 4, 5) call CheckNamelistOptionRange ('AerDust_Effect_opt', self%AerDust_Effect_opt, 0, 3) self%num_qjs = NUM_J @@ -854,22 +839,22 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, CALL Set_numTimeSteps(self%gmiClock, 0) !... solar cycle parameter - if(self%do_solar_cycle) then + if(self%do_solar_cycle) then - CALL readSolarCycleData( s_cycle_dates, s_cycle, self%sc_infile_name ) + CALL readSolarCycleData( s_cycle_dates, s_cycle, self%sc_infile_name ) !... figure out index for solar cycle array from year and month - inyr = int(nymd/10000) - inmon = int(nymd/100)-100*inyr - iscyr = nint(((inyr+inmon/12.0)-s_cycle_dates(1))*12.)+1 - - IF( MAPL_AM_I_ROOT() ) THEN - PRINT *,"Solar cycle: ",s_cycle_dates(iscyr),s_cycle(:,iscyr) - ENDIF - self%JXbundle%fjx_solar_cycle_param(:) = s_cycle(:,iscyr) - else - self%JXbundle%fjx_solar_cycle_param(:) = 1.000 - endif + inyr = int(nymd/10000) + inmon = int(nymd/100)-100*inyr + iscyr = nint(((inyr+inmon/12.0)-s_cycle_dates(1))*12.)+1 + + IF( MAPL_AM_I_ROOT() ) THEN + PRINT *,"Solar cycle: ",s_cycle_dates(iscyr),s_cycle(:,iscyr) + ENDIF + self%JXbundle%fjx_solar_cycle_param(:) = s_cycle(:,iscyr) + else + self%JXbundle%fjx_solar_cycle_param(:) = 1.000 + endif ! Grid box surface area, m^{2} ! ---------------------------- @@ -971,33 +956,6 @@ SUBROUTINE GmiPhotolysis_GridCompInitialize( self, w_c, impChem, expChem, nymd, select case (self%fastj_opt) !=========================== - !======= - case (0) - !======= - call InitializeFastJ (self%cross_section_file, self%rate_file, & - & self%T_O3_climatology_file, n_qj_O3_2OH, & - & NUM_J, self%chem_mask_khi, k2, k1) - !======= - case (1) - !======= - call InitializeFastJX (self%JXbundle, self%cross_section_file, & - self%rate_file, & - & self%T_O3_climatology_file, rootProc, & - & n_qj_O3_2OH, NUM_J, self%chem_mask_khi, k2, k1) - !======= - case (2) - !======= - call InitializeFastJX53b (k1, k2, self%chem_mask_khi, & - & NUM_J, self%cross_section_file, & - & self%scattering_data_file, self%rate_file, & - & self%T_O3_climatology_file) - !======= - case (3) - !======= - call InitializeFastJX53c (k1, k2, self%chem_mask_khi, & - & NUM_J, self%cross_section_file, & - & self%scattering_data_file, self%rate_file, & - & self%T_O3_climatology_file) !======= case (4) !======= diff --git a/Shared/Chem_Shared/WetRemovalMod.F90 b/Shared/Chem_Shared/WetRemovalMod.F90 index f13ece25..5a26f153 100644 --- a/Shared/Chem_Shared/WetRemovalMod.F90 +++ b/Shared/Chem_Shared/WetRemovalMod.F90 @@ -228,7 +228,7 @@ subroutine WetRemovalGOCART ( i1, i2, j1, j2, km, n1, n2, cdt, aero_type, kin, & ! next level, where a fraction could be re-evaporated to gas phase ! if Qls is less then 0 in that level. !----------------------------------------------------------------------------- - if (qls(k) .gt. 0.) then + if (qls(k) .gt. tiny(0.)) then F = F0_ls / (1. + F0_ls*B0_ls*XL_ls/(qls(k)*cdt/Td_ls)) k_rain = B0_ls/F0_ls +1./(F0_ls*XL_ls/qls(k)) if ( kin ) then ! Aerosols