From 629a6fb511a738aded01367759a7368e000a4ad1 Mon Sep 17 00:00:00 2001 From: Isaac Rowe Date: Wed, 24 Feb 2021 00:25:21 -0500 Subject: [PATCH] Add Montornes's solar eclipse modelling (#1285) MIME-Version: 1.0 Content-Type: text/plain; charset=UTF-8 Content-Transfer-Encoding: 8bit TYPE: new feature KEYWORDS: radiation, eclipse SOURCE: Isaac Rowe (University of Kentucky); original source: Alex Montornès (University of Barcelona), internal DESCRIPTION OF CHANGES: Alex Montornès developed a modification to the radiation schemes for WRF 3.6 to model the effect of eclipse based on the Bessel's method. This PR aims to bring the work back into the latest version of WRF for four shortwave schemes: RRTMG, Dudhia, Goddard, and old Goddard. LIST OF MODIFIED FILES: Makefile Registry/Registry.EM_COMMON Registry/Registry.NMM clean dyn_em/module_first_rk_step_part1.F dyn_nmm/module_PHYSICS_CALLS.F phys/Makefile phys/module_ra_eclipse.F phys/module_ra_goddard.F phys/module_ra_gsfcsw.F phys/module_ra_rrtmg_sw.F phys/module_ra_sw.F phys/module_radiation_driver.F run/eclipse_besselian_elements.dat run/README.namelist share/module_check_a_mundo.F TESTS CONDUCTED: 1. Jenkins tests all passed. 2. The model is run with and without the eclipse mods for the August 2017 eclipse event over US. A figure is shown below: the left is SWDOWN valid at 1800 UTC without eclipse mod, and right is with eclipse mod: ![eclipse](https://user-images.githubusercontent.com/12705680/108938290-0d9d5800-760d-11eb-80b8-6c6229156741.png) RELEASE NOTE: Add a new option (ra_sw_eclipse) to model the effect of eclipses based on the the Bessel's method in four radiation schemes: RRTMG, Dudhia, Goddard, and old Goddard. Additional output includes the location of the eclipse: ELAT_TRACK and ELON_TRACK. For reference, see this paper: Montornès, A., Codina, B., Zack, J. W., and Sola, Y.: Implementation of Bessel's method for solar eclipses prediction in the WRF-ARW model, Atmos. Chem. Phys., 16, 5949–5967, https://doi.org/10.5194/acp-16-5949-2016, 2016. (Thanks to Alex Montornès of University of Barcelona and Issac Rowe of University of Kentucky.) --- Makefile | 3 + Registry/Registry.EM_COMMON | 6 + Registry/Registry.NMM | 2 + clean | 1 + dyn_em/module_first_rk_step_part1.F | 5 +- dyn_nmm/module_PHYSICS_CALLS.F | 1 + phys/Makefile | 1 + phys/module_ra_eclipse.F | 439 ++++++++++++++++++++++++++++ phys/module_ra_goddard.F | 21 +- phys/module_ra_gsfcsw.F | 26 +- phys/module_ra_rrtmg_sw.F | 16 +- phys/module_ra_sw.F | 24 +- phys/module_radiation_driver.F | 58 +++- run/README.namelist | 2 + run/eclipse_besselian_elements.dat | 242 +++++++++++++++ share/module_check_a_mundo.F | 22 ++ 16 files changed, 835 insertions(+), 34 deletions(-) create mode 100644 phys/module_ra_eclipse.F create mode 100644 run/eclipse_besselian_elements.dat diff --git a/Makefile b/Makefile index 8086d86742..282980ca00 100644 --- a/Makefile +++ b/Makefile @@ -555,6 +555,7 @@ em_real : wrf ln -sf ../../run/aerosol_lat.formatted . ; \ ln -sf ../../run/aerosol_lon.formatted . ; \ ln -sf ../../run/aerosol_plev.formatted . ; \ + ln -sf ../../run/eclipse_besselian_elements.dat . ; \ ln -sf ../../run/CCN_ACTIVATE.BIN . ; \ ln -sf ../../run/p3_lookup_table_1.dat-v4.1 . ; \ ln -sf ../../run/p3_lookup_table_2.dat-v4.1 . ; \ @@ -617,6 +618,7 @@ em_real : wrf ln -sf ../../run/aerosol_lat.formatted . ; \ ln -sf ../../run/aerosol_lon.formatted . ; \ ln -sf ../../run/aerosol_plev.formatted . ; \ + ln -sf ../../run/eclipse_besselian_elements.dat . ; \ ln -sf ../../run/capacity.asc . ; \ ln -sf ../../run/coeff_p.asc . ; \ ln -sf ../../run/coeff_q.asc . ; \ @@ -911,6 +913,7 @@ nmm_real : nmm_wrf ln -sf ../../run/aerosol_lat.formatted . ; \ ln -sf ../../run/aerosol_lon.formatted . ; \ ln -sf ../../run/aerosol_plev.formatted . ; \ + ln -sf ../../run/eclipse_besselian_elements.dat . ; \ ln -sf ../../run/capacity.asc . ; \ ln -sf ../../run/coeff_p.asc . ; \ ln -sf ../../run/coeff_q.asc . ; \ diff --git a/Registry/Registry.EM_COMMON b/Registry/Registry.EM_COMMON index d7caa13329..d786af5760 100644 --- a/Registry/Registry.EM_COMMON +++ b/Registry/Registry.EM_COMMON @@ -966,6 +966,10 @@ state real CHC_SFCDIF ij misc 1 - r "C state real CMGR_SFCDIF ij misc 1 - r "CMGR_SFCDIF" "" "" state real CHGR_SFCDIF ij misc 1 - r "CHGR_SFCDIF" "" "" +state integer ECMASK ij misc 1 - rh "ECMASK" "ECLIPSE MASK" "dimensionless" +state real ECOBSC ij misc 1 - rh "ECOBSC" "ECLIPSE OBSCURITY" "dimensionless" +state real elon_track - misc 1 - rh "elon_track" "ECLIPSE LON" "degrees" +state real elat_track - misc 1 - rh "elat_track" "ECLIPSE LAT" "degrees" # solar location variables from radiation driver state real COSZEN ij misc 1 - rh "COSZEN" "COS of SOLAR ZENITH ANGLE" "dimensionless" @@ -2331,6 +2335,7 @@ rconfig integer do_radar_ref namelist,physics 1 0 rconfig integer compute_radar_ref derived 1 0 - "compute_radar_ref" "0/1 flag: compute radar reflectivity, either do_radar_ref=1 .or. (milbrandt or NSSL schemes)" rconfig integer ra_lw_physics namelist,physics max_domains -1 rh "ra_lw_physics" "" "" rconfig integer ra_sw_physics namelist,physics max_domains -1 rh "ra_sw_physics" "" "" +rconfig integer ra_sw_eclipse namelist,physics 1 0 rh "ra_sw_eclipse" "0/1 flag: 1=turn eclipse on" "" rconfig real radt namelist,physics max_domains 0 h "RADT" "" "" rconfig real naer namelist,physics max_domains 1e9 rh "NAER" "" "" rconfig integer sf_sfclay_physics namelist,physics max_domains -1 rh "sf_sfclay_physics" "" "" @@ -2956,6 +2961,7 @@ package rrtmg_swscheme_fast ra_sw_physics==24 - ozmixm:mth01, package goddardswscheme ra_sw_physics==5 - state:tswdn,tswup,sswdn,sswup,taucldc,taucldi,re_cloud_gsfc,re_rain_gsfc,re_ice_gsfc,re_snow_gsfc,re_graupel_gsfc,re_hail_gsfc,cod2d_out,ctop2d_out,re_cloud,re_ice,re_snow package flgswscheme ra_sw_physics==7 - - package gfdlswscheme ra_sw_physics==99 - - +package eclipsescheme ra_sw_eclipse==1 - state:ecmask,ecobsc,elat_track,elon_track package nosfcscheme sf_sfclay_physics==0 - - package sfclayrevscheme sf_sfclay_physics==1 - - diff --git a/Registry/Registry.NMM b/Registry/Registry.NMM index e25653c328..e8a18f4e4b 100644 --- a/Registry/Registry.NMM +++ b/Registry/Registry.NMM @@ -1444,6 +1444,7 @@ rconfig integer do_radar_ref namelist,physics 1 0 rconfig integer compute_radar_ref derived 1 0 - "compute_radar_ref" "0/1 flag: compute radar reflectivity, either do_radar_ref=1 .or. (milbrandt or NSSL schemes)" rconfig integer ra_lw_physics namelist,physics max_domains 0 rh0123 "ra_lw_physics" "" "" rconfig integer ra_sw_physics namelist,physics max_domains 0 rh0123 "ra_sw_physics" "" "" +rconfig integer ra_sw_eclipse namelist,physics 1 0 rh "ra_sw_eclipse" "" "" rconfig real radt namelist,physics max_domains 0 h "RADT" "" "" rconfig integer sf_sfclay_physics namelist,physics max_domains 0 rh0123 "sf_sfclay_physics" "" "" rconfig integer sf_surface_physics namelist,physics max_domains 0 rh0123 "sf_surface_physics" "" "" @@ -1848,6 +1849,7 @@ package flgswscheme ra_sw_physics==7 - - package gfdlswscheme ra_sw_physics==99 - - package hwrfswscheme ra_sw_physics==98 - state:o3rad package heldsuarez ra_lw_physics==31 - - +package eclipsescheme ra_sw_eclipse==1 - - package nosfcscheme sf_sfclay_physics==0 - - package sfclayscheme sf_sfclay_physics==91 - - diff --git a/clean b/clean index d5a4a99e5f..3680e80fdf 100755 --- a/clean +++ b/clean @@ -65,6 +65,7 @@ if ( "$arg" == '-a' || "$arg" == '-aa' ) then */constants.asc */p3_lookup_table_1.dat \ */masses.asc */kernels_z.asc */capacity.asc */termvels.asc */coeff_p.asc */coeff_q.asc \ */gribmap.txt */tr??t?? */co2_trans */namelist.output */ishmael-gamma-tab.bin \ + */eclipse_besselian_elements.dat \ */HLC.TBL */wind-turbine-1.tbl \ */ishmael-qi-qc.bin */ishmael-qi-qr.bin ) >& /dev/null ( cd test/em_fire; rm -rf two_fires rain ) diff --git a/dyn_em/module_first_rk_step_part1.F b/dyn_em/module_first_rk_step_part1.F index 1f3eb31742..bdbcaacabb 100644 --- a/dyn_em/module_first_rk_step_part1.F +++ b/dyn_em/module_first_rk_step_part1.F @@ -434,7 +434,10 @@ SUBROUTINE first_rk_step_part1 ( grid , config_flags & & ,slope_rad=config_flags%slope_rad,topo_shading=config_flags%topo_shading & & ,shadowmask=grid%shadowmask & & ,ht=grid%ht,dx=grid%dx,dy=grid%dy,dx2d=grid%dx2d,area2d=grid%area2d & - & ,diffuse_frac=grid%diffuse_frac & + & ,diffuse_frac=grid%diffuse_frac & + & ,obscur=grid%ECOBSC, mask=grid%ECMASK & + & ,elat_track=grid%elat_track,elon_track=grid%elon_track & + & ,SW_ECLIPSE=config_flags%ra_sw_eclipse & & ,IS_CAMMGMP_USED = grid%is_CAMMGMP_used & & ,cw_rad=grid%cw_rad & & ,shcu_physics=config_flags%shcu_physics & diff --git a/dyn_nmm/module_PHYSICS_CALLS.F b/dyn_nmm/module_PHYSICS_CALLS.F index 66a792a18e..cca292bc6c 100644 --- a/dyn_nmm/module_PHYSICS_CALLS.F +++ b/dyn_nmm/module_PHYSICS_CALLS.F @@ -503,6 +503,7 @@ SUBROUTINE RADIATION(NTSD,DT,JULDAY,JULYR,XTIME,JULIAN & & ,F_ICE_PHY=F_ICE,F_RAIN_PHY=F_RAIN & & ,LWCF=LWCF,SWCF=SWCF & & ,O3INPUT=config_flags%O3INPUT,AER_OPT=config_flags%AER_OPT,O3RAD=grid%o3rad & + & ,SW_ECLIPSE=config_flags%ra_sw_eclipse & & ,SF_SURFACE_PHYSICS=CONFIG_FLAGS%SF_SURFACE_PHYSICS & & ,QV=MOIST_TRANS(IMS,KMS,JMS,P_QV),F_QV=F_QV & & ,QC=MOIST_TRANS(IMS,KMS,JMS,P_QC),F_QC=F_QC & diff --git a/phys/Makefile b/phys/Makefile index 5e1a771329..38b8f5cdcb 100644 --- a/phys/Makefile +++ b/phys/Makefile @@ -123,6 +123,7 @@ MODULES = \ module_ra_flg.o \ module_ra_HWRF.o \ module_ra_hs.o \ + module_ra_eclipse.o \ module_ra_aerosol.o \ module_ra_farms.o \ module_sf_sfclay.o \ diff --git a/phys/module_ra_eclipse.F b/phys/module_ra_eclipse.F new file mode 100644 index 0000000000..8c90260198 --- /dev/null +++ b/phys/module_ra_eclipse.F @@ -0,0 +1,439 @@ +module module_ra_eclipse + +contains + +!-------------------------------------------- +! Solar eclipse prediction moduel +! +! Alex Montornès and Bernat Codina. University of Barcelona. 2015 +! +! Based on Montornès A., Codina B., Zack J., Sola, Y.: Implementation of the +! Bessel's method for solar eclipses prediction in the WRF-ARW model. 2015 +! +! This key point of this subroutine is the evaluation of the degree of obscuration, +! i.e. the part of the solar disk that is hidden by the Moon. This variable is +! introduced in the SW schemes and used as a correction of the incoming radiation. +! In other words, if obscur is the part of the solar disk hidden by the Moon, then +! (1-obscur) is the part of the solar disk emitting radiation. +! +! Note that if obscur = 0., then we recover the standard code +! +!---------------------------- +! History +! +! amontornes 2015/09 First implementation +! +!---------------------------- +! MAIN ROUTINE +! +subroutine solar_eclipse(ims,ime,jms,jme,its,ite,jts,jte, & + julian,gmt,year,xtime,radt, & + degrad,xlon,xlat,Obscur,mask, & + elat_track,elon_track,sw_eclipse ) +!------------------------------------------------------------- + implicit none +! +!-------------- +!---------- +! VARIABLES +!---------- +!-------------- +! +!---------- +! Input/output vars +!---------- +! Grid indeces + integer, intent(in) :: ims,ime,jms,jme, & + its,ite,jts,jte +! Temporal variables + real, intent(in) :: gmt,degrad,julian,xtime,radt + integer, intent(in) :: year +! Geographical information + real, dimension(ims:ime,jms:jme), intent(in) :: xlat,xlon + real, dimension(ims:ime,jms:jme), intent(inout) :: Obscur +! Eclipse variables + integer, dimension(ims:ime,jms:jme), intent(inout) :: mask + real, intent(inout) :: elat_track,elon_track +! Namelist option 1 - enabled / 0 - disabled + integer, intent(in) :: sw_eclipse + +!---------- +! Local vars +!---------- +! +! Constants + real, parameter :: pi = 3.1415926535897932384626433 + real, parameter :: epsil = 0.0818192 ! Earth excentricity +! +! Besseliam elements from file eclipse_besselian_elements.dat +! X, Y :: coordinates of the eclipse's axis in the fundamental plane +! d, mu :: declination and azimuth (deg) +! l1, l2 :: radii of the penumbra and umbra regions in the fundamental +! plane +! tanf1, tanf2 :: angle of the shadow's conus +! t0, min, max :: time when the Besselian elements are valid +! Dt :: time correction + integer, parameter :: NBessel = 4 ! Dimension + real, dimension(NBessel) :: X, Y, d, l1, l2, mu + real :: tanf1, tanf2, t0, tmin, tmax, Dt +! +! d and mu in radians + real :: rmu, rd +! +! Besselian elements at the current time t1 + real :: cx, cy, cd, cl1, cl2, cmu +! +! Current time t1, and hourly angle H + real :: t1, & + H +! +! Latitude and longitude in radians + real :: rlat, rlon +! +! +! Geocentric coordinates +!---------- + real :: cos_lat1, sin_lat1 ! cos/sin of the corrected latitude + real :: xi, eta1, zeta1 ! Geocentric coordinates at the observation point +! +! Eclipse variables + real :: DELTA, DELTA2 ! Distance of the observation point + ! to the eclipse axis + real :: LL1, LL2 ! Penumbra and Umbra radius + ! from the point observer's plane + logical :: eclipse_exist +! +! Loop indeces + integer :: i, j +! +! Internal variables + real :: A, B + real :: da,eot,xt24 + integer :: julday +! +! Eclipse path + real :: E, E_1, tan_rd1, rd1, rho1, cy1, tan_gamma, cgamma, sin_beta, & + tan_C, C, cm, tan_lat1, tan_lat, sin_H, & + cos_H, tan_H, beta, lon, tan_rd2, rd2, rho2 +! +! Missing value + real :: MISSING + + +!-------------- +!---------- +! CODE CUSTOMIZATION +!---------- +!-------------- +! + MISSING = 1E30 + +!-------------- +!---------- +! MAIN +!---------- +!-------------- +! +!---------- +! Check if the eclipse is enabled by the namelist.input +! If eclipse is not enabled -> set eclipse variables to zero and nothing to do + if(sw_eclipse .eq. 0) then + Obscur(:,:) = 0. + mask(:,:) = 0 + elat_track = MISSING + elon_track = MISSING + return + endif +! +!---------- +! Set current time + xt24 = mod(xtime+radt,1440.) + t1 = gmt+xt24/60 + julday = int(julian)+1 + if(t1 .ge. 24.) then + t1 = t1 - 24. + endif +! +!---------- +! Check if the eclipse exists for the current simulation date + eclipse_exist = .false. +! +! and load the besselian elements +! Note: eclipse_besselian_elements.dat should be in the running directory! + call load_besselian_elements(t1, julday, year, X, Y, d, l1, l2, mu, & + tanf1, tanf2, t0, tmin, tmax, NBessel, & + eclipse_exist,Dt) +! +!---------- +! If the eclipse does not exist, then we set all the output vars to zero and finish + if(.not. eclipse_exist) then + Obscur(:,:) = 0. + mask(:,:) = 0 + elat_track = MISSING + elon_track = MISSING + return + endif +! +!---------- +! Compute the besselian elements at t1 + call compute_besselian_t(t1, NBessel, X, Y, d, l1, l2, mu, t0, Dt, & + cx, cy, cd, cl1, cl2, cmu) +! +!---------- +! Convert the beselian elements from deg to radians + rmu = cmu * degrad + rd = cd * degrad + +!--------------------------- +! STEP 1: Compute the eclipse track. This is just a diagnosis for the user +! +!-- Initialization + elat_track=MISSING + elon_track=MISSING +! +!-- Compute the excentricity correction + E = sqrt(1 - epsil**2) + E_1 = 1/E +!-- Get d1 + tan_rd1 = E_1 * tan(rd) + rd1 = atan(tan_rd1) +!-- Get rho1 + rho1 = sin(rd)/sin(rd1) +!-- Correct cy1 + cy1 = cy / rho1 +!-- Get d2 + tan_rd2 = E * tan(rd) + rd2 = atan(tan_rd2) +!-- Get rho2 + rho2 = cos(rd)/cos(rd2) +!-- Compute gamma + tan_gamma = cx / cy1 + cgamma = atan(tan_gamma) +!-- Compute beta + sin_beta = cx/sin(cgamma) +! +!-- If |sin(beta)|>1 then the axis of the eclipse is tangent to the Earth's +! surface or directly it does not crosses the Earth. + if(abs(sin_beta) .lt. 1) then + beta = asin(sin_beta) + !-- Compute C + tan_C = cy1 / cos(beta) + C = atan(tan_C) + !-- Compute c + cm = cy1 / sin(C) + !-- Compute lat1 + sin_lat1 = cm * sin(C + rd1) + cos_lat1 = sqrt(1 - sin_lat1**2) + tan_lat1 = sin_lat1/cos_lat1 + !-- Convert to geographic latitude + tan_lat = E_1 * tan_lat1 + elat_track= atan(tan_lat)/degrad + !-- Compute the hourly angle + sin_H = cx / cos_lat1 + cos_H = cm * cos(C+rd1)/cos_lat1 + tan_H = sin_H/cos_H + H = atan(tan_H) + + if(cos_H .lt. 0) then + if(sin_H .ge. 0) then + H = pi - abs(H) + else + H = pi + abs(H) + end if + end if + !-- Compute the longitude + elon_track= (rmu - H)/degrad + !-- Convert to geopgraphic longitude + if(elon_track .gt. 360) then + elon_track = elon_track -360 + endif + if(elon_track .gt. 180) then + elon_track = elon_track -360 + endif + if(elon_track .le. -180) then + elon_track = elon_track +360 + endif + !-- Correct the Earth's movement + elon_track = -elon_track + 1.002738 * 15*Dt/3600 + endif + +!--------------------------- +! STEP 2: Compute the obscuricity for each grid-point. This step it is important +! in order to reduce the incoming radiation +! Loop over latitudes + do j=jts,jte + ! Loop over longitudes + do i=its,ite + !--Correct the Earth's movement + lon = -xlon(i,j) - 1.002738 * 15*Dt/3600 + if(lon .lt. 0) then + lon = lon + 360 + endif + if(lon .gt. 360) then + lon = lon -360 + endif + + !-- Convert degrees to radians + rlat = xlat(i,j)*degrad + rlon = lon*degrad + + !-- Hourly angle + H = rmu - rlon + + !-- Adjust the Earth's sphericity + A = sqrt( 1 - ( epsil * sin(rlat) )**2 ) + + !-- Compute lat1 + cos_lat1 = cos(rlat) / A + sin_lat1 = sin(rlat) * E / A + + !-- Geocentric coordinates at the observation point + xi = cos_lat1 * sin(H) + eta1 = sin_lat1 * cos(rd1) * E - cos_lat1 * sin(rd1) * cos(H) + zeta1 = sin_lat1 * sin(rd2) * E + cos_lat1 * cos(rd2) * cos(H) + + !-- Correct cy (sembla que no és necessari) + cy1 = cy/rho1 + + !-- Distance to the shadow axis + DELTA2 = (xi - cx)**2 + (eta1 - cy1)**2; + DELTA = sqrt(DELTA2) + + !-- Penumbra and Umbra cone's circumference over the Earth's surface + LL1 = (cl1 - zeta1 * tanf1) ! Penumbra + LL2 = (cl2 - zeta1 * tanf2) ! Umbra + + ! Check if we are inside the eclipse + if(DELTA .gt. LL1) then ! Without obscuration + Obscur(i,j) = 0. + mask(i,j) = 0 + elseif(DELTA .le. LL1 .and. DELTA .gt. abs(LL2)) then ! Penumbra + Obscur(i,j) = (LL1 - DELTA) / (LL1 + LL2) ! Partial eclipse + mask(i,j) = 1 + elseif(DELTA .le. abs(LL2)) then ! Umbra + if(LL2 .lt. 0) then + Obscur(i,j) = 1. ! Total eclipse + mask(i,j) = 2 + else + Obscur(i,j) = (LL1 - DELTA) / (LL1 + LL2) ! Annular eclipse + mask(i,j) = 3 + endif + endif + + ! Check that the obscuration is not greater than 1 + if(Obscur(i,j) .gt. 1) then + Obscur(i,j) = 1. + endif + + enddo + ! End loop over longitudes + enddo +! End loop over longitudes +end subroutine +! +!---------------------------- +! INTERNAL SUBROUTINES +! load_besselian_elements --> load the besselian elements from eclipse_besselian_elements.dat +! compute_besselian_t --> compute the besselian elements for the current time +! +!---------------------------- +subroutine load_besselian_elements(t, julday, year, X, Y, d, l1, l2, mu, & + tanf1, tanf2, t0, tmin, tmax, NBessel, & + eclipse_exist,Dt) + IMPLICIT NONE +! +!-------------- +!---------- +! VARIABLES +!---------- +!-------------- +! +!---------- +! Input/output vars +!---------- + integer, intent(in) :: julday, year, NBessel + real, intent(in) :: t + logical, intent(inout) :: eclipse_exist + real, dimension(NBessel), intent(inout) :: X, Y, d, l1, l2, mu + real, intent(inout) :: tanf1, tanf2, t0, tmin, tmax, Dt +!---------- +! Local vars +!---------- + integer :: ryear, rjulday + logical :: file_exist + +!---------- +! Initialization +!---------- + eclipse_exist = .false. + +!---------- +! Load the information from eclipse_besselian_elements.dat +!---------- + inquire( file="eclipse_besselian_elements.dat", exist=file_exist) + if (file_exist) then + open (20,FILE='eclipse_besselian_elements.dat',status="old",action="read") + else + call wrf_error_fatal('load_besselian_elements: eclipse_besselian_elements.dat not found') + return + end if + + do + ! Load the list of eclipse features + read(20,*,end=1)ryear,rjulday,t0,tmin,tmax, & + X(1), X(2), X(3), X(4), & + Y(1), Y(2), Y(3), Y(4), & + d(1), d(2), d(3), d(4), & + l1(1),l1(2),l1(3),l1(4), & + l2(1),l2(2),l2(3),l2(4), & + mu(1),mu(2),mu(3),mu(4), & + tanf1,tanf2,Dt + ! Check if the current date matches with the loaded episode + if(ryear .eq. year .and. rjulday .eq. julday .and. tmin .le. t .and. t .le. tmax) then + eclipse_exist = .true. + close(20) + return + else + endif + end do + 1 close(20) + return +end subroutine +!---------------------------- +!---------------------------- +!---------------------------- +subroutine compute_besselian_t(t1, NBessel, X, Y, d, l1, l2, mu, t0, Dt, & + cx, cy, cd, cl1, cl2, cmu) + IMPLICIT NONE + integer, intent(in) :: NBessel + real, intent(in) :: t1 + real, dimension(NBessel), intent(in) :: X, Y, d, l1, l2, mu + real, intent(in) :: t0, Dt + real, intent(inout) :: cx, cy, cd, cl1, cl2, cmu + + real :: t + integer :: i + + cx = 0. + cy = 0. + cd = 0. + cl1 = 0. + cl2 = 0. + cmu = 0. + + t = (t1 + DT/3600) - t0 + + do i=1,NBessel + cx = cx + X(i) * t**(i-1) + cy = cy + Y(i) * t**(i-1) + cd = cd + d(i) * t**(i-1) + cl1 = cl1 + l1(i) * t**(i-1) + cl2 = cl2 + l2(i) * t**(i-1) + cmu = cmu + mu(i) * t**(i-1) + enddo + +end subroutine +!---------------------------- +!---------------------------- + +end module module_ra_eclipse diff --git a/phys/module_ra_goddard.F b/phys/module_ra_goddard.F index 54d0d12d3e..f9387c1a92 100644 --- a/phys/module_ra_goddard.F +++ b/phys/module_ra_goddard.F @@ -1034,6 +1034,7 @@ subroutine goddardrad( sw_or_lw, dx & ,sflxd & !optional for sw ,swddir,swddni,swddif & !optinal for sw ,coszen & !optional for sw + ,obscur & ! amontornes-bcodina 2015/09 solar eclipses #if (WRF_CHEM == 1) ,aod2d_out,atop2d_out & !optional for sw ,aero & @@ -1270,6 +1271,10 @@ subroutine goddardrad( sw_or_lw, dx & real, optional, dimension(ims:ime, jms:jme), intent(in) :: & coszen ! cosine of the solar zenith angle +! amontornes-bcodina 2015/09 solar eclipses +! obscur --> degree of obscuration for solar eclipses prediction (2D) +real, dimension( ims:ime, jms:jme ), intent(in) :: & + obscur !------- Local variables ---------------------------------------------- @@ -2079,7 +2084,7 @@ subroutine goddardrad( sw_or_lw, dx & do kt=kts-1,kte !full level ( kts -1 = TOA, kte = BOA ) DO ic=1,min(CHUNK,ite-ii+1) if(lmask(ic) .eqv. .true.) then - flx(ic,kt) = flx(ic,kt) * solcon * cosz(ic) + flx(ic,kt) = flx(ic,kt) * solcon * cosz(ic)* ( 1 - obscur(i,j) ) ! amontornes-bcodina 2015/09 solar eclipses endif ENDDO enddo @@ -2151,7 +2156,7 @@ subroutine goddardrad( sw_or_lw, dx & DO ic=1,min(CHUNK,ite-ii+1) if(lmask(ic) .eqv. .true.) then i = ii+ic-1 - gsf(i:ie(ic),j:je(ic)) = (1. - rsuvbm(ic)) * flxd(ic,kte) * solcon * cosz(ic) + gsf(i:ie(ic),j:je(ic)) = (1. - rsuvbm(ic)) * flxd(ic,kte) * solcon * cosz(ic) * (1 - obscur(i,j) ) ! amontornes-bcodina 2015/09 solar eclipses endif ENDDO @@ -2172,17 +2177,17 @@ subroutine goddardrad( sw_or_lw, dx & DO ic=1,min(CHUNK,ite-ii+1) if(lmask(ic) .eqv. .true.) then i = ii+ic-1 - if(present(swddni)) swddni(i:ie(ic),j:je(ic)) = (flxd_surf(ic,1)+flxd_surf(ic,3)) * solcon !total SW direct radiation at normal direction [W/m2] + if(present(swddni)) swddni(i:ie(ic),j:je(ic)) = (flxd_surf(ic,1)+flxd_surf(ic,3)) * solcon * ( 1 - obscur(i,j) ) !total SW direct radiation at normal direction [W/m2] ! amontornes-bcodina 2015/09 solar eclipses if(present(swddir)) swddir(i:ie(ic),j:je(ic)) = swddni(i,j) * cosz(ic) !total SW direct radiation [W/m2] - if(present(swddif)) swddif(i:ie(ic),j:je(ic)) = (flxd_surf(ic,2)+flxd_surf(ic,4)) * solcon * cosz(ic) !total SW diffuse radiation [W/m2] + if(present(swddif)) swddif(i:ie(ic),j:je(ic)) = (flxd_surf(ic,2)+flxd_surf(ic,4)) * solcon * cosz(ic) * ( 1 - obscur(i,j) ) !total SW diffuse radiation [W/m2] ! amontornes-bcodina 2015/09 solar eclipses ! ! extra output for earth radiation budget ! - ERBE_out(i:ie(ic),j:je(ic),5) = flxd(ic,kts-1) * solcon * cosz(ic) ! TOA SW downwelling flux [W/m2] - ERBE_out(i:ie(ic),j:je(ic),6) = flxu(ic,kts-1) * solcon * cosz(ic) ! TOA SW upwelling flux [W/m2] - ERBE_out(i:ie(ic),j:je(ic),7) = flxd(ic,kte) * solcon * cosz(ic) ! surface SW downwelling flux [W/m2] - ERBE_out(i:ie(ic),j:je(ic),8) = flxu(ic,kte) * solcon * cosz(ic) ! surface SW upwelling flux [W/m2] + ERBE_out(i:ie(ic),j:je(ic),5) = flxd(ic,kts-1) * solcon * cosz(ic) * (1 - obscur(i,j) ) ! TOA SW downwelling flux [W/m2] + ERBE_out(i:ie(ic),j:je(ic),6) = flxu(ic,kts-1) * solcon * cosz(ic) * (1 - obscur(i,j) ) ! TOA SW upwelling flux [W/m2] + ERBE_out(i:ie(ic),j:je(ic),7) = flxd(ic,kte) * solcon * cosz(ic) * (1 - obscur(i,j) ) ! surface SW downwelling flux [W/m2] + ERBE_out(i:ie(ic),j:je(ic),8) = flxu(ic,kte) * solcon * cosz(ic) * (1 - obscur(i,j) ) ! surface SW upwelling flux [W/m2] endif ENDDO diff --git a/phys/module_ra_gsfcsw.F b/phys/module_ra_gsfcsw.F index 5537ce2f1b..2a8bec1233 100644 --- a/phys/module_ra_gsfcsw.F +++ b/phys/module_ra_gsfcsw.F @@ -25,6 +25,7 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and ,aer_ra_feedback & ,f_qv,f_qc,f_qr,f_qi,f_qs,f_qg,f_qndrop & ,coszen & ! PAJ + ,obscur & ! amontornes-bcodina 2015/09 solar eclipses ,ids,ide, jds,jde, kds,kde & ,ims,ime, jms,jme, kms,kme & ,its,ite, jts,jte, kts,kte ) @@ -107,6 +108,10 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and ! REAL, DIMENSION( ims:ime, jms:jme), INTENT(IN) :: COSZEN +! amontornes-bcodina 2015/09 solar eclipses +! obscur --> degree of obscuration for solar eclipses prediction (2D) + REAL, DIMENSION( ims:ime, jms:jme ), INTENT(IN) :: obscur + ! LOCAL VARS REAL, DIMENSION( its:ite ) :: & @@ -122,7 +127,12 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and INTEGER, DIMENSION( its:ite ) :: & ict, & - icb + icb + +! amontornes-bcodina 2015/09 solar eclipses +! obscur --> degree of obscuration for solar eclipses prediction (one row) + REAL, DIMENSION( its:ite ) :: & + obscur_row REAL, DIMENSION( its:ite, kts-1:kte, 2 ) :: taucld @@ -755,6 +765,8 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and do i = its,ite ! PAJ: Use cos zenith angle from the radiation driver: cosz(i)=coszen(i,j) +! amontornes-bcodina 2015/09 solar eclipses :: save obscuration from for the current j + obscur_row(i)=obscur(i,j) ! xt24 = mod(xtime + radfrq * 0.5, 1440.) ! tloctm = GMT + xt24 / 60. + XLONG(i,j) / 15. ! hrang = 15. * (tloctm - 12.) * degrad @@ -788,7 +800,9 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and if (cosz(i) .lt. thresh) then flx(i,k) = 0. else - flx(i,k) = flx(i,k) * SOLCON * cosz(i) + ! amontornes-bcodina 2015/09 solar eclipses: modified for considering the solar + ! eclipse + flx(i,k) = flx(i,k) * SOLCON * cosz(i) * (1. - obscur_row(i) ) endif end do end do @@ -810,7 +824,9 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and if (cosz(i) .le. thresh) then RSWTOA(i,j) = 0. else - RSWTOA(i,j) = flx(i,kts) - flxd(i,kts) * SOLCON * cosz(i) + ! amontornes-bcodina 2015/09 solar eclipses: modified for considering the solar + ! eclipse + RSWTOA(i,j) = flx(i,kts) - flxd(i,kts) * SOLCON * cosz(i) * (1. - obscur_row(i) ) endif end do ! @@ -820,7 +836,9 @@ SUBROUTINE GSFCSWRAD(rthraten,gsw & ! PAJ: xlat and if (cosz(i) .le. thresh) then GSW(i,j) = 0. else - GSW(i,j) = (1. - rsuvbm(i)) * flxd(i,kte+1) * SOLCON * cosz(i) + ! amontornes-bcodina 2015/09 solar eclipses: modified for considering the solar + ! eclipse + GSW(i,j) = (1. - rsuvbm(i)) * flxd(i,kte+1) * SOLCON * cosz(i) * (1. - obscur_row(i) ) endif end do diff --git a/phys/module_ra_rrtmg_sw.F b/phys/module_ra_rrtmg_sw.F index 3e7f2ffc03..7a13b1686f 100644 --- a/phys/module_ra_rrtmg_sw.F +++ b/phys/module_ra_rrtmg_sw.F @@ -9960,8 +9960,9 @@ SUBROUTINE RRTMG_SWRAD( & tauaer3d_sw,ssaaer3d_sw,asyaer3d_sw, & ! jararias 2013/11 swddir, swddni, swddif, & ! jararias 2013/08 swdownc, swddnic, swddirc, & ! PAJ - xcoszen,yr,julian & ! jararias 2013/08 - ) + xcoszen,yr,julian, & ! jararias 2013/08 + obscur & ! amontornes-bcodina 2015/09 solar eclipses + ) !------------------------------------------------------------------ IMPLICIT NONE !------------------------------------------------------------------ @@ -10125,6 +10126,10 @@ SUBROUTINE RRTMG_SWRAD( & SWUPFLX,SWUPFLXC, & SWDNFLX,SWDNFLXC +! amontornes-bcodina 2015/09 solar eclipses +! obscur --> degree of obscuration for solar eclipses prediction (2D) + REAL, DIMENSION(ims:ime,jms:jme), INTENT(IN) :: obscur + ! LOCAL VARS REAL, DIMENSION( kts:kte+1 ) :: Pw1D, & @@ -10636,8 +10641,11 @@ SUBROUTINE RRTMG_SWRAD( & ! Set cosine of solar zenith angle coszen(ncol) = coszrs -! Set solar constant - scon = solcon +! Set solar constant (original) amontornes-bcodina 2015/09 +! scon = solcon +! amontornes-bcodina 2015/09 solar eclipses + scon = solcon*(1-obscur(i,j)) + ! For Earth/Sun distance adjustment in RRTMG ! dyofyr = julday ! adjes = 0.0 diff --git a/phys/module_ra_sw.F b/phys/module_ra_sw.F index 6f44d73334..1c366dca37 100644 --- a/phys/module_ra_sw.F +++ b/phys/module_ra_sw.F @@ -18,8 +18,8 @@ SUBROUTINE SWRAD(dt,RTHRATEN,GSW,XLAT,XLONG,ALBEDO, & ids,ide, jds,jde, kds,kde, & ims,ime, jms,jme, kms,kme, & its,ite, jts,jte, kts,kte, & - coszen,julian & ! jararias, 14/08/2013 - ) + coszen,julian, & ! jararias, 14/08/2013 + obscur) ! amontornes-bcodina 2015/09 solar eclipses !------------------------------------------------------------------ IMPLICIT NONE !------------------------------------------------------------------ @@ -64,6 +64,10 @@ SUBROUTINE SWRAD(dt,RTHRATEN,GSW,XLAT,XLONG,ALBEDO, & REAL, DIMENSION( ims:ime, jms:jme ), OPTIONAL, INTENT(IN) :: COSZEN REAL, OPTIONAL, INTENT(IN) :: JULIAN +!-- amontornes-bcodina 2015/09 +! obscur --> degree of obscuration for solar eclipses prediction (2D) + real, dimension(ims:ime,jms:jme), INTENT(IN) :: obscur + ! ! Optional ! @@ -101,6 +105,10 @@ SUBROUTINE SWRAD(dt,RTHRATEN,GSW,XLAT,XLONG,ALBEDO, & LOGICAL :: predicate , do_topo_shading real :: aer_dry1(kts:kte),aer_water1(kts:kte) +! amontornes-bcodina 2015/09 solar eclipses +! obscur0 --> degree of obscuration for solar eclipses prediction at one point + REAL:: obscur0 + !------------------------------------------------------------------ j_loop: DO J=jts,jte @@ -218,6 +226,7 @@ SUBROUTINE SWRAD(dt,RTHRATEN,GSW,XLAT,XLONG,ALBEDO, & XLAT0=XLAT(I,J) XLONG0=XLONG(I,J) ALB0=ALBEDO(I,J) + obscur0=obscur(I,J) ! slope code removed - factor now done in surface driver CALL SWPARA(TTEN1D,GSW0,XLAT0,XLONG0,ALB0, & T1D,QV1D,QC1D,QR1D,QI1D,QS1D,QG1D,P1D, & @@ -225,7 +234,7 @@ SUBROUTINE SWRAD(dt,RTHRATEN,GSW,XLAT,XLONG,ALBEDO, & R,CP,G,DECLIN,SOLCON, & RADFRQ,ICLOUD,DEGRAD,aer_dry1,aer_water1, & kts,kte, & - coszen(i,j),julian ) ! jararias, 14/08/2013 + coszen(i,j),julian,obscur0 ) ! jararias, 14/08/2013, amontornes-bcodina 2015/09 solar eclipses GSW(I,J)=GSW0 DO K=kts,kte NK=kme-1-K+kms @@ -243,7 +252,7 @@ SUBROUTINE SWPARA(TTEN,GSW,XLAT,XLONG,ALBEDO, & XTIME, GMT, RHO0, DZ, & R,CP,G,DECLIN,SOLCON, & RADFRQ,ICLOUD,DEGRAD,aer_dry1,aer_water1, & - kts,kte,coszen,julian, & + kts,kte,coszen,julian,obscur0, & ! amontornes-bcodina 2015/09 solar eclipses slope_rad,shadow,slp_azi,slope ) !------------------------------------------------------------------ ! TO CALCULATE SHORT-WAVE ABSORPTION AND SCATTERING IN CLEAR @@ -285,6 +294,7 @@ SUBROUTINE SWPARA(TTEN,GSW,XLAT,XLONG,ALBEDO, & INTEGER, OPTIONAL, INTENT(IN) :: slope_rad,shadow REAL, OPTIONAL, INTENT(IN) :: slp_azi,slope + REAL, INTENT(IN) :: obscur0 ! LOCAL VARS ! @@ -334,7 +344,8 @@ SUBROUTINE SWPARA(TTEN,GSW,XLAT,XLONG,ALBEDO, & GSW=0.0 bext340=5.E-6 bexth2o=5.E-6 - SOLTOP=SOLCON +! SOLTOP=SOLCON + SOLTOP = SOLCON*(1-obscur0) ! jararias, 14/08/2013 if (present(coszen)) then csza=coszen @@ -352,6 +363,9 @@ SUBROUTINE SWPARA(TTEN,GSW,XLAT,XLONG,ALBEDO, & ! RETURN IF NIGHT IF(CSZA.LE.1.E-9)GOTO 7 + +! amontornes-bcodina 2015/09 solar eclipses eclipse + IF(SOLTOP.LE.1.E-9)GOTO 7 ! DO K=kts, kte diff --git a/phys/module_radiation_driver.F b/phys/module_radiation_driver.F index 9f162faba2..f112da6854 100644 --- a/phys/module_radiation_driver.F +++ b/phys/module_radiation_driver.F @@ -31,6 +31,7 @@ SUBROUTINE radiation_driver ( & ,RTHRATENLW ,RTHRATENSW & ,SNOW ,STEPRA ,SWDOWN & ,SWDOWNC ,SW_PHYSICS & + ,SW_ECLIPSE & ,T8W ,T ,TAUCLDC & ,TAUCLDI ,TSK ,VEGFRA & ,WARM_RAIN ,XICE ,XLAND & @@ -166,6 +167,7 @@ SUBROUTINE radiation_driver ( & ,aod5502d, angexp2d, aerssa2d, aerasy2d & ,aod5503d & ,cw_rad, shcu_physics & + ,obscur,mask,elat_track,elon_track & ,taod5502d, taod5503d & ,mp_physics & ,EFCG,EFCS,EFIG,EFIS,EFSG,aercu_opt & @@ -213,7 +215,8 @@ SUBROUTINE radiation_driver ( & #endif #endif ,KFCUPSCHEME, BMJSCHEME & !BSINGH - Added KFCUPSCHEME for WRFCuP scheme - ,FLGLWSCHEME, FLGSWSCHEME + ,FLGLWSCHEME, FLGSWSCHEME & + ,ECLIPSESCHEME USE module_model_constants #ifndef HWRF @@ -248,7 +251,8 @@ SUBROUTINE radiation_driver ( & USE module_ra_aerosol , ONLY : calc_aerosol_goddard_sw, & calc_aerosol_rrtmg_sw USE module_ra_farms , ONLY : farms_driver - +! amontornes-bcodina 2015/09 solar eclipses + USE module_ra_eclipse , ONLY : solar_eclipse ! This driver calls subroutines for the radiation parameterizations. ! @@ -427,7 +431,7 @@ SUBROUTINE radiation_driver ( & kts,kte, & num_tiles - INTEGER, INTENT(IN) :: lw_physics, sw_physics, mp_physics + INTEGER, INTENT(IN) :: lw_physics, sw_physics, mp_physics, sw_eclipse INTEGER, INTENT(IN) :: o3input, aer_opt INTEGER, INTENT(IN) :: id integer, intent(in) :: swint_opt @@ -879,6 +883,15 @@ SUBROUTINE radiation_driver ( & ! jararias 2013/11 but modified on 2016/2/10 ! the following three arrays may be dimensioned by (ims,ime,kms,kme,jms,jme,aerosol_vars) real, dimension(:,:,:,:), pointer :: tauaer_sw=>null(), ssaaer_sw=>null(), asyaer_sw=>null() +! +! Montornes-Cordian eclipse variables + real, dimension(ims:ime,jms:jme), optional, INTENT(OUT) :: obscur + integer, dimension(ims:ime,jms:jme), optional, INTENT(OUT) :: mask + real, optional, INTENT(OUT) :: elat_track, elon_track +! Local variables + INTEGER, DIMENSION( ims:ime, jms:jme ) :: mask_loc + REAL, DIMENSION( ims:ime, jms:jme ) :: obscur_loc + REAL :: elat_loc, elon_loc ! Trude AOD variables INTEGER, PARAMETER:: taer_type = 1 ! rural, urban, maritime, ... @@ -1042,6 +1055,15 @@ SUBROUTINE radiation_driver ( & jte = j_end(ij) CALL radconst(XTIME,DECLIN,SOLCON,JULIAN, & DEGRAD,DPD ) + +! amontornes-bcodina 2015/09 solar eclipses +! Solar eclipse prediction based on the Bessel's method +! outputs: obscur, mask, elat_track, elon_track + CALL solar_eclipse(ims,ime,jms,jme,its,ite,jts,jte, & + julian,gmt,YR,xtime,radt, & + degrad,xlong,xlat,obscur_loc,mask_loc, & + elat_loc,elon_loc,sw_eclipse ) + IF(PRESENT(declinx).AND.PRESENT(solconx))THEN ! saved to state arrays used in surface driver declinx=declin @@ -1765,6 +1787,7 @@ SUBROUTINE radiation_driver ( & ,reg3d=re_graupel_gsfc,reh3d=re_hail_gsfc & !optional ,erbe_out=erbe_out & ,itimestep=itimestep, dt_in = dt & + ,obscur=obscur_loc & #if (WRF_CHEM == 1) ,AERO=aero & ,CHEM_OPT=chem_opt & @@ -2109,7 +2132,7 @@ SUBROUTINE radiation_driver ( & ,NETSWBOT=GSW,DLWBOT=GLW & ,DSWBOT=SWDOWN,deltat=RTHRATEN & ,dtshort=RTHRATENSW,dtlongwv=RTHRATENLW & - ,SWDDIR=swddir,SWDDIF=swddif,SWDDNI=swddni & ! amontornes-bcodina (2014-04-20) + ,SWDDIR=swddir,SWDDIF=swddif,SWDDNI=swddni & ) CALL wrf_debug(100, 'a4 Fu_Liou-Gu') @@ -2237,7 +2260,8 @@ SUBROUTINE radiation_driver ( & ,QG3D=qg & ,F_QV=f_qv,F_QC=f_qc,F_QR=f_qr & ,F_QI=f_qi,F_QS=f_qs,F_QG=f_qg & - ,coszen=coszen,julian=julian ) + ,coszen=coszen,julian=julian & + ,obscur=obscur_loc ) CASE (GSFCSWSCHEME) CALL wrf_debug(100, 'CALL gsfcswrad') @@ -2276,6 +2300,7 @@ SUBROUTINE radiation_driver ( & ,F_QI=f_qi,F_QS=f_qs,F_QG=f_qg & ,F_QNDROP=f_qndrop & ,COSZEN=coszen & + ,OBSCUR=obscur_loc & ) case (goddardswscheme) @@ -2326,6 +2351,7 @@ SUBROUTINE radiation_driver ( & ,sflxd=sflxd & !optional ,swddir=swddir,swddni=swddni,swddif=swddif & !optional ,coszen=coszen & !optional + ,obscur=obscur_loc & ,itimestep=itimestep, dt_in = dt & #if (WRF_CHEM == 1) ,aod2d_out=aod2d_out, atop2d_out=atop2d_out & ! optional @@ -2335,12 +2361,6 @@ SUBROUTINE radiation_driver ( & #endif ) - - - - - - CASE (CAMSWSCHEME) CALL wrf_debug(100, 'CALL camrad sw') IF ( PRESENT( OZMIXM ) .AND. PRESENT( PIN ) .AND. & @@ -2392,7 +2412,7 @@ SUBROUTINE radiation_driver ( & ,IDS=ids,IDE=ide, JDS=jds,JDE=jde, KDS=kds,KDE=kde & ,IMS=ims,IME=ime, JMS=jms,JME=jme, KMS=kms,KME=kme & ,ITS=its,ITE=ite, JTS=jts,JTE=jte, KTS=kts,KTE=kte & - ,coszen=coszen ) + ,coszen=coszen ) ELSE CALL wrf_error_fatal ( 'arguments not present for calling cam radiation' ) ENDIF @@ -2468,6 +2488,7 @@ SUBROUTINE radiation_driver ( & asyaer3d_sw=asyaer_sw, & ! jararias 2013/11 swddir=swddir,swddni=swddni,swddif=swddif, & ! jararias 2013/08/10 swdownc=swdownc, swddnic=swddnic, swddirc=swddirc, & ! PAJ + obscur=obscur_loc, & xcoszen=coszen,yr=yr,julian=julian,mp_physics=mp_physics ) ! jararias 2013/08/14 DO j=jts,jte @@ -2739,6 +2760,19 @@ SUBROUTINE radiation_driver ( & coszen_ref ) ENDIF + IF ( PRESENT( obscur ) ) THEN + IF ( sw_eclipse == eclipsescheme ) THEN + DO j=jts,jte + DO i=its,ite + obscur(i,j) = obscur_loc(i,j) + mask(i,j) = mask_loc(i,j) + ENDDO + ENDDO + elat_track = elat_loc + elon_track = elon_loc + ENDIF + ENDIF + ENDDO !$OMP END PARALLEL DO diff --git a/run/README.namelist b/run/README.namelist index b7d82324c4..7ae8ff9fa0 100644 --- a/run/README.namelist +++ b/run/README.namelist @@ -602,6 +602,8 @@ Namelist variables for controlling the adaptive time step option: use the same value for all nests. cldovrlp = 2, ! cloud overlapping option for RRTMG only. 1=random, 2=maximum-random (default), 3=maximum, 4=exponential, 5=exponential-random + ra_sw_eclipse = 0, ! eclipse effect on shortwave radiation. 0: off, 1: on. + Applies to RRTMG, Goddard, old Goddard and Dudhia schemes nrads (max_dom) = FOR NMM: number of fundamental timesteps between calls to shortwave radiation; the value diff --git a/run/eclipse_besselian_elements.dat b/run/eclipse_besselian_elements.dat new file mode 100644 index 0000000000..64c6858262 --- /dev/null +++ b/run/eclipse_besselian_elements.dat @@ -0,0 +1,242 @@ +1950 077 16.000 13.00 19.00 0.69434700 0.44855320 -0.00004020 -0.00000510 -0.75679700 0.24932350 0.00003230 -0.00000310 -0.99661000 0.01586900 0.00000000 0.00000000 0.56728300 0.00006470 -0.00001010 0.00000000 0.02104000 0.00006440 -0.00001010 0.00000000 57.94582000 15.00413000 0.00000000 0.00000000 0.00469760 0.00467420 29.2 +1950 255 4.000 1.00 7.00 0.60059100 0.49031310 -0.00002800 -0.00000730 0.68628400 -0.26820760 -0.00006570 0.00000410 4.42109010 -0.01523100 -0.00000100 0.00000000 0.54329200 -0.00011690 -0.00001180 0.00000000 -0.00283200 -0.00011630 -0.00001180 0.00000000 240.86778300 15.00483000 0.00000000 0.00000000 0.00464580 0.00462270 29.4 +1951 066 21.000 18.00 24.00 0.16605200 0.47746940 -0.00003970 -0.00000650 -0.18510700 0.25980900 0.00003120 -0.00000370 -5.33635000 0.01556600 0.00000100 0.00000000 0.55360700 0.00011570 -0.00001140 0.00000000 0.00743200 0.00011510 -0.00001130 0.00000000 132.20501700 15.00366000 0.00000000 0.00000000 0.00471120 0.00468770 29.5 +1951 244 13.000 10.00 16.00 0.13551500 0.46554990 -0.00001450 -0.00000580 0.10476000 -0.24409190 -0.00005420 0.00000320 8.46757030 -0.01448600 -0.00000200 0.00000000 0.55781400 -0.00010570 -0.00001050 0.00000000 0.01161900 -0.00010520 -0.00001040 0.00000000 14.95947000 15.00438000 0.00000000 0.00000000 0.00463370 0.00461070 29.7 +1952 056 9.000 6.00 12.00 -0.31351000 0.51046550 -0.00002230 -0.00000820 0.36692800 0.26274600 0.00003110 -0.00000440 -9.42160030 0.01476600 0.00000200 0.00000000 0.54060300 0.00007890 -0.00001270 0.00000000 -0.00550700 0.00007850 -0.00001260 0.00000000 311.67123400 15.00282000 0.00000000 0.00000000 0.00472320 0.00469960 29.9 +1952 233 15.000 12.00 18.00 -0.36888200 0.45544500 -0.00001390 -0.00000500 -0.49943500 -0.22031140 -0.00004480 0.00000260 12.34340000 -0.01325900 -0.00000300 0.00000000 0.56669400 -0.00001700 -0.00000970 0.00000000 0.02045400 -0.00001690 -0.00000970 0.00000000 44.18368900 15.00361000 0.00000000 0.00000000 0.00462270 0.00459970 30.1 +1953 044 1.000 22.000 24.000 -0.47586600 0.52733910 -0.00000750 -0.00000880 1.02831990 0.24680130 0.00002470 -0.00000430 -13.17891980 0.01349700 0.00000300 0.00000000 0.53758600 -0.00002620 -0.00001310 0.00000000 -0.00851000 -0.00002610 -0.00001300 0.00000000 191.42613200 15.00165000 0.00000000 0.00000000 0.00473380 0.00471020 30.3 +1953 045 1.000 0.000 4.00 -0.47586600 0.52733910 -0.00000750 -0.00000880 1.02831990 0.24680130 0.00002470 -0.00000430 -13.17891980 0.01349700 0.00000300 0.00000000 0.53758600 -0.00002620 -0.00001310 0.00000000 -0.00851000 -0.00002610 -0.00001300 0.00000000 191.42613200 15.00165000 0.00000000 0.00000000 0.00473380 0.00471020 30.3 +1953 192 3.000 0.00 6.00 0.46543000 0.51336120 -0.00006790 -0.00000650 1.36848500 -0.12129430 -0.00019700 0.00000170 22.16329960 -0.00513300 -0.00000500 0.00000000 0.55524500 0.00010170 -0.00001050 0.00000000 0.00906200 0.00010120 -0.00001040 0.00000000 223.67996200 14.99988000 0.00000000 0.00000000 0.00459960 0.00457670 30.5 +1953 221 16.000 13.00 19.00 -0.48897400 0.47216380 -0.00002730 -0.00000550 -1.25264600 -0.20170660 -0.00003190 0.00000250 15.82427020 -0.01155700 -0.00000400 0.00000000 0.56236500 0.00007530 -0.00001000 0.00000000 0.01614600 0.00007490 -0.00000990 0.00000000 58.64434100 15.00263000 0.00000000 0.00000000 0.00461330 0.00459030 30.5 +1954 005 3.000 0.00 6.00 0.43776400 0.53268030 -0.00003420 -0.00000740 -0.85840600 0.11096770 0.00020230 -0.00000170 -22.68207930 0.00423400 0.00000600 0.00000000 0.55568800 -0.00013270 -0.00001150 0.00000000 0.00950200 -0.00013200 -0.00001140 0.00000000 223.70935100 14.99671000 0.00000000 0.00000000 0.00475540 0.00473170 30.7 +1954 181 13.000 10.00 16.00 0.34972700 0.55333840 -0.00005780 -0.00000830 0.56511500 -0.08903550 -0.00018680 0.00000150 23.19103050 -0.00223900 -0.00000500 0.00000000 0.54033300 0.00009880 -0.00001180 0.00000000 -0.00577500 0.00009830 -0.00001170 0.00000000 14.14451000 14.99936000 0.00000000 0.00000000 0.00459880 0.00457590 30.8 +1954 359 8.000 5.00 11.00 0.22925000 0.50889560 -0.00001580 -0.00000590 -0.23115200 0.06321300 0.00016820 -0.00000090 -23.41061020 0.00080700 0.00000600 0.00000000 0.57061600 -0.00008810 -0.00001020 0.00000000 0.02435700 -0.00008760 -0.00001020 0.00000000 300.03530900 14.99618000 0.00000000 0.00000000 0.00475520 0.00473150 31.0 +1955 171 4.000 1.00 7.00 -0.11636700 0.58054600 -0.00001310 -0.00000980 -0.14352100 -0.04885960 -0.00016040 0.00000100 23.43098070 0.00069700 -0.00000600 0.00000000 0.53092700 0.00003840 -0.00001270 0.00000000 -0.01513400 0.00003820 -0.00001270 0.00000000 239.70013400 14.99924000 0.00000000 0.00000000 0.00460040 0.00457750 31.2 +1955 348 7.000 4.00 10.00 -0.03605500 0.50298380 -0.00000760 -0.00000560 0.42554000 0.01860390 0.00013780 -0.00000030 -23.17317960 -0.00275400 0.00000600 0.00000000 0.57507400 0.00002210 -0.00000990 0.00000000 0.02879200 0.00002190 -0.00000980 0.00000000 286.42312600 14.99640000 0.00000000 0.00000000 0.00475130 0.00472770 31.4 +1956 160 21.000 18.00 24.00 -0.20495700 0.57754780 0.00001870 -0.00000950 -0.89204400 -0.00389030 -0.00011250 0.00000020 22.90468980 0.00358500 -0.00000600 0.00000000 0.53314600 -0.00005800 -0.00001250 0.00000000 -0.01292600 -0.00005770 -0.00001250 0.00000000 135.25053400 14.99948000 0.00000000 0.00000000 0.00460490 0.00458200 31.6 +1956 337 8.000 5.00 11.00 0.04658400 0.52172340 -0.00001110 -0.00000640 1.09131000 -0.02470560 0.00010420 0.00000020 -21.97545050 -0.00610000 0.00000600 0.00000000 0.56515200 0.00010780 -0.00001060 0.00000000 0.01892000 0.00010720 -0.00001050 0.00000000 302.63574200 14.99736000 0.00000000 0.00000000 0.00474400 0.00472040 31.8 +1957 119 24.000 21.000 24.000 -0.26986100 0.51843310 0.00004830 -0.00000670 0.96326600 0.11852790 -0.00012530 -0.00000150 14.61919970 0.01257300 -0.00000300 0.00000000 0.55539500 -0.00011550 -0.00001070 0.00000000 0.00921100 -0.00011500 -0.00001070 0.00000000 180.68484500 15.00271000 0.00000000 0.00000000 0.00464150 0.00461830 32.0 +1957 120 0.000 0.000 3.00 -0.26986100 0.51843310 0.00004830 -0.00000670 0.96326600 0.11852790 -0.00012530 -0.00000150 14.61919970 0.01257300 -0.00000300 0.00000000 0.55539500 -0.00011550 -0.00001070 0.00000000 0.00921100 -0.00011500 -0.00001070 0.00000000 180.68484500 15.00271000 0.00000000 0.00000000 0.00464150 0.00461830 32.0 +1957 296 5.000 2.00 8.00 -0.20696900 0.55254370 0.00001930 -0.00000890 -0.98222300 -0.14953420 0.00013060 0.00000230 -11.30438990 -0.01428700 0.00000200 0.00000000 0.54024100 0.00008410 -0.00001250 0.00000000 -0.00586700 0.00008370 -0.00001250 0.00000000 258.89184600 15.00284000 0.00000000 0.00000000 0.00470010 0.00467670 32.2 +1958 109 3.000 0.00 6.00 -0.29426900 0.48986910 0.00003360 -0.00000560 0.20549400 0.13207620 -0.00006710 -0.00000140 10.96243000 0.01416900 -0.00000200 0.00000000 0.56789700 -0.00003950 -0.00000980 0.00000000 0.02165100 -0.00003930 -0.00000980 0.00000000 225.17787200 15.00352000 0.00000000 0.00000000 0.00465590 0.00463270 32.4 +1958 285 21.000 18.00 24.00 -0.04220300 0.55896610 0.00001830 -0.00000950 -0.29533800 -0.16694160 0.00006330 0.00000280 -7.45073990 -0.01524100 0.00000100 0.00000000 0.53487300 -0.00001300 -0.00001300 0.00000000 -0.01120800 -0.00001290 -0.00001290 0.00000000 138.36946100 15.00394000 0.00000000 0.00000000 0.00468570 0.00466240 32.6 +1959 098 3.000 0.00 6.00 -0.06549700 0.48764750 0.00000540 -0.00000560 -0.49432100 0.14635950 -0.00002140 -0.00000160 6.88698010 0.01529700 -0.00000200 0.00000000 0.56775800 0.00006210 -0.00000990 0.00000000 0.02151300 0.00006170 -0.00000990 0.00000000 224.45945700 15.00412000 0.00000000 0.00000000 0.00467060 0.00464740 32.8 +1959 275 12.000 9.00 15.00 -0.11562900 0.53915620 0.00002420 -0.00000840 0.47794400 -0.17071990 -0.00001010 0.00000260 -3.38892010 -0.01574400 0.00000100 0.00000000 0.54177500 -0.00008690 -0.00001220 0.00000000 -0.00434100 -0.00008650 -0.00001210 0.00000000 2.61192000 15.00463000 0.00000000 0.00000000 0.00467160 0.00464840 33.0 +1960 087 7.000 4.00 10.00 0.13647500 0.51057280 -0.00001860 -0.00000680 -1.16740500 0.16265200 0.00003130 -0.00000210 2.63179990 0.01591200 -0.00000100 0.00000000 0.55566200 0.00012420 -0.00001100 0.00000000 0.00947700 0.00012360 -0.00001090 0.00000000 283.63415500 15.00441000 0.00000000 0.00000000 0.00468490 0.00466160 33.3 +1960 264 23.000 20.00 24.000 0.37143900 0.50663930 -0.00000320 -0.00000660 1.14701000 -0.16377560 -0.00006280 0.00000200 0.80816000 -0.01580700 0.00000000 0.00000000 0.55587700 -0.00011170 -0.00001080 0.00000000 0.00969100 -0.00011110 -0.00001070 0.00000000 166.69998200 15.00490000 0.00000000 0.00000000 0.00465790 0.00463470 33.5 +1960 265 23.000 0.000 2.000 0.37143900 0.50663930 -0.00000320 -0.00000660 1.14701000 -0.16377560 -0.00006280 0.00000200 0.80816000 -0.01580700 0.00000000 0.00000000 0.55587700 -0.00011170 -0.00001080 0.00000000 0.00969100 -0.00011110 -0.00001070 0.00000000 166.69998200 15.00490000 0.00000000 0.00000000 0.00465790 0.00463470 33.5 +1961 046 8.000 5.00 11.00 -0.40334700 0.56142840 -0.00000660 -0.00000940 0.80846100 0.14303490 0.00003550 -0.00000230 -12.71558000 0.01394600 0.00000300 0.00000000 0.53877700 0.00005750 -0.00001290 0.00000000 -0.00732400 0.00005720 -0.00001290 0.00000000 296.43963600 15.00190000 0.00000000 0.00000000 0.00473280 0.00470920 33.6 +1961 223 11.000 8.00 14.00 -0.08008400 0.49359960 -0.00001610 -0.00000550 -0.88930900 -0.10770120 -0.00005170 0.00000110 15.27838040 -0.01209800 -0.00000300 0.00000000 0.56655200 0.00000290 -0.00000970 0.00000000 0.02031300 0.00000290 -0.00000960 0.00000000 343.71139500 15.00286000 0.00000000 0.00000000 0.00461470 0.00459170 33.8 +1962 035 24.000 21.000 24.000 -0.16164300 0.56725580 -0.00000660 -0.00000950 0.18195500 0.11603710 0.00010340 -0.00000190 -16.13048940 0.01223700 0.00000400 0.00000000 0.53948200 -0.00004890 -0.00001290 0.00000000 -0.00662300 -0.00004860 -0.00001290 0.00000000 176.49542200 15.00052000 0.00000000 0.00000000 0.00474190 0.00471830 34.0 +1962 036 0.000 0.000 3.00 -0.16164300 0.56725580 -0.00000660 -0.00000950 0.18195500 0.11603710 0.00010340 -0.00000190 -16.13048940 0.01223700 0.00000400 0.00000000 0.53948200 -0.00004890 -0.00001290 0.00000000 -0.00662300 -0.00004860 -0.00001290 0.00000000 176.49542200 15.00052000 0.00000000 0.00000000 0.00474190 0.00471830 34.0 +1962 212 12.000 9.00 15.00 -0.23680000 0.51399390 -0.00002270 -0.00000630 -0.07623200 -0.08284920 -0.00010360 0.00000090 18.32307050 -0.01003900 -0.00000400 0.00000000 0.55869900 0.00010530 -0.00001020 0.00000000 0.01249900 0.00010480 -0.00001020 0.00000000 358.42129500 15.00178000 0.00000000 0.00000000 0.00460690 0.00458390 34.3 +1963 025 14.000 11.00 17.00 0.27819200 0.54660900 -0.00001420 -0.00000790 -0.45453700 0.07954260 0.00015850 -0.00000110 -19.04698940 0.01000100 0.00000500 0.00000000 0.55157000 -0.00012860 -0.00001180 0.00000000 0.00540500 -0.00012790 -0.00001170 0.00000000 26.92914000 14.99898000 0.00000000 0.00000000 0.00474940 0.00472580 34.5 +1963 201 21.000 18.00 24.00 0.28264500 0.55049110 -0.00004300 -0.00000800 0.63240400 -0.05439410 -0.00016490 0.00000070 20.67934040 -0.00765600 -0.00000500 0.00000000 0.54363300 0.00010840 -0.00001150 0.00000000 -0.00249200 0.00010780 -0.00001140 0.00000000 133.43791200 15.00078000 0.00000000 0.00000000 0.00460120 0.00457830 34.8 +1964 014 21.000 18.00 24.00 0.35085100 0.51769870 -0.00000960 -0.00000630 -1.21234910 0.03935590 0.00019760 -0.00000040 -21.35531040 0.00720000 0.00000500 0.00000000 0.56749000 -0.00010900 -0.00001050 0.00000000 0.02124600 -0.00010850 -0.00001040 0.00000000 132.75976600 14.99754000 0.00000000 0.00000000 0.00475450 0.00473080 35.1 +1964 162 5.000 2.00 8.00 0.44756600 0.57495030 0.00000420 -0.00000980 -1.07755000 0.10219610 -0.00010130 -0.00000190 23.01786040 0.00294300 -0.00000600 0.00000000 0.53039100 -0.00000600 -0.00001280 0.00000000 -0.01566800 -0.00000600 -0.00001280 0.00000000 255.17909200 14.99942000 0.00000000 0.00000000 0.00460420 0.00458130 35.4 +1964 191 11.000 8.00 14.00 -0.12845700 0.57982410 -0.00000710 -0.00000970 1.36716800 -0.01875010 -0.00023400 0.00000020 22.32827950 -0.00502000 -0.00000500 0.00000000 0.53193300 0.00006290 -0.00001260 0.00000000 -0.01413400 0.00006260 -0.00001250 0.00000000 343.71948200 14.99996000 0.00000000 0.00000000 0.00459830 0.00457540 35.4 +1964 338 2.000 23.000 24.000 0.48824100 0.49248890 0.00000810 -0.00000550 1.03472490 -0.11638250 0.00010250 0.00000140 -22.23031040 -0.00534300 0.00000600 0.00000000 0.57325900 0.00004170 -0.00001000 0.00000000 0.02698600 0.00004150 -0.00000990 0.00000000 212.46533200 14.99710000 0.00000000 0.00000000 0.00474560 0.00472190 35.7 +1964 339 2.000 0.000 5.00 0.48824100 0.49248890 0.00000810 -0.00000550 1.03472490 -0.11638250 0.00010250 0.00000140 -22.23031040 -0.00534300 0.00000600 0.00000000 0.57325900 0.00004170 -0.00001000 0.00000000 0.02698600 0.00004150 -0.00000990 0.00000000 212.46533200 14.99710000 0.00000000 0.00000000 0.00474560 0.00472190 35.7 +1965 150 21.000 18.00 24.00 -0.05644400 0.55331930 0.00005280 -0.00000880 -0.45070900 0.14211910 -0.00012150 -0.00000240 21.83715060 0.00573800 -0.00000500 0.00000000 0.53618600 -0.00008200 -0.00001230 0.00000000 -0.00990200 -0.00008160 -0.00001220 0.00000000 135.63844300 14.99996000 0.00000000 0.00000000 0.00461100 0.00458810 36.1 +1965 327 4.000 1.00 7.00 -0.00671800 0.50674280 0.00002360 -0.00000650 0.41215000 -0.16169070 0.00011590 0.00000230 -20.29318050 -0.00836100 0.00000500 0.00000000 0.56024300 0.00012500 -0.00001090 0.00000000 0.01403500 0.00012440 -0.00001090 0.00000000 243.42034900 14.99846000 0.00000000 0.00000000 0.00473590 0.00471230 36.5 +1966 140 10.000 7.00 13.00 0.07032500 0.51234600 0.00005580 -0.00000690 0.38836200 0.16914990 -0.00013690 -0.00000240 19.92527010 0.00835200 -0.00000500 0.00000000 0.55065500 -0.00012900 -0.00001100 0.00000000 0.00449500 -0.00012840 -0.00001090 0.00000000 330.89981100 15.00075000 0.00000000 0.00000000 0.00462040 0.00459740 36.9 +1966 316 14.000 11.00 17.00 -0.32613100 0.52700210 0.00004600 -0.00000810 -0.22688800 -0.20595310 0.00013110 0.00000340 -17.67395020 -0.01081100 0.00000400 0.00000000 0.54428600 0.00011190 -0.00001230 0.00000000 -0.00184300 0.00011130 -0.00001230 0.00000000 33.96147900 15.00005000 0.00000000 0.00000000 0.00472410 0.00470060 37.3 +1967 129 15.000 12.00 18.00 -0.28596100 0.47527930 0.00006070 -0.00000540 1.11546800 0.18900470 -0.00013910 -0.00000230 17.27771950 0.01071600 -0.00000400 0.00000000 0.56457000 -0.00007390 -0.00000990 0.00000000 0.01834100 -0.00007350 -0.00000990 0.00000000 45.90193200 15.00172000 0.00000000 0.00000000 0.00463180 0.00460880 37.7 +1967 306 6.000 3.00 9.00 -0.22254800 0.53236780 0.00005380 -0.00000900 -0.99685200 -0.23859710 0.00014990 0.00000420 -14.53792950 -0.01271900 0.00000300 0.00000000 0.53616800 0.00000360 -0.00001310 0.00000000 -0.00992000 0.00000360 -0.00001300 0.00000000 274.09503200 15.00157000 0.00000000 0.00000000 0.00471170 0.00468820 38.1 +1968 088 23.000 20.00 24.000 0.49645700 0.45081620 -0.00002220 -0.00000520 -0.91050100 0.24826940 0.00001640 -0.00000310 3.30468010 0.01563900 -0.00000100 0.00000000 0.56572600 0.00007850 -0.00001020 0.00000000 0.01949000 0.00007810 -0.00001010 0.00000000 163.77092000 15.00425000 0.00000000 0.00000000 0.00468320 0.00465990 38.5 +1968 089 23.000 0.000 2.000 0.49645700 0.45081620 -0.00002220 -0.00000520 -0.91050100 0.24826940 0.00001640 -0.00000310 3.30468010 0.01563900 -0.00000100 0.00000000 0.56572600 0.00007850 -0.00001020 0.00000000 0.01949000 0.00007810 -0.00001010 0.00000000 163.77092000 15.00425000 0.00000000 0.00000000 0.00468320 0.00465990 38.5 +1968 266 11.000 8.00 14.00 0.30693300 0.48664820 -0.00000230 -0.00000710 0.91063900 -0.27046230 -0.00005330 0.00000410 0.19997000 -0.01557500 0.00000000 0.00000000 0.54497200 -0.00010320 -0.00001180 0.00000000 -0.00116000 -0.00010270 -0.00001170 0.00000000 346.83560200 15.00482000 0.00000000 0.00000000 0.00465950 0.00463630 38.9 +1969 077 5.000 2.00 8.00 0.17160100 0.47676430 -0.00002710 -0.00000660 -0.21391600 0.26538190 0.00000900 -0.00000390 -1.02358000 0.01583000 0.00000000 0.00000000 0.55192500 0.00011560 -0.00001140 0.00000000 0.00575900 0.00011500 -0.00001130 0.00000000 252.94537400 15.00419000 0.00000000 0.00000000 0.00469730 0.00467390 39.4 +1969 254 20.000 17.00 23.00 0.11380100 0.45900590 -0.00000360 -0.00000560 0.18865900 -0.25213260 -0.00003620 0.00000320 4.39598990 -0.01527000 -0.00000100 0.00000000 0.55943600 -0.00010000 -0.00001040 0.00000000 0.01323200 -0.00009950 -0.00001040 0.00000000 120.87062800 15.00476000 0.00000000 0.00000000 0.00464640 0.00462330 39.9 +1970 066 18.000 15.00 21.00 -0.03258900 0.50545260 -0.00002270 -0.00000820 0.49145600 0.27499720 -0.00000080 -0.00000460 -5.23252010 0.01554100 0.00000100 0.00000000 0.53945300 0.00006010 -0.00001270 0.00000000 -0.00665200 0.00005980 -0.00001260 0.00000000 87.22515900 15.00374000 0.00000000 0.00000000 0.00471040 0.00468690 40.4 +1970 243 22.000 19.00 24.000 -0.21532000 0.44769950 -0.00001160 -0.00000490 -0.49274400 -0.23453270 -0.00002420 0.00000270 8.54804040 -0.01448500 -0.00000200 0.00000000 0.56757600 -0.00001620 -0.00000970 0.00000000 0.02133100 -0.00001610 -0.00000970 0.00000000 149.93722500 15.00433000 0.00000000 0.00000000 0.00463370 0.00461060 40.9 +1970 244 22.000 0.000 1.000 -0.21532000 0.44769950 -0.00001160 -0.00000490 -0.49274400 -0.23453270 -0.00002420 0.00000270 8.54804040 -0.01448500 -0.00000200 0.00000000 0.56757600 -0.00001620 -0.00000970 0.00000000 0.02133100 -0.00001610 -0.00000970 0.00000000 149.93722500 15.00433000 0.00000000 0.00000000 0.00463370 0.00461060 40.9 +1971 056 10.000 7.00 13.00 -0.32150700 0.51789370 -0.00000410 -0.00000870 1.09239400 0.26550750 -0.00000510 -0.00000470 -9.26004030 0.01480200 0.00000200 0.00000000 0.53716400 -0.00004130 -0.00001300 0.00000000 -0.00892900 -0.00004110 -0.00001300 0.00000000 326.69076500 15.00288000 0.00000000 0.00000000 0.00472280 0.00469930 41.4 +1971 203 10.000 7.00 13.00 0.68553900 0.50543480 -0.00008310 -0.00000640 1.37127300 -0.15726250 -0.00018100 0.00000220 20.36965940 -0.00779900 -0.00000400 0.00000000 0.55451800 0.00010070 -0.00001050 0.00000000 0.00833900 0.00010020 -0.00001050 0.00000000 328.41455100 15.00082000 0.00000000 0.00000000 0.00460210 0.00457920 41.8 +1971 232 23.000 20.00 24.000 -0.38978900 0.46392800 -0.00002560 -0.00000540 -1.21714790 -0.22285860 -0.00001140 0.00000270 12.42899990 -0.01321400 -0.00000300 0.00000000 0.56229700 0.00007560 -0.00001000 0.00000000 0.01607900 0.00007520 -0.00001000 0.00000000 164.15951500 15.00361000 0.00000000 0.00000000 0.00462190 0.00459890 41.9 +1971 233 23.000 0.000 2.000 -0.38978900 0.46392800 -0.00002560 -0.00000540 -1.21714790 -0.22285860 -0.00001140 0.00000270 12.42899990 -0.01321400 -0.00000300 0.00000000 0.56229700 0.00007560 -0.00001000 0.00000000 0.01607900 0.00007520 -0.00001000 0.00000000 164.15951500 15.00361000 0.00000000 0.00000000 0.00462190 0.00459890 41.9 +1972 016 11.000 8.00 14.00 0.23215500 0.52077080 -0.00003420 -0.00000710 -0.90779200 0.15136750 0.00018800 -0.00000220 -21.05788990 0.00739400 0.00000500 0.00000000 0.55647800 -0.00012140 -0.00001140 0.00000000 0.01028800 -0.00012080 -0.00001130 0.00000000 342.61105300 14.99773000 0.00000000 0.00000000 0.00475370 0.00473010 42.3 +1972 192 20.000 17.00 23.00 0.28179700 0.54694630 -0.00006470 -0.00000830 0.63914200 -0.13100550 -0.00017900 0.00000220 22.14701080 -0.00514000 -0.00000500 0.00000000 0.53946500 0.00010210 -0.00001190 0.00000000 -0.00663900 0.00010160 -0.00001180 0.00000000 118.66390200 14.99998000 0.00000000 0.00000000 0.00459880 0.00457590 42.8 +1973 004 16.000 13.00 19.00 0.16819700 0.50076550 -0.00002600 -0.00000580 -0.23491100 0.10499610 0.00016070 -0.00000130 -22.68857000 0.00422700 0.00000600 0.00000000 0.57126300 -0.00008140 -0.00001020 0.00000000 0.02500000 -0.00008100 -0.00001010 0.00000000 58.72660100 14.99662000 0.00000000 0.00000000 0.00475630 0.00473260 43.3 +1973 181 12.000 9.00 15.00 0.19178900 0.57546760 -0.00004080 -0.00000970 -0.11111100 -0.09466380 -0.00015800 0.00000170 23.16778950 -0.00232900 -0.00000500 0.00000000 0.53058900 0.00001900 -0.00001280 0.00000000 -0.01547100 0.00001890 -0.00001270 0.00000000 359.11322000 14.99943000 0.00000000 0.00000000 0.00459820 0.00457530 43.8 +1973 358 15.000 12.00 18.00 -0.07312300 0.49988990 -0.00002010 -0.00000560 0.41127700 0.06085120 0.00013950 -0.00000080 -23.41661070 0.00070800 0.00000600 0.00000000 0.57516000 0.00002670 -0.00000990 0.00000000 0.02887700 0.00002660 -0.00000980 0.00000000 45.08675000 14.99615000 0.00000000 0.00000000 0.00475520 0.00473150 44.4 +1974 171 5.000 2.00 8.00 0.04381400 0.57430020 -0.00000560 -0.00000940 -0.83066500 -0.04926460 -0.00012050 0.00000090 23.43549920 0.00056700 -0.00000600 0.00000000 0.53338900 -0.00007640 -0.00001250 0.00000000 -0.01268500 -0.00007600 -0.00001240 0.00000000 254.66212500 14.99922000 0.00000000 0.00000000 0.00460050 0.00457760 44.9 +1974 347 16.000 13.00 19.00 -0.15130400 0.52346950 -0.00001600 -0.00000650 1.07530800 0.01739980 0.00011450 -0.00000030 -23.15629960 -0.00282700 0.00000600 0.00000000 0.56476500 0.00011430 -0.00001070 0.00000000 0.01853400 0.00011370 -0.00001060 0.00000000 61.46255100 14.99648000 0.00000000 0.00000000 0.00475040 0.00472670 45.4 +1975 131 7.000 4.00 10.00 -0.33642800 0.52215040 0.00004950 -0.00000670 1.02200000 0.09154180 -0.00015040 -0.00000110 17.73483090 0.01059300 -0.00000400 0.00000000 0.55560700 -0.00010870 -0.00001060 0.00000000 0.00942200 -0.00010820 -0.00001060 0.00000000 285.91113300 15.00166000 0.00000000 0.00000000 0.00462990 0.00460690 45.8 +1975 307 13.000 10.00 16.00 -0.37404200 0.55952720 0.00003070 -0.00000910 -0.96607900 -0.12643840 0.00015740 0.00000190 -14.96477030 -0.01276200 0.00000300 0.00000000 0.54037300 0.00008900 -0.00001260 0.00000000 -0.00573600 0.00008850 -0.00001260 0.00000000 19.09967000 15.00145000 0.00000000 0.00000000 0.00471330 0.00468980 46.3 +1976 120 10.000 7.00 13.00 -0.27503200 0.49430400 0.00003470 -0.00000560 0.28392600 0.11243640 -0.00009300 -0.00000120 14.56363960 0.01261900 -0.00000300 0.00000000 0.56739400 -0.00003440 -0.00000980 0.00000000 0.02115100 -0.00003420 -0.00000970 0.00000000 330.67230200 15.00265000 0.00000000 0.00000000 0.00464280 0.00461960 46.9 +1976 297 5.000 2.00 8.00 -0.21339600 0.56328300 0.00003370 -0.00000960 -0.28151400 -0.15026080 0.00009020 0.00000250 -11.44277000 -0.01423300 0.00000200 0.00000000 0.53574200 -0.00001090 -0.00001300 0.00000000 -0.01034400 -0.00001090 -0.00001300 0.00000000 258.90966800 15.00283000 0.00000000 0.00000000 0.00469980 0.00467640 47.4 +1977 108 11.000 8.00 14.00 0.33826200 0.49262390 -0.00000410 -0.00000570 -0.32183800 0.13328400 -0.00005050 -0.00000150 10.86802960 0.01420000 -0.00000200 0.00000000 0.56643300 0.00004990 -0.00001000 0.00000000 0.02019400 0.00004970 -0.00000990 0.00000000 345.16647300 15.00354000 0.00000000 0.00000000 0.00465650 0.00463330 47.9 +1977 285 20.000 17.00 23.00 -0.13762200 0.54020310 0.00003330 -0.00000830 0.44132700 -0.16101510 0.00001800 0.00000240 -7.58560990 -0.01522500 0.00000100 0.00000000 0.54330800 -0.00009000 -0.00001210 0.00000000 -0.00281600 -0.00008960 -0.00001210 0.00000000 123.39025100 15.00387000 0.00000000 0.00000000 0.00468600 0.00466270 48.4 +1978 097 15.000 12.00 18.00 0.28864300 0.51485880 -0.00001760 -0.00000690 -1.07041300 0.15584760 0.00000340 -0.00000200 6.84699010 0.01528300 -0.00000200 0.00000000 0.55396000 0.00011720 -0.00001100 0.00000000 0.00778400 0.00011670 -0.00001100 0.00000000 44.45846900 15.00419000 0.00000000 0.00000000 0.00467050 0.00464730 48.8 +1978 275 6.000 3.00 9.00 0.11055200 0.50530900 0.00001460 -0.00000650 1.18390300 -0.16086040 -0.00003930 0.00000200 -3.44973990 -0.01576000 0.00000100 0.00000000 0.55766200 -0.00009950 -0.00001070 0.00000000 0.01146700 -0.00009900 -0.00001070 0.00000000 272.61926300 15.00454000 0.00000000 0.00000000 0.00467210 0.00464880 49.3 +1979 057 17.000 14.00 20.00 -0.20600200 0.55702730 -0.00001020 -0.00000940 0.87545100 0.16251630 0.00000390 -0.00000260 -8.75745960 0.01517600 0.00000200 0.00000000 0.53787900 0.00004140 -0.00001300 0.00000000 -0.00821800 0.00004110 -0.00001290 0.00000000 71.75305900 15.00311000 0.00000000 0.00000000 0.00472150 0.00469800 49.7 +1979 234 17.000 14.00 20.00 -0.42897500 0.48865560 -0.00000310 -0.00000550 -0.88320200 -0.12830280 -0.00002930 0.00000140 11.82268050 -0.01367800 -0.00000300 0.00000000 0.56706000 0.00002140 -0.00000970 0.00000000 0.02081800 0.00002130 -0.00000970 0.00000000 74.26717400 15.00381000 0.00000000 0.00000000 0.00462390 0.00460090 50.2 +1980 047 9.000 6.00 12.00 0.00102400 0.56041690 -0.00001240 -0.00000930 0.22978800 0.14254690 0.00007350 -0.00000230 -12.56628040 0.01400700 0.00000300 0.00000000 0.53932600 -0.00006220 -0.00001290 0.00000000 -0.00677800 -0.00006190 -0.00001280 0.00000000 311.45929000 15.00195000 0.00000000 0.00000000 0.00473260 0.00470910 50.6 +1980 223 19.000 16.00 22.00 -0.14559400 0.51036760 -0.00002790 -0.00000630 -0.16445500 -0.11048350 -0.00007830 0.00000130 15.35354040 -0.01204400 -0.00000300 0.00000000 0.55835700 0.00010530 -0.00001030 0.00000000 0.01215900 0.00010470 -0.00001030 0.00000000 103.69719700 15.00288000 0.00000000 0.00000000 0.00461400 0.00459100 51.1 +1981 035 22.000 19.00 24.000 0.01344600 0.53927890 -0.00000570 -0.00000780 -0.49118500 0.11136020 0.00013520 -0.00000150 -16.03495030 0.01230600 0.00000400 0.00000000 0.55202500 -0.00011760 -0.00001170 0.00000000 0.00585800 -0.00011700 -0.00001160 0.00000000 146.49736000 15.00049000 0.00000000 0.00000000 0.00474230 0.00471870 51.5 +1981 036 22.000 0.000 1.000 0.01344600 0.53927890 -0.00000570 -0.00000780 -0.49118500 0.11136020 0.00013520 -0.00000150 -16.03495030 0.01230600 0.00000400 0.00000000 0.55202500 -0.00011760 -0.00001170 0.00000000 0.00585800 -0.00011700 -0.00001160 0.00000000 146.49736000 15.00049000 0.00000000 0.00000000 0.00474230 0.00471870 51.5 +1981 212 4.000 1.00 7.00 0.21525300 0.54793640 -0.00004560 -0.00000800 0.55176700 -0.08917380 -0.00014110 0.00000120 18.30328940 -0.01003600 -0.00000400 0.00000000 0.54299300 0.00011140 -0.00001160 0.00000000 -0.00312900 0.00011080 -0.00001150 0.00000000 238.42109700 15.00187000 0.00000000 0.00000000 0.00460610 0.00458320 51.9 +1982 025 5.000 2.00 8.00 0.32499700 0.51230950 -0.00001700 -0.00000620 -1.19656400 0.07533980 0.00017720 -0.00000080 -19.03972050 0.01001400 0.00000500 0.00000000 0.56792400 -0.00010190 -0.00001040 0.00000000 0.02167700 -0.00010140 -0.00001040 0.00000000 251.93632500 14.99890000 0.00000000 0.00000000 0.00475010 0.00472640 52.3 +1982 172 12.000 9.00 15.00 0.07337400 0.58126400 0.00001210 -0.00000990 -1.20875700 0.05667380 -0.00009920 -0.00000110 23.44343950 -0.00007000 -0.00000600 0.00000000 0.53014200 0.00000110 -0.00001280 0.00000000 -0.01591600 0.00000100 -0.00001280 0.00000000 359.59048500 14.99924000 0.00000000 0.00000000 0.00460000 0.00457710 52.6 +1982 201 19.000 16.00 22.00 0.27990600 0.57789010 -0.00003700 -0.00000970 1.26646700 -0.06000160 -0.00021320 0.00000090 20.61553960 -0.00772000 -0.00000400 0.00000000 0.53170800 0.00004360 -0.00001270 0.00000000 -0.01435700 0.00004340 -0.00001260 0.00000000 103.42675800 15.00088000 0.00000000 0.00000000 0.00460080 0.00457790 52.7 +1982 349 10.000 7.00 13.00 0.40209100 0.50094630 0.00000050 -0.00000570 1.08119800 -0.07597220 0.00011160 0.00000100 -23.26392940 -0.00201900 0.00000600 0.00000000 0.57327700 0.00004610 -0.00001000 0.00000000 0.02700400 0.00004580 -0.00001000 0.00000000 331.24942000 14.99633000 0.00000000 0.00000000 0.00475180 0.00472810 53.0 +1983 162 5.000 2.00 8.00 0.24025900 0.56096530 0.00003000 -0.00000890 -0.45982300 0.09958330 -0.00013400 -0.00000170 23.04494100 0.00283400 -0.00000600 0.00000000 0.53645000 -0.00009960 -0.00001220 0.00000000 -0.00963900 -0.00009910 -0.00001210 0.00000000 255.14927700 14.99936000 0.00000000 0.00000000 0.00460450 0.00458150 53.3 +1983 338 13.000 10.00 16.00 0.34178900 0.51896450 0.00000380 -0.00000680 0.33128400 -0.12362550 0.00013730 0.00000180 -22.20572090 -0.00537000 0.00000600 0.00000000 0.56003400 0.00011000 -0.00001100 0.00000000 0.01382700 0.00010940 -0.00001100 0.00000000 17.49019100 14.99719000 0.00000000 0.00000000 0.00474480 0.00472120 53.7 +1984 151 17.000 14.00 20.00 0.05601100 0.52088930 0.00005120 -0.00000690 0.29867200 0.13301230 -0.00015060 -0.00000190 21.86890030 0.00569500 -0.00000500 0.00000000 0.55108400 -0.00012500 -0.00001090 0.00000000 0.00492200 -0.00012440 -0.00001080 0.00000000 75.61669900 14.99986000 0.00000000 0.00000000 0.00461160 0.00458860 54.0 +1984 327 23.000 20.00 24.000 -0.04324900 0.54060380 0.00003250 -0.00000840 -0.31485900 -0.17163490 0.00015930 0.00000280 -20.32707020 -0.00828800 0.00000500 0.00000000 0.54429100 0.00009640 -0.00001240 0.00000000 -0.00183800 0.00009590 -0.00001230 0.00000000 168.41832000 14.99853000 0.00000000 0.00000000 0.00473520 0.00471160 54.3 +1984 328 23.000 0.000 2.000 -0.04324900 0.54060380 0.00003250 -0.00000840 -0.31485900 -0.17163490 0.00015930 0.00000280 -20.32707020 -0.00828800 0.00000500 0.00000000 0.54429100 0.00009640 -0.00001240 0.00000000 -0.00183800 0.00009590 -0.00001230 0.00000000 168.41832000 14.99853000 0.00000000 0.00000000 0.00473520 0.00471160 54.3 +1985 139 21.000 18.00 24.00 -0.57546300 0.48482390 0.00006910 -0.00000550 0.93886300 0.16021270 -0.00015240 -0.00000200 19.89410970 0.00840400 -0.00000500 0.00000000 0.56446800 -0.00005250 -0.00000990 0.00000000 0.01823900 -0.00005220 -0.00000980 0.00000000 135.88954200 15.00069000 0.00000000 0.00000000 0.00462120 0.00459820 54.5 +1985 316 14.000 11.00 17.00 -0.45631000 0.54434080 0.00007060 -0.00000920 -0.87380500 -0.21001160 0.00017000 0.00000380 -17.77672960 -0.01071500 0.00000400 0.00000000 0.53676900 0.00001190 -0.00001310 0.00000000 -0.00932200 0.00001180 -0.00001300 0.00000000 33.95472000 15.00004000 0.00000000 0.00000000 0.00472400 0.00470040 54.8 +1986 099 6.000 3.00 9.00 0.34347800 0.45629580 -0.00000640 -0.00000530 -1.04254600 0.24137660 0.00000000 -0.00000300 7.48053980 0.01493900 -0.00000200 0.00000000 0.56414100 0.00008970 -0.00001020 0.00000000 0.01791400 0.00008930 -0.00001010 0.00000000 269.57122800 15.00398000 0.00000000 0.00000000 0.00466900 0.00464580 55.0 +1986 276 19.000 16.00 22.00 0.42664500 0.48638750 0.00000560 -0.00000700 0.89859100 -0.26658240 -0.00002940 0.00000400 -4.06904980 -0.01545800 0.00000100 0.00000000 0.54658300 -0.00011010 -0.00001170 0.00000000 0.00044300 -0.00010950 -0.00001170 0.00000000 107.74845900 15.00441000 0.00000000 0.00000000 0.00467350 0.00465020 55.2 +1987 088 13.000 10.00 16.00 0.22913500 0.47956260 -0.00001680 -0.00000670 -0.22226300 0.26463540 -0.00001340 -0.00000390 3.29555010 0.01560400 -0.00000100 0.00000000 0.55025100 0.00011280 -0.00001150 0.00000000 0.00409300 0.00011230 -0.00001140 0.00000000 13.76953000 15.00431000 0.00000000 0.00000000 0.00468330 0.00466000 55.4 +1987 266 3.000 0.00 6.00 0.04200800 0.45559470 0.00001020 -0.00000550 0.29572800 -0.25436290 -0.00001890 0.00000320 0.17405000 -0.01560800 0.00000000 0.00000000 0.56106900 -0.00009200 -0.00001040 0.00000000 0.01485700 -0.00009150 -0.00001030 0.00000000 226.83679200 15.00476000 0.00000000 0.00000000 0.00465960 0.00463640 55.6 +1988 077 2.000 23.000 24.000 -0.19467900 0.50395760 -0.00000070 -0.00000820 0.37094000 0.28034660 -0.00001930 -0.00000480 -0.91813000 0.01579700 0.00000000 0.00000000 0.53823400 0.00006380 -0.00001270 0.00000000 -0.00786400 0.00006350 -0.00001270 0.00000000 207.96847500 15.00426000 0.00000000 0.00000000 0.00469700 0.00467360 55.9 +1988 078 2.000 0.000 5.00 -0.19467900 0.50395760 -0.00000070 -0.00000820 0.37094000 0.28034660 -0.00001930 -0.00000480 -0.91813000 0.01579700 0.00000000 0.00000000 0.53823400 0.00006380 -0.00001270 0.00000000 -0.00786400 0.00006350 -0.00001270 0.00000000 207.96847500 15.00426000 0.00000000 0.00000000 0.00469700 0.00467360 55.9 +1988 255 5.000 2.00 8.00 -0.11086500 0.44259560 -0.00000580 -0.00000490 -0.47318000 -0.24311570 -0.00000410 0.00000280 4.48112010 -0.01527400 -0.00000100 0.00000000 0.56848300 -0.00001320 -0.00000970 0.00000000 0.02223400 -0.00001320 -0.00000970 0.00000000 255.84582500 15.00472000 0.00000000 0.00000000 0.00464590 0.00462280 56.1 +1989 066 18.000 15.00 21.00 -0.59674700 0.51151340 0.00002300 -0.00000850 0.92568600 0.27690780 -0.00002170 -0.00000480 -5.08024980 0.01555600 0.00000100 0.00000000 0.53672100 -0.00003370 -0.00001300 0.00000000 -0.00937000 -0.00003350 -0.00001290 0.00000000 87.25440200 15.00378000 0.00000000 0.00000000 0.00471020 0.00468670 56.4 +1989 243 6.000 3.00 9.00 -0.33568800 0.45761240 -0.00001960 -0.00000530 -1.17003090 -0.23831220 0.00000870 0.00000290 8.64247040 -0.01444700 -0.00000200 0.00000000 0.56232600 0.00007800 -0.00001010 0.00000000 0.01610800 0.00007770 -0.00001010 0.00000000 269.90951500 15.00434000 0.00000000 0.00000000 0.00463280 0.00460980 56.7 +1990 026 20.000 17.00 23.00 0.56778200 0.50742020 -0.00005080 -0.00000690 -0.79894900 0.18643750 0.00016130 -0.00000270 -18.62073000 0.01014600 0.00000400 0.00000000 0.55694900 -0.00013390 -0.00001130 0.00000000 0.01075700 -0.00013320 -0.00001120 0.00000000 116.84974000 14.99911400 0.00000000 0.00000000 0.00474880 0.00472510 56.9 +1990 203 3.000 0.00 6.00 0.19994600 0.53828200 -0.00006690 -0.00000820 0.73352000 -0.16929630 -0.00016640 0.00000280 20.34538000 -0.00779800 -0.00000500 0.00000000 0.53878500 0.00010620 -0.00001190 0.00000000 -0.00731600 0.00010560 -0.00001190 0.00000000 223.39980000 15.00091500 0.00000000 0.00000000 0.00460170 0.00457880 57.2 +1991 014 24.000 21.000 24.000 0.12669100 0.49010650 -0.00003300 -0.00000560 -0.24713200 0.14324540 0.00014570 -0.00000180 -21.07115000 0.00739100 0.00000500 0.00000000 0.57167600 -0.00007540 -0.00001020 0.00000000 0.02541100 -0.00007500 -0.00001010 0.00000000 177.63292000 14.99764300 0.00000000 0.00000000 0.00475420 0.00473060 57.6 +1991 015 0.000 0.000 3.00 0.12669100 0.49010650 -0.00003300 -0.00000560 -0.24713200 0.14324540 0.00014570 -0.00000180 -21.07115000 0.00739100 0.00000500 0.00000000 0.57167600 -0.00007540 -0.00001020 0.00000000 0.02541100 -0.00007500 -0.00001010 0.00000000 177.63292000 14.99764300 0.00000000 0.00000000 0.00475420 0.00473060 57.6 +1991 192 19.000 16.00 22.00 -0.06725900 0.56713760 -0.00003690 -0.00000960 0.01212700 -0.13797720 -0.00015290 0.00000250 22.09743000 -0.00522000 -0.00000500 0.00000000 0.53041400 0.00002520 -0.00001280 0.00000000 -0.01564500 0.00002510 -0.00001270 0.00000000 103.63978000 15.00005800 0.00000000 0.00000000 0.00459860 0.00457570 57.9 +1992 004 23.000 20.00 24.000 -0.12922300 0.49348110 -0.00003040 -0.00000550 0.39099500 0.10225830 0.00013210 -0.00000130 -22.72167000 0.00413200 0.00000600 0.00000000 0.57502600 0.00003210 -0.00000990 0.00000000 0.02874400 0.00003200 -0.00000990 0.00000000 163.77448000 14.99658400 0.00000000 0.00000000 0.00475630 0.00473260 58.3 +1992 005 23.000 0.000 2.000 -0.12922300 0.49348110 -0.00003040 -0.00000550 0.39099500 0.10225830 0.00013210 -0.00000130 -22.72167000 0.00413200 0.00000600 0.00000000 0.57502600 0.00003210 -0.00000990 0.00000000 0.02874400 0.00003200 -0.00000990 0.00000000 163.77448000 14.99658400 0.00000000 0.00000000 0.00475630 0.00473260 58.3 +1992 182 12.000 9.00 15.00 -0.23040100 0.56738230 -0.00000380 -0.00000920 -0.72325000 -0.09407900 -0.00012280 0.00000170 23.14090000 -0.00244500 -0.00000600 0.00000000 0.53385500 -0.00007130 -0.00001240 0.00000000 -0.01222100 -0.00007090 -0.00001240 0.00000000 359.08344000 14.99942900 0.00000000 0.00000000 0.00459840 0.00457550 58.7 +1992 358 1.000 22.000 24.000 0.12051400 0.52160690 -0.00003970 -0.00000650 1.09277000 0.06171780 0.00011410 -0.00000090 -23.41922000 0.00064300 0.00000700 0.00000000 0.56433100 0.00010120 -0.00001070 0.00000000 0.01810200 0.00010070 -0.00001070 0.00000000 195.11781300 14.99621000 0.00000000 0.00000000 0.00475450 0.00473090 59.1 +1992 359 1.000 0.000 4.00 0.12051400 0.52160690 -0.00003970 -0.00000650 1.09277000 0.06171780 0.00011410 -0.00000090 -23.41922000 0.00064300 0.00000700 0.00000000 0.56433100 0.00010120 -0.00001070 0.00000000 0.01810200 0.00010070 -0.00001070 0.00000000 195.11781300 14.99621000 0.00000000 0.00000000 0.00475450 0.00473090 59.1 +1993 141 14.000 11.00 17.00 -0.30414200 0.52511010 0.00004290 -0.00000670 1.11016100 0.05911710 -0.00017390 -0.00000070 20.25684930 0.00822100 -0.00000500 0.00000000 0.55585800 -0.00010480 -0.00001050 0.00000000 0.00967200 -0.00010430 -0.00001050 0.00000000 30.86197100 15.00062000 0.00000000 0.00000000 0.00461950 0.00459650 59.4 +1993 317 22.000 19.00 24.000 -0.03945600 0.56676360 0.00001330 -0.00000920 -1.04916890 -0.09547200 0.00018790 0.00000150 -18.14669040 -0.01068700 0.00000400 0.00000000 0.54056600 0.00007180 -0.00001270 0.00000000 -0.00554400 0.00007140 -0.00001260 0.00000000 153.90306100 14.99990000 0.00000000 0.00000000 0.00472560 0.00470200 59.8 +1993 318 22.000 0.000 1.000 -0.03945600 0.56676360 0.00001330 -0.00000920 -1.04916890 -0.09547200 0.00018790 0.00000150 -18.14669040 -0.01068700 0.00000400 0.00000000 0.54056600 0.00007180 -0.00001270 0.00000000 -0.00554400 0.00007140 -0.00001260 0.00000000 153.90306100 14.99990000 0.00000000 0.00000000 0.00472560 0.00470200 59.8 +1994 130 17.000 14.00 20.00 -0.17342000 0.49906290 0.00002960 -0.00000560 0.38365200 0.08693930 -0.00011830 -0.00000090 17.68613000 0.01064200 -0.00000400 0.00000000 0.56691300 -0.00003180 -0.00000980 0.00000000 0.02067200 -0.00003170 -0.00000970 0.00000000 75.90923000 15.00162100 0.00000000 0.00000000 0.00463080 0.00460770 60.2 +1994 307 14.000 11.00 17.00 0.11255000 0.56878270 0.00002070 -0.00000970 -0.38557000 -0.12578030 0.00012330 0.00000200 -15.10091000 -0.01268600 0.00000300 0.00000000 0.53659700 -0.00003140 -0.00001300 0.00000000 -0.00949300 -0.00003120 -0.00001300 0.00000000 34.10425000 15.00142100 0.00000000 0.00000000 0.00471330 0.00468990 60.6 +1995 119 18.000 15.00 21.00 0.29701000 0.49877340 -0.00000070 -0.00000580 -0.27902300 0.11401000 -0.00007490 -0.00000130 14.48233000 0.01265900 -0.00000300 0.00000000 0.56506700 0.00005580 -0.00001000 0.00000000 0.01883500 0.00005550 -0.00000990 0.00000000 90.65739000 15.00268200 0.00000000 0.00000000 0.00464330 0.00462020 61.0 +1995 297 5.000 2.00 8.00 0.33002800 0.54305180 0.00001820 -0.00000830 0.27634900 -0.14411000 0.00005250 0.00000210 -11.58057000 -0.01419600 0.00000200 0.00000000 0.54475300 -0.00011490 -0.00001210 0.00000000 -0.00137800 -0.00011430 -0.00001200 0.00000000 258.92838000 15.00274000 0.00000000 0.00000000 0.00470030 0.00467690 61.4 +1996 108 23.000 20.00 24.000 0.46804100 0.52094160 -0.00001940 -0.00000710 -0.96887400 0.14228970 -0.00002450 -0.00000190 10.83629040 0.01419100 -0.00000300 0.00000000 0.55227600 0.00010840 -0.00001110 0.00000000 0.00610800 0.00010790 -0.00001100 0.00000000 165.15182500 15.00361000 0.00000000 0.00000000 0.00465640 0.00463320 61.8 +1996 109 23.000 0.000 2.000 0.46804100 0.52094160 -0.00001940 -0.00000710 -0.96887400 0.14228970 -0.00002450 -0.00000190 10.83629040 0.01419100 -0.00000300 0.00000000 0.55227600 0.00010840 -0.00001110 0.00000000 0.00610800 0.00010790 -0.00001100 0.00000000 165.15182500 15.00361000 0.00000000 0.00000000 0.00465640 0.00463320 61.8 +1996 286 14.000 11.00 17.00 0.29615900 0.50603630 0.00001450 -0.00000640 1.08322500 -0.15152180 -0.00001020 0.00000180 -7.63950010 -0.01523400 0.00000200 0.00000000 0.55934800 -0.00010670 -0.00001070 0.00000000 0.01314400 -0.00010620 -0.00001060 0.00000000 33.40581900 15.00378000 0.00000000 0.00000000 0.00468650 0.00466320 62.1 +1997 067 1.000 22.000 24.000 -0.50503000 0.55430740 0.00001340 -0.00000930 0.80380800 0.17435860 -0.00002040 -0.00000290 -4.55016000 0.01586200 0.00000100 0.00000000 0.53689100 0.00004860 -0.00001300 0.00000000 -0.00920100 0.00004840 -0.00001290 0.00000000 192.33604000 15.00396100 0.00000000 0.00000000 0.00470880 0.00468530 62.4 +1997 068 1.000 0.000 4.00 -0.50503000 0.55430740 0.00001340 -0.00000930 0.80380800 0.17435860 -0.00002040 -0.00000290 -4.55016000 0.01586200 0.00000100 0.00000000 0.53689100 0.00004860 -0.00001300 0.00000000 -0.00920100 0.00004840 -0.00001290 0.00000000 192.33604000 15.00396100 0.00000000 0.00000000 0.00470880 0.00468530 62.4 +1997 244 24.000 21.000 24.000 -0.33190000 0.48463470 -0.00000260 -0.00000540 -0.98140200 -0.14306040 -0.00000310 0.00000150 7.98437980 -0.01483800 -0.00000200 0.00000000 0.56764100 0.00002240 -0.00000970 0.00000000 0.02139600 0.00002230 -0.00000970 0.00000000 180.05259700 15.00450000 0.00000000 0.00000000 0.00463490 0.00461180 62.7 +1997 245 0.000 0.000 3.00 -0.33190000 0.48463470 -0.00000260 -0.00000540 -0.98140200 -0.14306040 -0.00000310 0.00000150 7.98437980 -0.01483800 -0.00000200 0.00000000 0.56764100 0.00002240 -0.00000970 0.00000000 0.02139600 0.00002230 -0.00000970 0.00000000 180.05259700 15.00450000 0.00000000 0.00000000 0.00463490 0.00461180 62.7 +1998 057 17.000 14.00 20.00 -0.33884800 0.55449570 0.00001030 -0.00000920 0.15050500 0.16113160 0.00004940 -0.00000260 -8.60943000 0.01521500 0.00000200 0.00000000 0.53915900 -0.00005210 -0.00001280 0.00000000 -0.00694400 -0.00005190 -0.00001280 0.00000000 71.77806000 15.00313000 0.00000000 0.00000000 0.00472160 0.00469810 63.0 +1998 233 2.000 23.000 24.000 -0.12743100 0.50677430 -0.00002700 -0.00000630 -0.24000000 -0.13235680 -0.00005200 0.00000160 11.89285000 -0.01363700 -0.00000300 0.00000000 0.55809700 0.00010750 -0.00001040 0.00000000 0.01190000 0.00010700 -0.00001030 0.00000000 209.24457000 15.00384700 0.00000000 0.00000000 0.00462290 0.00459990 63.3 +1998 234 2.000 0.000 5.00 -0.12743100 0.50677430 -0.00002700 -0.00000630 -0.24000000 -0.13235680 -0.00005200 0.00000160 11.89285000 -0.01363700 -0.00000300 0.00000000 0.55809700 0.00010750 -0.00001040 0.00000000 0.01190000 0.00010700 -0.00001030 0.00000000 209.24457000 15.00384700 0.00000000 0.00000000 0.00462290 0.00459990 63.3 +1999 047 7.000 4.00 10.00 0.34195700 0.53182110 -0.00001820 -0.00000760 -0.40033100 0.13612880 0.00010500 -0.00000180 -12.45961000 0.01406600 0.00000300 0.00000000 0.55225100 -0.00013240 -0.00001160 0.00000000 0.00608200 -0.00013180 -0.00001160 0.00000000 281.47751000 15.00190800 0.00000000 0.00000000 0.00473320 0.00470970 63.5 +1999 223 11.000 8.00 14.00 0.07004200 0.54430350 -0.00004060 -0.00000810 0.50284100 -0.11849290 -0.00011580 0.00000170 15.32734000 -0.01203500 -0.00000300 0.00000000 0.54246900 0.00011680 -0.00001170 0.00000000 -0.00365000 0.00011630 -0.00001160 0.00000000 343.68741000 15.00298200 0.00000000 0.00000000 0.00461290 0.00459000 63.7 +2001 172 12.000 9.00 15.00 0.01038600 0.56538320 0.00002920 -0.00000870 -0.57188300 0.05512640 -0.00013400 -0.00000110 23.43977000 -0.00018300 -0.00000600 0.00000000 0.53697100 -0.00009440 -0.00001210 0.00000000 -0.00912000 -0.00009390 -0.00001210 0.00000000 359.56018000 14.99919200 0.00000000 0.00000000 0.00460050 0.00457750 64.2 +2001 348 21.000 18.00 24.00 0.12368700 0.52894790 0.00000210 -0.00000790 0.39462500 -0.08130230 0.00014570 0.00000120 -23.25180000 -0.00205500 0.00000600 0.00000000 0.55952800 0.00011850 -0.00001110 0.00000000 0.01332400 0.00011790 -0.00001100 0.00000000 136.27827000 14.99641500 0.00000000 0.00000000 0.00475080 0.00472720 64.3 +2002 160 24.000 21.000 24.000 0.09396300 0.52745400 0.00004030 -0.00000710 0.21901800 0.09319000 -0.00015930 -0.00000130 23.05547000 0.00279500 -0.00000600 0.00000000 0.55165600 -0.00012320 -0.00001080 0.00000000 0.00549100 -0.00012250 -0.00001070 0.00000000 180.13342000 14.99926300 0.00000000 0.00000000 0.00460540 0.00458240 64.3 +2002 161 0.000 0.000 3.00 0.09396300 0.52745400 0.00004030 -0.00000710 0.21901800 0.09319000 -0.00015930 -0.00000130 23.05547000 0.00279500 -0.00000600 0.00000000 0.55165600 -0.00012320 -0.00001080 0.00000000 0.00549100 -0.00012250 -0.00001070 0.00000000 180.13342000 14.99926300 0.00000000 0.00000000 0.00460540 0.00458240 64.3 +2002 338 8.000 5.00 11.00 0.18619000 0.55325520 0.00001450 -0.00000980 -0.35445800 -0.13091310 0.00018060 0.00000220 -22.22650000 -0.00529700 0.00000600 0.00000000 0.54416500 0.00008340 -0.00001250 0.00000000 -0.00196300 0.00008300 -0.00001240 0.00000000 302.48074000 14.99726500 0.00000000 0.00000000 0.00474370 0.00472010 64.4 +2003 151 4.000 1.00 7.00 -0.32387700 0.49389820 0.00005460 -0.00000540 0.94521600 0.12632840 -0.00016920 -0.00000150 21.84598000 0.00574600 -0.00000400 0.00000000 0.56438400 -0.00005300 -0.00000980 0.00000000 0.01815600 -0.00005270 -0.00000980 0.00000000 240.61102000 14.99979200 0.00000000 0.00000000 0.00461260 0.00458960 64.5 +2003 327 23.000 20.00 24.000 -0.19795400 0.55690030 0.00005560 -0.00001000 -0.94781800 -0.17392380 0.00019910 0.00000310 -20.40539000 -0.00817800 0.00000500 0.00000000 0.53732700 -0.00000320 -0.00001310 0.00000000 -0.00876700 -0.00000320 -0.00001300 0.00000000 168.39499000 14.99854000 0.00000000 0.00000000 0.00473480 0.00471120 64.5 +2003 328 23.000 0.000 2.000 -0.19795400 0.55690030 0.00005560 -0.00001000 -0.94781800 -0.17392380 0.00019910 0.00000310 -20.40539000 -0.00817800 0.00000500 0.00000000 0.53732700 -0.00000320 -0.00001310 0.00000000 -0.00876700 -0.00000320 -0.00001300 0.00000000 168.39499000 14.99854000 0.00000000 0.00000000 0.00473480 0.00471120 64.5 +2005 098 21.000 18.00 24.00 0.35032000 0.48577370 -0.00001010 -0.00000680 -0.20742200 0.25757550 -0.00003670 -0.00000390 7.48629000 0.01489900 -0.00000200 0.00000000 0.54854700 0.00010690 -0.00001150 0.00000000 0.00239800 0.00010640 -0.00001150 0.00000000 134.57384000 15.00404300 0.00000000 0.00000000 0.00466860 0.00464540 64.7 +2005 276 11.000 8.00 14.00 0.36610000 0.45548370 0.00000910 -0.00000610 0.17581700 -0.25080570 0.00000750 0.00000320 -4.09224000 -0.01549100 0.00000100 0.00000000 0.56266000 -0.00010220 -0.00001030 0.00000000 0.01644000 -0.00010170 -0.00001030 0.00000000 347.75363000 15.00434100 0.00000000 0.00000000 0.00467400 0.00465080 64.8 +2006 088 10.000 7.00 13.00 -0.28988200 0.50608680 0.00001820 -0.00000830 0.27898800 0.27899100 -0.00003860 -0.00000480 3.39884000 0.01555700 -0.00000100 0.00000000 0.53700100 0.00006440 -0.00001270 0.00000000 -0.00909100 0.00006410 -0.00001270 0.00000000 328.79321000 15.00436400 0.00000000 0.00000000 0.00468260 0.00465930 64.9 +2006 265 12.000 9.00 15.00 -0.06065600 0.44050890 0.00000370 -0.00000460 -0.43146900 -0.24612790 0.00001520 0.00000290 0.26179000 -0.01562100 -0.00000000 0.00000000 0.56941900 -0.00000790 -0.00000980 0.00000000 0.02316600 -0.00000790 -0.00000970 0.00000000 1.81219000 15.00472500 0.00000000 0.00000000 0.00465930 0.00463610 65.0 +2008 038 4.000 1.00 7.00 0.41244400 0.49430760 -0.00004040 -0.00000640 -0.86425000 0.21449760 0.00013940 -0.00000300 -15.51264000 0.01237700 0.00000400 0.00000000 0.55741600 -0.00012460 -0.00001120 0.00000000 0.01122200 -0.00012400 -0.00001120 0.00000000 236.47757000 15.00059600 0.00000000 0.00000000 0.00474170 0.00471810 65.5 +2008 214 10.000 7.00 13.00 0.10184300 0.52857890 -0.00006210 -0.00000860 0.85062200 -0.20252130 -0.00015120 0.00000330 17.86754000 -0.01012100 -0.00000400 0.00000000 0.53823100 0.00011110 -0.00001200 0.00000000 -0.00786700 0.00011050 -0.00001200 0.00000000 328.42578000 15.00200800 0.00000000 0.00000000 0.00460650 0.00458360 65.6 +2009 026 8.000 5.00 11.00 0.09963900 0.47819680 -0.00003500 -0.00000550 -0.26384400 0.17630640 0.00012540 -0.00000210 -18.64790000 0.01014500 0.00000400 0.00000000 0.57190700 -0.00006970 -0.00001010 0.00000000 0.02564100 -0.00006930 -0.00001010 0.00000000 296.86316000 14.99901400 0.00000000 0.00000000 0.00474980 0.00472620 65.8 +2009 203 3.000 0.00 6.00 0.24005900 0.55639750 -0.00005830 -0.00001000 -0.00328300 -0.17745710 -0.00013460 0.00000320 20.26424000 -0.00787300 -0.00000400 0.00000000 0.53042600 0.00000630 -0.00001280 0.00000000 -0.01563300 0.00000630 -0.00001270 0.00000000 223.38823000 15.00100700 0.00000000 0.00000000 0.00460130 0.00457840 65.9 +2010 015 7.000 4.00 10.00 -0.17322400 0.48451680 -0.00004000 -0.00000470 0.36640800 0.14049240 0.00011710 -0.00000180 -21.12929000 0.00730800 0.00000500 0.00000000 0.57467500 0.00003720 -0.00000990 0.00000000 0.02839500 0.00003700 -0.00000990 0.00000000 282.67114000 14.99758400 0.00000000 0.00000000 0.00475450 0.00473080 66.0 +2010 192 20.000 17.00 23.00 0.07414800 0.55724950 -0.00002720 -0.00000890 -0.71703800 -0.13665730 -0.00011190 0.00000240 22.03570000 -0.00534100 -0.00000500 0.00000000 0.53442200 -0.00009080 -0.00001240 0.00000000 -0.01165700 -0.00009040 -0.00001230 0.00000000 118.61430000 15.00007500 0.00000000 0.00000000 0.00459880 0.00457590 66.2 +2012 140 24.000 21.000 24.000 -0.00227200 0.50318120 0.00001830 -0.00000570 0.48552200 0.05605360 -0.00014110 -0.00000060 20.22055000 0.00827100 -0.00000500 0.00000000 0.56650600 -0.00003120 -0.00000970 0.00000000 0.02024700 -0.00003110 -0.00000970 0.00000000 180.85658000 15.00057800 0.00000000 0.00000000 0.00462040 0.00459740 66.7 +2012 141 0.000 0.000 3.00 -0.00227200 0.50318120 0.00001830 -0.00000570 0.48552200 0.05605360 -0.00014110 -0.00000060 20.22055000 0.00827100 -0.00000500 0.00000000 0.56650600 -0.00003120 -0.00000970 0.00000000 0.02024700 -0.00003110 -0.00000970 0.00000000 180.85658000 15.00057800 0.00000000 0.00000000 0.00462040 0.00459740 66.7 +2012 318 22.000 19.00 24.000 -0.18374100 0.57433870 0.00003500 -0.00000970 -0.34676000 -0.09406980 0.00014830 0.00000150 -18.24755000 -0.01060200 0.00000400 0.00000000 0.53746400 -0.00002290 -0.00001300 0.00000000 -0.00865000 -0.00002280 -0.00001300 0.00000000 153.89781000 14.99986800 0.00000000 0.00000000 0.00472550 0.00470200 66.8 +2012 319 22.000 0.000 1.000 -0.18374100 0.57433870 0.00003500 -0.00000970 -0.34676000 -0.09406980 0.00014830 0.00000150 -18.24755000 -0.01060200 0.00000400 0.00000000 0.53746400 -0.00002290 -0.00001300 0.00000000 -0.00865000 -0.00002280 -0.00001300 0.00000000 153.89781000 14.99986800 0.00000000 0.00000000 0.00472550 0.00470200 66.8 +2013 129 24.000 21.000 24.000 -0.17518100 0.50528710 0.00001450 -0.00000590 -0.30430100 0.08888960 -0.00009580 -0.00000100 17.60547000 0.01070100 -0.00000400 0.00000000 0.56369000 0.00007880 -0.00001000 0.00000000 0.01744600 0.00007840 -0.00001000 0.00000000 180.90349000 15.00166100 0.00000000 0.00000000 0.00463130 0.00460820 67.0 +2013 130 0.000 0.000 3.00 -0.17518100 0.50528710 0.00001450 -0.00000590 -0.30430100 0.08888960 -0.00009580 -0.00000100 17.60547000 0.01070100 -0.00000400 0.00000000 0.56369000 0.00007880 -0.00001000 0.00000000 0.01744600 0.00007840 -0.00001000 0.00000000 180.90349000 15.00166100 0.00000000 0.00000000 0.00463130 0.00460820 67.0 +2013 307 13.000 10.00 16.00 0.18319000 0.54694780 0.00002820 -0.00000830 0.29472100 -0.12007530 0.00007900 0.00000170 -15.20965000 -0.01263600 0.00000300 0.00000000 0.54630100 -0.00011210 -0.00001200 0.00000000 0.00014300 -0.00011160 -0.00001200 0.00000000 19.11060000 15.00132500 0.00000000 0.00000000 0.00471370 0.00469020 67.2 +2014 119 6.000 3.00 9.00 0.18515800 0.52826680 -0.00000500 -0.00000720 -0.98352500 0.12211270 -0.00004730 -0.00000160 14.44979000 0.01265800 -0.00000300 0.00000000 0.55055600 0.00011870 -0.00001110 0.00000000 0.00437700 0.00011810 -0.00001110 0.00000000 270.65601000 15.00275500 0.00000000 0.00000000 0.00464330 0.00462020 67.3 +2015 079 10.000 7.00 13.00 -0.16829500 0.55373980 0.00000580 -0.00000940 0.93905200 0.17864750 -0.00005410 -0.00000290 -0.21267000 0.01603600 -0.00000000 0.00000000 0.53595000 0.00002650 -0.00001300 0.00000000 -0.01015600 0.00002640 -0.00001290 0.00000000 328.10678000 15.00441400 0.00000000 0.00000000 0.00469500 0.00467170 67.6 +2016 068 2.000 23.000 24.000 -0.06252500 0.55027520 0.00000460 -0.00000910 0.25383300 0.17212270 0.00001710 -0.00000270 -4.37973000 0.01588600 0.00000100 0.00000000 0.53888600 -0.00007040 -0.00001280 0.00000000 -0.00723500 -0.00007000 -0.00001270 0.00000000 207.37216000 15.00396900 0.00000000 0.00000000 0.00470870 0.00468520 67.9 +2016 069 2.000 0.000 5.00 -0.06252500 0.55027520 0.00000460 -0.00000910 0.25383300 0.17212270 0.00001710 -0.00000270 -4.37973000 0.01588600 0.00000100 0.00000000 0.53888600 -0.00007040 -0.00001280 0.00000000 -0.00723500 -0.00007000 -0.00001270 0.00000000 207.37216000 15.00396900 0.00000000 0.00000000 0.00470870 0.00468520 67.9 +2016 245 9.000 6.00 12.00 -0.16139800 0.50406190 -0.00002130 -0.00000630 -0.29965400 -0.14815160 -0.00002590 0.00000180 8.06331000 -0.01480200 -0.00000200 0.00000000 0.55794700 0.00011160 -0.00001050 0.00000000 0.01173100 0.00011100 -0.00001040 0.00000000 315.03156000 15.00454300 0.00000000 0.00000000 0.00463400 0.00461090 68.1 +2017 057 15.000 12.00 18.00 0.17593500 0.52535470 -0.00000620 -0.00000740 -0.42555500 0.15325350 0.00007920 -0.00000210 -8.49165000 0.01526100 0.00000200 0.00000000 0.55248900 -0.00012570 -0.00001150 0.00000000 0.00630000 -0.00012510 -0.00001150 0.00000000 41.79895000 15.00308500 0.00000000 0.00000000 0.00472190 0.00469840 68.3 +2017 233 18.000 15.00 21.00 -0.12957600 0.54064090 -0.00002930 -0.00000810 0.48541700 -0.14163940 -0.00009050 0.00000210 11.86697000 -0.01362200 -0.00000200 0.00000000 0.54211200 0.00012410 -0.00001180 0.00000000 -0.00402500 0.00012350 -0.00001170 0.00000000 89.24545000 15.00393700 0.00000000 0.00000000 0.00462220 0.00459920 68.4 +2019 183 19.000 16.00 22.00 -0.21563400 0.56620700 0.00002740 -0.00000880 -0.65070900 0.01064010 -0.00012720 -0.00000030 23.01295000 -0.00318700 -0.00000500 0.00000000 0.53765000 -0.00008980 -0.00001200 0.00000000 -0.00846500 -0.00008940 -0.00001200 0.00000000 103.97974000 14.99950700 0.00000000 0.00000000 0.00459840 0.00457550 69.0 +2019 360 5.000 2.00 8.00 -0.14041500 0.53560860 -0.00000140 -0.00000710 0.42407400 -0.03665520 0.00014580 0.00000060 -23.37347000 0.00140700 0.00000600 0.00000000 0.55890600 0.00012840 -0.00001120 0.00000000 0.01268500 0.00012780 -0.00001110 0.00000000 254.93678000 14.99627100 0.00000000 0.00000000 0.00475480 0.00473110 69.2 +2020 173 7.000 4.00 10.00 0.15426000 0.53115280 0.00002580 -0.00000690 0.13640400 0.05138710 -0.00016090 -0.00000080 23.43567000 -0.00023300 -0.00000600 0.00000000 0.55233600 -0.00012230 -0.00001070 0.00000000 0.00614800 -0.00012170 -0.00001070 0.00000000 284.53555000 14.99911100 0.00000000 0.00000000 0.00460090 0.00457800 69.4 +2020 349 16.000 13.00 19.00 -0.18182700 0.56335490 0.00002170 -0.00000890 -0.26964200 -0.08581210 0.00018840 0.00000150 -23.25776000 -0.00198600 0.00000600 0.00000000 0.54388100 0.00009700 -0.00001260 0.00000000 -0.00226600 0.00009660 -0.00001250 0.00000000 61.26593000 14.99649800 0.00000000 0.00000000 0.00475020 0.00472660 69.5 +2021 161 11.000 8.00 14.00 -0.01862800 0.50122760 0.00003370 -0.00000590 0.92612700 0.08877570 -0.00017960 -0.00000100 23.04229000 0.00284100 -0.00000500 0.00000000 0.56437900 -0.00005510 -0.00000980 0.00000000 0.01815000 -0.00005480 -0.00000970 0.00000000 345.12701000 14.99918400 0.00000000 0.00000000 0.00460600 0.00458300 69.7 +2021 338 8.000 5.00 11.00 0.02519400 0.56830120 0.00004000 -0.00000920 -0.98355900 -0.13151360 0.00022120 0.00000240 -22.27472000 -0.00517800 0.00000600 0.00000000 0.53780400 -0.00001600 -0.00001310 0.00000000 -0.00829200 -0.00001600 -0.00001310 0.00000000 302.45218000 14.99727800 0.00000000 0.00000000 0.00474340 0.00471980 69.8 +2022 120 21.000 18.00 24.00 0.61810800 0.47531230 -0.00000150 -0.00000560 -1.02805300 0.20963920 -0.00004320 -0.00000270 14.97104000 0.01216700 -0.00000300 0.00000000 0.56107200 0.00008480 -0.00001030 0.00000000 0.01486000 0.00008430 -0.00001020 0.00000000 135.70560000 15.00246300 0.00000000 0.00000000 0.00464200 0.00461890 70.0 +2022 298 11.000 8.00 14.00 0.45489900 0.49554730 0.00002770 -0.00000710 0.96870900 -0.23958760 0.00001680 0.00000360 -12.17348000 -0.01374500 0.00000300 0.00000000 0.54987900 -0.00011520 -0.00001160 0.00000000 0.00372200 -0.00011460 -0.00001160 0.00000000 348.98224000 15.00242900 0.00000000 0.00000000 0.00470190 0.00467850 70.1 +2023 110 4.000 1.00 7.00 0.02696700 0.49501730 0.00001370 -0.00000720 -0.42732200 0.24419850 -0.00004940 -0.00000370 11.41179000 0.01374100 -0.00000200 0.00000000 0.54680300 0.00012160 -0.00001160 0.00000000 0.00066200 0.00012100 -0.00001150 0.00000000 240.24289000 15.00341100 0.00000000 0.00000000 0.00465490 0.00463180 70.3 +2023 287 18.000 15.00 21.00 0.16975100 0.45854800 0.00002730 -0.00000490 0.33483700 -0.24136680 0.00002400 0.00000300 -8.24419000 -0.01488800 0.00000100 0.00000000 0.56431100 -0.00008910 -0.00001030 0.00000000 0.01808300 -0.00008860 -0.00001030 0.00000000 93.50170000 15.00353300 0.00000000 0.00000000 0.00468820 0.00466480 70.5 +2024 099 18.000 15.00 21.00 -0.31815700 0.51171050 0.00003260 -0.00000850 0.21974700 0.27095860 -0.00005940 -0.00000470 7.58620000 0.01484400 -0.00000200 0.00000000 0.53581300 0.00006180 -0.00001280 0.00000000 -0.01027400 0.00006150 -0.00001270 0.00000000 89.59122000 15.00408400 0.00000000 0.00000000 0.00466830 0.00464500 70.6 +2024 276 19.000 16.00 22.00 -0.06796800 0.44161680 0.00001420 -0.00000490 -0.36318000 -0.24356310 0.00003390 0.00000290 -3.98725000 -0.01551100 0.00000100 0.00000000 0.57034800 -0.00000020 -0.00000980 0.00000000 0.02409000 -0.00000020 -0.00000970 0.00000000 107.73106000 15.00433100 0.00000000 0.00000000 0.00467340 0.00465010 70.8 +2025 088 11.000 8.00 14.00 -0.40278300 0.50941000 0.00004160 -0.00000840 0.96564100 0.27883460 -0.00007230 -0.00000480 3.56602000 0.01553800 -0.00000100 0.00000000 0.53576500 -0.00005330 -0.00001290 0.00000000 -0.01032100 -0.00005300 -0.00001280 0.00000000 343.83157000 15.00436400 0.00000000 0.00000000 0.00468230 0.00465900 71.0 +2025 264 20.000 17.00 23.00 -0.39000200 0.45316410 0.00000240 -0.00000640 -1.00181600 -0.25216220 0.00004560 0.00000320 0.36472000 -0.01560000 -0.00000000 0.00000000 0.56249200 0.00009090 -0.00001020 0.00000000 0.01627300 0.00009050 -0.00001020 0.00000000 121.78191000 15.00477200 0.00000000 0.00000000 0.00465830 0.00463510 71.1 +2026 048 12.000 9.00 15.00 0.32203300 0.48271160 -0.00003360 -0.00000490 -0.92696400 0.23553860 0.00011680 -0.00000330 -11.87930000 0.01404900 0.00000200 0.00000000 0.55771900 -0.00011810 -0.00001110 0.00000000 0.01152300 -0.00011750 -0.00001110 0.00000000 356.51443000 15.00198500 0.00000000 0.00000000 0.00473200 0.00470850 71.2 +2026 224 18.000 15.00 21.00 0.47559300 0.51892880 -0.00007730 -0.00000880 0.77116100 -0.23016640 -0.00012450 0.00000370 14.79667000 -0.01206500 -0.00000300 0.00000000 0.53795400 0.00009400 -0.00001210 0.00000000 -0.00814200 0.00009350 -0.00001210 0.00000000 88.74776000 15.00309300 0.00000000 0.00000000 0.00461410 0.00459110 71.4 +2027 037 16.000 13.00 19.00 0.11174300 0.46648230 -0.00003250 -0.00000320 -0.27327700 0.20318400 0.00010250 -0.00000250 -15.54794000 0.01238300 0.00000400 0.00000000 0.57192700 -0.00006530 -0.00001010 0.00000000 0.02566100 -0.00006500 -0.00001000 0.00000000 56.49306000 15.00051200 0.00000000 0.00000000 0.00474260 0.00471900 71.6 +2027 214 10.000 7.00 13.00 -0.01964500 0.54471050 -0.00004440 -0.00000910 0.16006300 -0.21115690 -0.00012170 0.00000370 17.76247000 -0.01018100 -0.00000400 0.00000000 0.53059600 0.00001380 -0.00001280 0.00000000 -0.01546400 0.00001370 -0.00001280 0.00000000 328.42249000 15.00209300 0.00000000 0.00000000 0.00460640 0.00458340 71.7 +2028 026 15.000 12.00 18.00 -0.20522600 0.47427110 -0.00003770 -0.00000700 0.34027800 0.17385790 0.00009680 -0.00000200 -18.72825000 0.01007300 0.00000500 0.00000000 0.57411600 0.00004200 -0.00000990 0.00000000 0.02783900 0.00004180 -0.00000990 0.00000000 41.89120000 14.99897200 0.00000000 0.00000000 0.00475010 0.00472640 71.9 +2028 204 3.000 0.00 6.00 -0.15430000 0.54499410 -0.00002260 -0.00000950 -0.58638000 -0.17460770 -0.00010220 0.00000290 20.18231000 -0.00797400 -0.00000500 0.00000000 0.53523600 -0.00008590 -0.00001230 0.00000000 -0.01084700 -0.00008540 -0.00001220 0.00000000 223.37866000 15.00101800 0.00000000 0.00000000 0.00460160 0.00457860 72.1 +2029 014 17.000 14.00 20.00 -0.40734500 0.50816270 -0.00003960 -0.00000770 0.98105100 0.14552760 0.00009230 -0.00000200 -21.16301000 0.00724000 0.00000600 0.00000000 0.56266500 0.00011890 -0.00001080 0.00000000 0.01644500 0.00011830 -0.00001080 0.00000000 72.69289000 14.99762900 0.00000000 0.00000000 0.00475410 0.00473040 72.2 +2029 163 4.000 1.00 7.00 -0.01073400 0.52475940 0.00001010 -0.00000670 1.29540600 -0.01763710 -0.00020580 0.00000040 23.15931000 0.00259000 -0.00000500 0.00000000 0.55666100 -0.00010270 -0.00001040 0.00000000 0.01047100 -0.00010220 -0.00001030 0.00000000 240.03554000 14.99920100 0.00000000 0.00000000 0.00460480 0.00458190 72.3 +2029 192 16.000 13.00 19.00 -0.13721200 0.52525700 -0.00000920 -0.00000660 -1.42711900 -0.12804040 -0.00007670 0.00000190 22.00245000 -0.00542400 -0.00000600 0.00000000 0.54875500 -0.00012690 -0.00001100 0.00000000 0.00260400 -0.00012630 -0.00001090 0.00000000 58.60257000 15.00000900 0.00000000 0.00000000 0.00459940 0.00457650 72.4 +2029 339 15.000 12.00 18.00 -0.06374800 0.57663080 -0.00000360 -0.00000920 -1.05970900 -0.01401580 0.00022960 0.00000000 -22.44545000 -0.00505400 0.00000600 0.00000000 0.54064100 0.00006990 -0.00001290 0.00000000 -0.00546900 0.00006950 -0.00001280 0.00000000 47.30986000 14.99717400 0.00000000 0.00000000 0.00474460 0.00472090 72.5 +2030 152 6.000 3.00 9.00 -0.26934600 0.50563560 0.00001910 -0.00000580 0.55197600 0.02101460 -0.00015860 -0.00000010 22.06130000 0.00558200 -0.00000600 0.00000000 0.56614900 -0.00001300 -0.00000970 0.00000000 0.01991100 -0.00001290 -0.00000970 0.00000000 270.53992000 14.99970700 0.00000000 0.00000000 0.00461200 0.00458900 76.9 +2030 329 7.000 4.00 10.00 0.04420000 0.57877310 0.00001570 -0.00000990 -0.39272600 -0.05518960 0.00017440 0.00000080 -20.76100000 -0.00798900 0.00000500 0.00000000 0.53821300 -0.00003790 -0.00001300 0.00000000 -0.00788600 -0.00003770 -0.00001300 0.00000000 288.27457000 14.99836000 0.00000000 0.00000000 0.00473610 0.00471250 77.3 +2031 141 7.000 4.00 10.00 -0.11476200 0.51123740 0.00000740 -0.00000590 -0.21121500 0.05793290 -0.00011820 -0.00000060 20.15915000 0.00833900 -0.00000500 0.00000000 0.56240400 0.00008070 -0.00001000 0.00000000 0.01618500 0.00008020 -0.00001000 0.00000000 285.85107000 15.00061600 0.00000000 0.00000000 0.00462080 0.00459780 77.6 +2031 318 21.000 18.00 24.00 -0.01980000 0.55094530 0.00003380 -0.00000870 0.31493700 -0.08906460 0.00010470 0.00000120 -18.33681000 -0.01053500 0.00000500 0.00000000 0.54777300 -0.00010680 -0.00001200 0.00000000 0.00162700 -0.00010630 -0.00001190 0.00000000 138.89400000 14.99976300 0.00000000 0.00000000 0.00472600 0.00470250 77.9 +2032 130 13.000 10.00 16.00 -0.07430700 0.53595190 0.00000520 -0.00000730 -0.96542300 0.09540540 -0.00007010 -0.00000120 17.59291000 0.01069400 -0.00000400 0.00000000 0.54885100 0.00012720 -0.00001120 0.00000000 0.00270000 0.00012660 -0.00001120 0.00000000 15.88910000 15.00174500 0.00000000 0.00000000 0.00463100 0.00460790 78.2 +2032 308 6.000 3.00 9.00 0.44930800 0.51201480 0.00001780 -0.00000580 0.99081200 -0.11286820 0.00004510 0.00000130 -15.23991000 -0.01263300 0.00000300 0.00000000 0.56260400 -0.00011270 -0.00001060 0.00000000 0.01638400 -0.00011210 -0.00001050 0.00000000 274.11911000 15.00121800 0.00000000 0.00000000 0.00471410 0.00469060 78.6 +2033 089 18.000 15.00 21.00 -0.31878500 0.55542250 0.00002270 -0.00000940 0.92467800 0.17566100 -0.00008000 -0.00000290 4.09368000 0.01571900 -0.00000100 0.00000000 0.53494100 0.00002760 -0.00001300 0.00000000 -0.01114100 0.00002750 -0.00001290 0.00000000 88.92808000 15.00445600 0.00000000 0.00000000 0.00468070 0.00465740 78.9 +2033 266 14.000 11.00 17.00 -0.30995200 0.48153720 0.00000860 -0.00000480 -1.11703100 -0.15454320 0.00004780 0.00000160 -0.33982000 -0.01584500 -0.00000000 0.00000000 0.56889700 0.00003180 -0.00000980 0.00000000 0.02264600 0.00003160 -0.00000970 0.00000000 31.94244000 15.00480700 0.00000000 0.00000000 0.00466070 0.00463750 79.2 +2034 079 10.000 7.00 13.00 -0.25959300 0.54816650 0.00002300 -0.00000940 0.22082800 0.17557880 -0.00000800 -0.00000280 -0.05513000 0.01604200 -0.00000000 0.00000000 0.53863000 -0.00006650 -0.00001270 0.00000000 -0.00747000 -0.00006620 -0.00001260 0.00000000 328.13922000 15.00439800 0.00000000 0.00000000 0.00469510 0.00467180 79.5 +2034 255 16.000 13.00 19.00 -0.28088300 0.50282800 -0.00001150 -0.00000560 -0.32434900 -0.15778480 -0.00000080 0.00000190 3.97191000 -0.01553400 -0.00000100 0.00000000 0.55780000 0.00011880 -0.00001060 0.00000000 0.01160400 0.00011820 -0.00001050 0.00000000 60.94970000 15.00490200 0.00000000 0.00000000 0.00464610 0.00462300 79.9 +2035 068 23.000 20.00 24.000 0.07956700 0.52055920 0.00000520 -0.00000610 -0.43278300 0.16309460 0.00005330 -0.00000220 -4.27334000 0.01592000 0.00000100 0.00000000 0.55262200 -0.00012200 -0.00001150 0.00000000 0.00645200 -0.00012140 -0.00001140 0.00000000 162.39618000 15.00390200 0.00000000 0.00000000 0.00470950 0.00468600 80.2 +2035 069 23.000 0.000 2.000 0.07956700 0.52055920 0.00000520 -0.00000610 -0.43278300 0.16309460 0.00005330 -0.00000220 -4.27334000 0.01592000 0.00000100 0.00000000 0.55262200 -0.00012200 -0.00001150 0.00000000 0.00645200 -0.00012140 -0.00001140 0.00000000 162.39618000 15.00390200 0.00000000 0.00000000 0.00470950 0.00468600 80.2 +2035 244 2.000 23.000 24.000 0.13433900 0.53777130 -0.00003580 -0.00000800 0.34898800 -0.15846570 -0.00005950 0.00000230 8.01771000 -0.01478300 -0.00000200 0.00000000 0.54191900 0.00011040 -0.00001190 0.00000000 -0.00419700 0.00010980 -0.00001180 0.00000000 210.02995000 15.00464800 0.00000000 0.00000000 0.00463280 0.00460970 80.6 +2035 245 2.000 0.000 5.00 0.13433900 0.53777130 -0.00003580 -0.00000800 0.34898800 -0.15846570 -0.00005950 0.00000230 8.01771000 -0.01478300 -0.00000200 0.00000000 0.54191900 0.00011040 -0.00001190 0.00000000 -0.00419700 0.00010980 -0.00001180 0.00000000 210.02995000 15.00464800 0.00000000 0.00000000 0.00463280 0.00460970 80.6 +2036 058 5.000 2.00 8.00 0.44410300 0.49340670 -0.00001940 -0.00000680 -1.11429500 0.14453980 0.00009960 -0.00000160 -8.49969000 0.01528100 0.00000100 0.00000000 0.56819100 -0.00009060 -0.00001020 0.00000000 0.02194300 -0.00009010 -0.00001020 0.00000000 251.80841000 15.00299500 0.00000000 0.00000000 0.00472310 0.00469950 80.9 +2036 205 11.000 8.00 14.00 0.09010100 0.57881590 -0.00001690 -0.00000940 -1.44783000 -0.07336730 -0.00005480 0.00000110 19.89421000 -0.00853600 -0.00000400 0.00000000 0.53043500 -0.00003060 -0.00001280 0.00000000 -0.01562400 -0.00003040 -0.00001270 0.00000000 343.36185000 15.00124800 0.00000000 0.00000000 0.00460190 0.00457890 81.2 +2036 234 17.000 14.00 20.00 0.03652800 0.56328580 -0.00002980 -0.00000910 1.11033200 -0.14969690 -0.00013520 0.00000240 11.74119000 -0.01364600 -0.00000200 0.00000000 0.53190800 0.00004450 -0.00001280 0.00000000 -0.01415900 0.00004430 -0.00001270 0.00000000 74.25919000 15.00402700 0.00000000 0.00000000 0.00462180 0.00459870 81.3 +2037 016 10.000 7.00 13.00 -0.01337600 0.50711170 -0.00001870 -0.00000660 1.15146800 0.04756260 0.00008730 -0.00000050 -20.83011000 0.00797000 0.00000500 0.00000000 0.57208100 0.00006330 -0.00001010 0.00000000 0.02581400 0.00006300 -0.00001010 0.00000000 327.55042000 14.99783300 0.00000000 0.00000000 0.00475400 0.00473030 81.6 +2037 194 3.000 0.00 6.00 0.14158900 0.56359820 -0.00000030 -0.00000870 -0.73377400 -0.03182110 -0.00011310 0.00000030 21.78243000 -0.00604700 -0.00000500 0.00000000 0.53838300 -0.00011020 -0.00001200 0.00000000 -0.00771600 -0.00010960 -0.00001190 0.00000000 223.55016000 15.00022500 0.00000000 0.00000000 0.00459930 0.00457640 81.9 +2038 005 14.000 11.00 17.00 0.10901700 0.53853620 -0.00002560 -0.00000720 0.41854600 0.00799240 0.00013800 0.00000010 -22.55480000 0.00481100 0.00000500 0.00000000 0.55816200 0.00011650 -0.00001120 0.00000000 0.01196500 0.00011590 -0.00001120 0.00000000 28.64297000 14.99681500 0.00000000 0.00000000 0.00475540 0.00473170 82.3 +2038 183 14.000 11.00 17.00 0.23928500 0.53153960 0.00001010 -0.00000680 0.04414200 0.00971110 -0.00015440 -0.00000020 22.99407000 -0.00324000 -0.00000500 0.00000000 0.55313500 -0.00012260 -0.00001070 0.00000000 0.00696200 -0.00012200 -0.00001060 0.00000000 28.96234000 14.99942400 0.00000000 0.00000000 0.00459930 0.00457640 82.6 +2038 359 1.000 22.000 24.000 -0.02066300 0.56984400 0.00000170 -0.00000790 -0.28734300 -0.03797150 0.00019160 0.00000070 -23.36258000 0.00148100 0.00000600 0.00000000 0.54350700 0.00008670 -0.00001260 0.00000000 -0.00261800 0.00008630 -0.00001260 0.00000000 194.92212000 14.99637500 0.00000000 0.00000000 0.00475370 0.00473000 83.0 +2038 360 1.000 0.000 4.00 -0.02066300 0.56984400 0.00000170 -0.00000790 -0.28734300 -0.03797150 0.00019160 0.00000070 -23.36258000 0.00148100 0.00000600 0.00000000 0.54350700 0.00008670 -0.00001260 0.00000000 -0.00261800 0.00008630 -0.00001260 0.00000000 194.92212000 14.99637500 0.00000000 0.00000000 0.00475370 0.00473000 83.0 +2039 172 17.000 14.00 20.00 -0.18950900 0.50586620 0.00002800 -0.00000560 0.81659900 0.04954230 -0.00017980 -0.00000080 23.43238000 -0.00017900 -0.00000500 0.00000000 0.56452500 -0.00003880 -0.00000970 0.00000000 0.01829600 -0.00003860 -0.00000970 0.00000000 74.53581000 14.99904000 0.00000000 0.00000000 0.00460170 0.00457880 83.4 +2039 349 16.000 13.00 19.00 -0.36595300 0.57693030 0.00004600 -0.00001000 -0.90208800 -0.08494820 0.00022940 0.00000160 -23.27406000 -0.00186200 0.00000700 0.00000000 0.53820600 -0.00000050 -0.00001310 0.00000000 -0.00789200 -0.00000040 -0.00001310 0.00000000 61.22592000 14.99652800 0.00000000 0.00000000 0.00474990 0.00472620 83.8 +2040 132 4.000 1.00 7.00 0.58203500 0.48740470 0.00000170 -0.00000620 -1.11924800 0.18475670 -0.00005990 -0.00000230 18.02785000 0.01013500 -0.00000500 0.00000000 0.55954000 0.00008890 -0.00001030 0.00000000 0.01333600 0.00008840 -0.00001030 0.00000000 240.90558000 15.00144200 0.00000000 0.00000000 0.00462990 0.00460680 84.1 +2040 309 19.000 16.00 22.00 0.35752800 0.50392560 0.00003950 -0.00000660 1.04281100 -0.21615310 0.00003950 0.00000310 -15.73231000 -0.01209900 0.00000400 0.00000000 0.55151600 -0.00011360 -0.00001160 0.00000000 0.00535200 -0.00011300 -0.00001150 0.00000000 109.10986000 15.00098300 0.00000000 0.00000000 0.00471550 0.00469200 84.4 +2041 120 12.000 9.00 15.00 0.24653300 0.50667050 0.00001110 -0.00000740 -0.38213000 0.22423080 -0.00007380 -0.00000340 14.97447000 0.01212800 -0.00000400 0.00000000 0.54520600 0.00011040 -0.00001160 0.00000000 -0.00092700 0.00010990 -0.00001160 0.00000000 0.70743000 15.00254200 0.00000000 0.00000000 0.00464150 0.00461840 84.8 +2041 297 2.000 23.000 24.000 0.36382700 0.46455190 0.00003000 -0.00000540 0.28272300 -0.22580870 0.00004970 0.00000290 -12.17860000 -0.01377300 0.00000200 0.00000000 0.56585000 -0.00009390 -0.00001030 0.00000000 0.01961400 -0.00009340 -0.00001020 0.00000000 213.98293000 15.00235900 0.00000000 0.00000000 0.00470240 0.00467900 85.2 +2041 298 2.000 0.000 5.00 0.36382700 0.46455190 0.00003000 -0.00000540 0.28272300 -0.22580870 0.00004970 0.00000290 -12.17860000 -0.01377300 0.00000200 0.00000000 0.56585000 -0.00009390 -0.00001030 0.00000000 0.01961400 -0.00009340 -0.00001020 0.00000000 213.98293000 15.00235900 0.00000000 0.00000000 0.00470240 0.00467900 85.2 +2042 109 2.000 23.000 24.000 -0.28222500 0.52042940 0.00004160 -0.00000850 0.19045800 0.25618770 -0.00008190 -0.00000440 11.51744000 0.01367000 -0.00000200 0.00000000 0.53468200 0.00005610 -0.00001280 0.00000000 -0.01139900 0.00005580 -0.00001270 0.00000000 210.25865000 15.00345100 0.00000000 0.00000000 0.00465420 0.00463110 85.6 +2042 110 2.000 0.000 5.00 -0.28222500 0.52042940 0.00004160 -0.00000850 0.19045800 0.25618770 -0.00008190 -0.00000440 11.51744000 0.01367000 -0.00000200 0.00000000 0.53468200 0.00005610 -0.00001280 0.00000000 -0.01139900 0.00005580 -0.00001270 0.00000000 210.25865000 15.00345100 0.00000000 0.00000000 0.00465420 0.00463110 85.6 +2042 286 2.000 23.000 24.000 -0.14652300 0.44586330 0.00002630 -0.00000510 -0.26530100 -0.23529260 0.00005240 0.00000280 -8.14228000 -0.01492000 0.00000200 0.00000000 0.57124600 0.00001050 -0.00000980 0.00000000 0.02498300 0.00001040 -0.00000970 0.00000000 213.48593000 15.00352600 0.00000000 0.00000000 0.00468780 0.00466440 86.0 +2042 287 2.000 0.000 5.00 -0.14652300 0.44586330 0.00002630 -0.00000510 -0.26530100 -0.23529260 0.00005240 0.00000280 -8.14228000 -0.01492000 0.00000200 0.00000000 0.57124600 0.00001050 -0.00000980 0.00000000 0.02498300 0.00001040 -0.00000970 0.00000000 213.48593000 15.00352600 0.00000000 0.00000000 0.00468780 0.00466440 86.0 +2043 099 19.000 16.00 22.00 -0.44768700 0.51359810 0.00005640 -0.00000840 0.89794400 0.26972770 -0.00009270 -0.00000460 7.74980000 0.01480800 -0.00000200 0.00000000 0.53534200 -0.00005460 -0.00001280 0.00000000 -0.01074200 -0.00005440 -0.00001270 0.00000000 104.61504000 15.00406500 0.00000000 0.00000000 0.00466800 0.00464480 86.4 +2043 276 3.000 0.00 6.00 -0.50037100 0.45564480 0.00001780 -0.00000560 -0.87767800 -0.25050560 0.00006290 0.00000320 -3.88200000 -0.01549800 0.00000100 0.00000000 0.56258900 0.00010130 -0.00001030 0.00000000 0.01636900 0.00010080 -0.00001030 0.00000000 227.70959000 15.00437800 0.00000000 0.00000000 0.00467230 0.00464900 86.7 +2044 059 20.000 17.00 23.00 0.26979300 0.47361560 -0.00001970 -0.00000540 -0.98303800 0.24971210 0.00009430 -0.00000340 -7.86255000 0.01517000 0.00000100 0.00000000 0.55792000 -0.00011330 -0.00001100 0.00000000 0.01172300 -0.00011270 -0.00001100 0.00000000 116.87962000 15.00310000 0.00000000 0.00000000 0.00472090 0.00469740 87.1 +2044 235 1.000 22.000 24.000 0.27960900 0.51077470 -0.00006110 -0.00000790 0.93383500 -0.25128120 -0.00010950 0.00000420 11.26904000 -0.01358200 -0.00000300 0.00000000 0.53768900 0.00010280 -0.00001220 0.00000000 -0.00840600 0.00010230 -0.00001220 0.00000000 194.34897000 15.00400400 0.00000000 0.00000000 0.00462320 0.00460020 87.5 +2044 236 1.000 0.000 4.00 0.27960900 0.51077470 -0.00006110 -0.00000790 0.93383500 -0.25128120 -0.00010950 0.00000420 11.26904000 -0.01358200 -0.00000300 0.00000000 0.53768900 0.00010280 -0.00001220 0.00000000 -0.00840600 0.00010230 -0.00001220 0.00000000 194.34897000 15.00400400 0.00000000 0.00000000 0.00462320 0.00460020 87.5 +2045 046 24.000 21.000 24.000 0.16718400 0.45625730 -0.00003160 -0.00000530 -0.26615200 0.22355590 0.00007830 -0.00000260 -11.91638000 0.01406600 0.00000300 0.00000000 0.57177500 -0.00006270 -0.00001000 0.00000000 0.02550900 -0.00006230 -0.00001000 0.00000000 176.51633000 15.00189800 0.00000000 0.00000000 0.00473320 0.00470960 87.9 +2045 047 0.000 0.000 3.00 0.16718400 0.45625730 -0.00003160 -0.00000530 -0.26615200 0.22355590 0.00007830 -0.00000260 -11.91638000 0.01406600 0.00000300 0.00000000 0.57177500 -0.00006270 -0.00001000 0.00000000 0.02550900 -0.00006230 -0.00001000 0.00000000 176.51633000 15.00189800 0.00000000 0.00000000 0.00473320 0.00470960 87.9 +2045 224 18.000 15.00 21.00 0.24077000 0.53321540 -0.00005320 -0.00000850 0.12413600 -0.23881400 -0.00009650 0.00000420 14.67394000 -0.01210700 -0.00000300 0.00000000 0.53094200 -0.00000290 -0.00001280 0.00000000 -0.01512000 -0.00000290 -0.00001280 0.00000000 88.76047000 15.00317200 0.00000000 0.00000000 0.00461370 0.00459070 88.3 +2046 036 23.000 20.00 24.000 -0.19959300 0.46410630 -0.00003600 -0.00000500 0.32386500 0.20130480 0.00007380 -0.00000230 -15.64727000 0.01232800 0.00000300 0.00000000 0.57336000 0.00004560 -0.00000990 0.00000000 0.02708700 0.00004540 -0.00000990 0.00000000 161.51131000 15.00045700 0.00000000 0.00000000 0.00474310 0.00471950 88.7 +2046 037 23.000 0.000 2.000 -0.19959300 0.46410630 -0.00003600 -0.00000500 0.32386500 0.20130480 0.00007380 -0.00000230 -15.64727000 0.01232800 0.00000300 0.00000000 0.57336000 0.00004560 -0.00000990 0.00000000 0.02708700 0.00004540 -0.00000990 0.00000000 161.51131000 15.00045700 0.00000000 0.00000000 0.00474310 0.00471950 88.7 +2046 214 10.000 7.00 13.00 -0.38207600 0.53183390 -0.00001110 -0.00000870 -0.42533200 -0.20697770 -0.00008980 0.00000340 17.65569000 -0.01027100 -0.00000400 0.00000000 0.53621000 -0.00007980 -0.00001220 0.00000000 -0.00987800 -0.00007940 -0.00001220 0.00000000 328.41599000 15.00211500 0.00000000 0.00000000 0.00460660 0.00458370 89.1 +2047 025 2.000 23.000 24.000 -0.13470200 0.49847210 -0.00005360 -0.00000750 1.06278600 0.18108960 0.00006610 -0.00000240 -18.76767000 0.01001800 0.00000500 0.00000000 0.56168300 0.00010520 -0.00001090 0.00000000 0.01546800 0.00010470 -0.00001090 0.00000000 206.91580000 14.99899900 0.00000000 0.00000000 0.00474980 0.00472610 89.5 +2047 026 2.000 0.000 5.00 -0.13470200 0.49847210 -0.00005360 -0.00000750 1.06278600 0.18108960 0.00006610 -0.00000240 -18.76767000 0.01001800 0.00000500 0.00000000 0.56168300 0.00010520 -0.00001090 0.00000000 0.01546800 0.00010470 -0.00001090 0.00000000 206.91580000 14.99899900 0.00000000 0.00000000 0.00474980 0.00472610 89.5 +2047 174 11.000 8.00 14.00 0.21896500 0.52008320 -0.00001140 -0.00000650 1.36069000 -0.05858160 -0.00020990 0.00000080 23.41617000 -0.00044700 -0.00000500 0.00000000 0.55723100 -0.00010340 -0.00001030 0.00000000 0.01103800 -0.00010290 -0.00001030 0.00000000 344.42908000 14.99908900 0.00000000 0.00000000 0.00460100 0.00457800 89.8 +2047 203 23.000 20.00 24.000 -0.20666800 0.51307580 -0.00001220 -0.00000690 -1.34859300 -0.16373010 -0.00006500 0.00000230 20.13154000 -0.00805600 -0.00000500 0.00000000 0.54987200 -0.00012590 -0.00001090 0.00000000 0.00371600 -0.00012530 -0.00001090 0.00000000 163.36028000 15.00096500 0.00000000 0.00000000 0.00460200 0.00457910 89.9 +2047 204 23.000 0.000 2.000 -0.20666800 0.51307580 -0.00001220 -0.00000690 -1.34859300 -0.16373010 -0.00006500 0.00000230 20.13154000 -0.00805600 -0.00000500 0.00000000 0.54987200 -0.00012590 -0.00001090 0.00000000 0.00371600 -0.00012530 -0.00001090 0.00000000 163.36028000 15.00096500 0.00000000 0.00000000 0.00460200 0.00457910 89.9 +2047 349 24.000 21.000 24.000 0.15618100 0.57673940 -0.00002800 -0.00000950 -1.05881600 0.03363930 0.00023780 -0.00000060 -23.33402000 -0.00170000 0.00000600 0.00000000 0.54056600 0.00005890 -0.00001290 0.00000000 -0.00554400 0.00005860 -0.00001280 0.00000000 181.06407000 14.99646700 0.00000000 0.00000000 0.00475060 0.00472690 90.2 +2047 350 0.000 0.000 3.00 0.15618100 0.57673940 -0.00002800 -0.00000950 -1.05881600 0.03363930 0.00023780 -0.00000060 -23.33402000 -0.00170000 0.00000600 0.00000000 0.54056600 0.00005890 -0.00001290 0.00000000 -0.00554400 0.00005860 -0.00001280 0.00000000 181.06407000 14.99646700 0.00000000 0.00000000 0.00475060 0.00472690 90.2 +2048 163 13.000 10.00 16.00 0.03172400 0.50563170 -0.00000310 -0.00000560 0.64614200 -0.01737200 -0.00017060 0.00000020 23.14490000 0.00265000 -0.00000600 0.00000000 0.56587200 -0.00001580 -0.00000970 0.00000000 0.01963600 -0.00001570 -0.00000960 0.00000000 15.03369000 14.99914900 0.00000000 0.00000000 0.00460560 0.00458270 90.7 +2048 340 16.000 13.00 19.00 0.23019000 0.58064100 -0.00000200 -0.00000870 -0.40170600 -0.01070220 0.00019240 0.00000000 -22.49576000 -0.00493000 0.00000600 0.00000000 0.53889900 -0.00005060 -0.00001300 0.00000000 -0.00720300 -0.00005030 -0.00001300 0.00000000 62.27962000 14.99715000 0.00000000 0.00000000 0.00474450 0.00472090 91.1 +2049 151 14.000 11.00 17.00 0.00532600 0.51556490 -0.00000640 -0.00000600 -0.11858400 0.02221600 -0.00013620 -0.00000010 22.02431000 0.00564900 -0.00000500 0.00000000 0.56122600 0.00008050 -0.00001010 0.00000000 0.01501300 0.00008010 -0.00001000 0.00000000 30.54614000 14.99974100 0.00000000 0.00000000 0.00461230 0.00458940 91.5 +2049 329 6.000 3.00 9.00 0.26923900 0.55388450 0.00001640 -0.00000940 0.27049400 -0.05142720 0.00012960 0.00000060 -20.82803000 -0.00790000 0.00000600 0.00000000 0.54905700 -0.00012280 -0.00001200 0.00000000 0.00290500 -0.00012220 -0.00001190 0.00000000 273.25433000 14.99825900 0.00000000 0.00000000 0.00473630 0.00471270 91.9 +2050 140 21.000 18.00 24.00 0.25479400 0.54296140 -0.00001250 -0.00000750 -0.84515000 0.06247110 -0.00009470 -0.00000080 20.15502000 0.00833300 -0.00000500 0.00000000 0.54740900 0.00011080 -0.00001130 0.00000000 0.00126500 0.00011030 -0.00001120 0.00000000 135.84935000 15.00069600 0.00000000 0.00000000 0.00462060 0.00459760 94.5 +2050 318 14.000 11.00 17.00 0.41779500 0.51573900 0.00001700 -0.00000700 0.99053700 -0.08366170 0.00007040 0.00000100 -18.36299000 -0.01052000 0.00000400 0.00000000 0.56411200 -0.00011160 -0.00001050 0.00000000 0.01788500 -0.00011100 -0.00001050 0.00000000 33.89331000 14.99966000 0.00000000 0.00000000 0.00472620 0.00470270 95.5 diff --git a/share/module_check_a_mundo.F b/share/module_check_a_mundo.F index 602e0eef4b..c14fc184aa 100644 --- a/share/module_check_a_mundo.F +++ b/share/module_check_a_mundo.F @@ -2511,6 +2511,28 @@ END FUNCTION bep_bem_nbui_max CALL wrf_debug ( 1, wrf_err_message ) END IF +!----------------------------------------------------------------------- +! Consistency checks between eclipse option and shortwave radiation +! scheme selection. Eclipse option only applies to +! RRTMG_SWSCHEME, SWRADSCHEME, GSFCSWSCHEME and GODDARDSWSCHEME +!----------------------------------------------------------------------- + DO i = 1, model_config_rec % max_dom + IF ( .NOT. model_config_rec % grid_allowed(i) ) CYCLE + IF ( model_config_rec%ra_sw_eclipse == 1 ) THEN + IF ( ( model_config_rec%ra_sw_physics(i) .EQ. RRTMG_SWSCHEME ) .OR. & + ( model_config_rec%ra_sw_physics(i) .EQ. SWRADSCHEME ) .OR. & + ( model_config_rec%ra_sw_physics(i) .EQ. GSFCSWSCHEME ) .OR. & + ( model_config_rec%ra_sw_physics(i) .EQ. GODDARDSWSCHEME ) ) THEN + ! We are OK, these sw radiation schemes have eclipse physics + ELSE + wrf_err_message = '--- ERROR: ra_sw_eclipse=1 only works with ra_sw_physics=1 (Dudhia), ' // & + '=2 (Old Goddard), =4 (RRTMG) and =5 (new Goddard) ' + CALL wrf_debug ( 0, TRIM( wrf_err_message ) ) + count_fatal_error = count_fatal_error + 1 + END IF + END IF + END DO + #if (WRF_CHEM == 1 && WRF_KPP == 1 ) !----------------------------------------------------------------------- ! Check for consistent chem_opt and irr_opt