subroutine vmf3_grid( indir_vmf3_grid,indir_orography,VMF3_grid_file,mjd,lat,lon_old,h_ell,zd,grid_res , mfh,mfw,zhd,zwd ) ! ! vmf3_grid.m ! ! This routine determines mapping functions plus zenith delays from the ! gridded VMF3 files, as available from: ! http://vmf.geo.tuwien.ac.at/trop_products/GRID/ ! ! On the temporal scale, the values from the two surrounding NWM epochs are ! linearly interpolated to the respective mjd. ! In the horizontal, a bilinear interpolation is done for the mapping ! function coefficients as well as for the zenith delays. In the vertical, ! on the one hand the height correction by Niell (1996) is applied in order ! to "lift" the hydrostatic mapping function from zero height to h_ell; on ! the other hand, specific formulae as suggested by Kouba (2008) are ! applied in order to "lift" the zenith delays from the respective heights ! of the grid points (orography_ell) to that of the desired location. ! ! Reference for VMF3: ! Landskron, D. & Böhm, J. J Geod (2017). https://doi.org/10.1007/s00190-017-1066-2 ! ! Reference for conversion of mapping functions: ! Niell, A.E. (1996), Global mapping functions for the atmosphere delay at ! 310 radio wavelengths. J. Geophys. Res., 101, 3227-3246 ! ! Reference for conversion of zenith delays: ! Kouba, J. (2008), Implementation and testing of the gridded Vienna ! Mapping Function 1 (VMF1). J. Geodesy, Vol. 82:193-205, ! DOI: 10.1007/s00190-007-0170-0 ! ! ! INPUT: ! o indir_VMF3_grid ... input directory where the yearly subdivided VMF3 gridded files are stored ! o indir_orography ... input directory where the orography_ell file in the respective resolution is stored ! o VMF3_grid_file .... cell containing filenames, VMF3 data and the orography, which is always passed with the function ! o mjd ............... modified julian date ! o lat ............... ellipsoidal latitude (radians) ! o lon ............... ellipsoidal longitude (radians) ! o h_ell ............. ellipsoidal height in (m) ! o zd ................ zenith distance (radians) ! o grid_res........... grid resolution (°) (possible: 1 or 5) ! ! OUTPUT: ! o mfh ............... hydrostatic mapping function, valid at h_ell ! o mfw ............... wet mapping function, valid at h_ell ! o zhd ............... zenith hydrostatic delay (m), valid at h_ell ! o zwd ............... zenith wet delay (m), valid at h_ell ! o VMF3_grid_file: ... cell containing filenames, VMF3 data and the orography, which is always passed with the function ! ! ! Make sure to set the following variables as actual arguments in the script from which you call vmf3_grid.f90: ! ! character(len=:), allocatable :: indir_VMF3_grid ! character(len=:), allocatable :: indir_orography ! double precision :: mjd, lat, lon, h_ell, zd ! type :: VMF3_grid_file_type ! character(len=17), dimension(:), allocatable :: filename ! character(len=:), allocatable :: indir_VMF3_grid ! double precision, dimension(:,:,:), allocatable :: VMF3_data_all ! double precision, dimension(:), allocatable :: orography_ell ! double precision :: lat, lon ! end type VMF3_grid_file_type ! type(VMF3_grid_file_type) :: VMF3_grid_file ! integer :: grid_res ! double precision :: mfh, mfw, zhd, zwd ! ! ------------------------------------------------------------------------- ! ! written by Daniel Landskron (2018/01/31) ! ! ========================================================================= ! Input arguments character(len=:), allocatable, intent(in) :: indir_VMF3_grid character(len=:), allocatable, intent(in) :: indir_orography type(VMF3_grid_file_type), intent(inout) :: VMF3_grid_file double precision, intent(in) :: mjd double precision, intent(in) :: lat double precision, intent(in) :: lon_old double precision, intent(in) :: h_ell double precision, intent(in) :: zd integer :: grid_res ! Output arguments double precision, intent(out) :: mfh double precision, intent(out) :: mfw double precision, intent(out) :: zhd double precision, intent(out) :: zwd ! Internal variables ! pi double precision, parameter :: pi = 4 * atan(1.0d0) ! grid resolution converted to a string character :: grid_res_str ! further variables for lat/lon integer, allocatable :: num_lat integer, dimension(2) :: ind_lat_int, ind_lon_int double precision, dimension(:), allocatable :: lat_all, lon_all, lat_temp, lon_temp double precision :: lon, lat_deg, lon_deg double precision, dimension(4) :: lat_red, lon_red, polDist_red ! number of gridpoints, depending on the grid resolution integer :: num_gridpoints ! the variables for the 1 or 3 mjd's double precision, dimension(2) :: mjd_int double precision, dimension(:), allocatable :: mjd_all, jd_all integer, dimension(:), allocatable :: jd_all_int ! further time variables double precision, dimension(:), allocatable :: sec integer, dimension(:), allocatable :: hour, minu, day, month, year, epoch character(len=4) :: year_str character(len=2) :: month_str, day_str, epoch_str integer :: year_temp, month_temp, day_temp, epoch_temp ! variables for the conversion of date to mjd double precision, dimension(:), allocatable :: aa, bb, cc, dd, ee, mm ! filename character(len=17), dimension(:), allocatable :: filename ! variable for orography_ell and VMF3_data integer :: load_new integer :: file_unit_orography_ell = 1 integer :: file_unit_VMF3_data = 2 integer :: open_status, read_status integer :: i, ind_data, i_file, i_mjd, i_grid integer, dimension(4) :: index_p character :: first_char double precision, dimension(2,4,6) :: VMF3_data integer :: num_comment_lines ! VMF3 data after temporal interpolation double precision, dimension(4,7) :: VMF3_data_int_h0 double precision, dimension(4,9) :: VMF3_data_int_h1 ! mapping function variables double precision, dimension(4) :: ah, aw, bh, bw, ch, cw double precision :: a_ht, b_ht, c_ht double precision :: ht_corr, ht_corr_coef double precision :: zhd_lon1, zhd_lon2, zwd_lon1, zwd_lon2, mfh_lon1, mfh_lon2, mfw_lon1, mfw_lon2 ! day of year double precision :: doy integer, dimension(12) :: days ! elevation double precision :: el ! logical variable for leapYear integer :: leapYear ! define the variables for the Legendre coefficients double precision, dimension(455) :: anm_bh_temp double precision, dimension(455) :: anm_bw_temp double precision, dimension(455) :: anm_ch_temp double precision, dimension(455) :: anm_cw_temp double precision, dimension(455) :: bnm_bh_temp double precision, dimension(455) :: bnm_bw_temp double precision, dimension(455) :: bnm_ch_temp double precision, dimension(455) :: bnm_cw_temp double precision, dimension(91,5) :: anm_bh double precision, dimension(91,5) :: anm_bw double precision, dimension(91,5) :: anm_ch double precision, dimension(91,5) :: anm_cw double precision, dimension(91,5) :: bnm_bh double precision, dimension(91,5) :: bnm_bw double precision, dimension(91,5) :: bnm_ch double precision, dimension(91,5) :: bnm_cw double precision, dimension(91) :: anm_bh_A0, anm_bh_A1, anm_bh_B1, anm_bh_A2, anm_bh_B2 double precision, dimension(91) :: anm_bw_A0, anm_bw_A1, anm_bw_B1, anm_bw_A2, anm_bw_B2 double precision, dimension(91) :: anm_ch_A0, anm_ch_A1, anm_ch_B1, anm_ch_A2, anm_ch_B2 double precision, dimension(91) :: anm_cw_A0, anm_cw_A1, anm_cw_B1, anm_cw_A2, anm_cw_B2 double precision, dimension(91) :: bnm_bh_A0, bnm_bh_A1, bnm_bh_B1, bnm_bh_A2, bnm_bh_B2 double precision, dimension(91) :: bnm_bw_A0, bnm_bw_A1, bnm_bw_B1, bnm_bw_A2, bnm_bw_B2 double precision, dimension(91) :: bnm_ch_A0, bnm_ch_A1, bnm_ch_B1, bnm_ch_A2,bnm_ch_B2 double precision, dimension(91) :: bnm_cw_A0, bnm_cw_A1, bnm_cw_B1, bnm_cw_A2, bnm_cw_B2 ! parameter for degree n and order m of the expansion integer, parameter :: nmax = 12 ! variables for the polar coordinates double precision, dimension(4) :: x, y, z ! variable for the Legendre polynomials double precision, dimension(nmax+1,nmax+1) :: V, W ! variable for the indices integer :: n, m ! variables for the coefficients' amplitudes double precision :: bh_A0, bh_A1, bh_B1, bh_A2, bh_B2 double precision :: bw_A0, bw_A1, bw_B1, bw_A2, bw_B2 double precision :: ch_A0, ch_A1, ch_B1, ch_A2, ch_B2 double precision :: cw_A0, cw_A1, cw_B1, cw_A2, cw_B2 !====================================================================== ! save lat and lon also in degrees lat_deg = lat*180/pi lon_deg = lon_old*180/pi ! one must be named "_old" because as a dummy argument it cannot be changed within the subroutine lon = lon_old ! only positive longitude in degrees if (lon_deg < 0) then lon = lon + 2*pi lon_deg = lon_deg + 360 end if ! allocate the size of the grid if (grid_res==5) then num_gridpoints = 2592 num_lat = 36 elseif (grid_res==1) then num_gridpoints = 64800 num_lat = 180 else ! report error message print '(a /)', 'Error: Define a grid resolution of either 5° or 1°! Program stopped!' end if !---------------------------------------------------------------------- ! (1) convert the mjd to year, month, day in order to find the correct files !---------------------------------------------------------------------- ! find the two surrounding epochs if (modulo(mjd,0.25d0)==0) then allocate(mjd_all(1)) allocate(jd_all(1)) allocate(jd_all_int(1)) mjd_all = mjd else allocate(mjd_all(3)) allocate(jd_all(3)) allocate(jd_all_int(3)) mjd_int = (/ floor(mjd*4.0d0)/4.0d0, ceiling(mjd*4.0d0)/4.0d0 /) mjd_all = (/ mjd, mjd_int /) end if hour = floor((mjd_all-floor(mjd_all))*24) ! get hours minu = floor((((mjd_all-floor(mjd_all))*24)-hour)*60) ! get minutes sec = (((((mjd_all-floor(mjd_all))*24)-hour)*60)-minu)*60 ! get seconds ! change secs, min hour whose sec==60 and days, whose hour==24 do i_mjd = 1,size(hour) if (sec(i_mjd)==60) then minu(i_mjd) = minu(i_mjd) +1 end if if (minu(i_mjd)==60) then hour(i_mjd) = hour(i_mjd) +1 end if if (hour(i_mjd)==24) then mjd_all(i_mjd) = mjd_all(i_mjd) +1 end if end do ! calc jd (yet wrong for hour==24) jd_all = mjd_all+2400000.5d0 ! integer Julian date jd_all_int = floor(jd_all+0.5d0) aa = jd_all_int+32044 bb = floor((4*aa+3)/146097) cc = aa-floor((bb*146097)/4) dd = floor((4*cc+3)/1461) ee = cc-floor((1461*dd)/4) mm = floor((5*ee+2)/153) day = ee-floor((153*mm+2)/5)+1 month = mm+3-12*floor(mm/10) year = bb*100+dd-4800+floor(mm/10) epoch = (mjd_all-floor(mjd_all))*24 ! derive related VMFG filename(s) if (size(mjd_all)==1) then ! if the observation epoch coincides with an NWM epoch year_temp = year(1) month_temp = month(1) day_temp = day(1) epoch_temp = epoch(1) write(year_str,'(i4.4)') year_temp write(month_str, '(i2.2)') month_temp write(day_str, '(i2.2)') day_temp write(epoch_str, '(i2.2)') epoch_temp allocate(filename(1)) filename(1) = 'VMF3_' // year_str // month_str // day_str // '.H' // epoch_str else allocate(filename(2)) do i_mjd = 2,size(mjd_all) year_temp = year(i_mjd) month_temp = month(i_mjd) day_temp = day(i_mjd) epoch_temp = epoch(i_mjd) write(year_str,'(i4.4)') year_temp write(month_str, '(i2.2)') month_temp write(day_str, '(i2.2)') day_temp write(epoch_str, '(i2.2)') epoch_temp filename(i_mjd-1) = 'VMF3_' // year_str // month_str // day_str // '.H' // epoch_str end do end if !---------------------------------------------------------------------- ! (2) check if new files have to be loaded or if the overtaken ones are sufficient !---------------------------------------------------------------------- if (.not. allocated(VMF3_grid_file % filename)) then ! in the first run, 'VMF3_file' is always empty and the orography_ell file has to loaded load_new = 1 VMF3_grid_file % filename = filename ! replace the empty cell by the current filenames VMF3_grid_file % indir_VMF3_grid = indir_VMF3_grid ! replace the empty cell by the current indir_VMF3_grid ! num2str write(grid_res_str,fmt='(i1.1)') grid_res ! load the orography_ell file ! Open the file open(unit= file_unit_orography_ell,file= indir_orography // '/orography_ell_' // grid_res_str // 'x' // grid_res_str , action= 'read', status= 'old', iostat= open_status) ! Check if textfile can be opened (iostat == 0 --> no error) if (open_status /= 0) then ! report error message print '(a /)', 'Error: Problem with opening the orography_ell file! Program stopped!' ! stop the program stop end if allocate(VMF3_grid_file % orography_ell(num_gridpoints)) ! loop over all lines in the file do i= 1, num_gridpoints read(unit= file_unit_orography_ell, fmt=*) VMF3_grid_file % orography_ell(i) end do VMF3_grid_file % lat = lat VMF3_grid_file % lon = lon elseif ( VMF3_grid_file % filename(1) == filename(1) .AND. VMF3_grid_file % filename(2) == filename(2) .AND. ( lat > VMF3_grid_file % lat .OR. (lat == VMF3_grid_file % lat .AND. lon <= VMF3_grid_file % lon .AND. lon >= grid_res/2.0*pi/180.0) ) .AND. indir_VMF3_grid == VMF3_grid_file % indir_VMF3_grid ) then ! if the current filenames are the same as in the forwarded files load_new = 0 else ! if new VMF3 files are required, then they must be loaded anew load_new = 1 VMF3_grid_file % filename = filename VMF3_grid_file % indir_VMF3_grid = indir_VMF3_grid VMF3_grid_file % lat = lat VMF3_grid_file % lon = lon end if !---------------------------------------------------------------------- ! (3) find the indices of the 4 surrounding grid points !---------------------------------------------------------------------- ! find the coordinates (lat,lon) of the surrounding grid points allocate(lat_all(num_lat)) allocate(lon_all(num_gridpoints/num_lat)) lat_all(1) = 90-grid_res/2.0 do i=2,num_lat lat_all(i) = lat_all(i-1) - grid_res end do lon_all(1) = 0+grid_res/2.0 do i=2,num_gridpoints/num_lat lon_all(i) = lon_all(i-1) + grid_res end do ! find the 2 closest latitudes lat_temp = lat_deg-lat_all ind_lat_int(1) = minloc(abs(lat_temp),1) ind_lat_int(2) = ind_lat_int(1)-sign(1.0_8,lat_temp(ind_lat_int(1))) ! the '_8' is necessary for gfortran because it defines the type exactly (unlike only '1.0') ! find the two closest longitudes lon_temp = lon_deg-lon_all ind_lon_int(1) = minloc(abs(lon_temp),1) ind_lon_int(2) = ind_lon_int(1)+sign(1.0_8,lon_temp(ind_lon_int(1))) ! the '_8' is necessary for gfortran because it defines the type exactly (unlike only '1.0') ! correct indices out of range do i = 1,2 if (ind_lat_int(i)>size(lat_all)) ind_lat_int(i) = size(lat_all) if (ind_lat_int(i)<1) ind_lat_int(i) = 1 if (ind_lon_int(i)>size(lon_all)) ind_lon_int(i) = ind_lon_int(i)-size(lon_all) if (ind_lon_int(i)<1) ind_lon_int(i) = ind_lon_int(i)+size(lon_all) end do !! define the indices index_p(1) = (ind_lat_int(1)-1)*size(lon_all)+ind_lon_int(1) index_p(2) = (ind_lat_int(1)-1)*size(lon_all)+ind_lon_int(2) index_p(3) = (ind_lat_int(2)-1)*size(lon_all)+ind_lon_int(1) index_p(4) = (ind_lat_int(2)-1)*size(lon_all)+ind_lon_int(2) !---------------------------------------------------------------------- ! (4) read the correct data and perform a linear time interpolation from the surrounding two epochs !---------------------------------------------------------------------- if (load_new == 1) then ! first deallocate the old array, if allocated, and allocate it new (because if a new gridsize is used, the deallocation is necessary) if (allocated(VMF3_grid_file % VMF3_data_all)) then deallocate(VMF3_grid_file % VMF3_data_all) end if allocate(VMF3_grid_file % VMF3_data_all(2,num_gridpoints,6)) do i_file = 1,size(filename) ! read the files and collect the data if (size(mjd_all)==1) then ! if the observation epoch coincides with an NWM epoch year_temp = year(1) write(year_str,'(i4.4)') year_temp else year_temp = year(i_file+1) write(year_str,'(i4.4)') year_temp end if open(unit= file_unit_VMF3_data, file= indir_VMF3_grid // '/' // year_str // '/' // filename(i_file) , action= 'read', status= 'old', iostat= open_status) ! Check if textfile can be opened (iostat == 0 --> no error) if (open_status /= 0) then ! report error message print '(a /)', 'Error: Problem with opening the gridded VMF3 data! Program stopped!' ! stop the program stop end if ind_data = 0 num_comment_lines = 0 ! there are comment lines in the VMF3 file ! determine the number of comment lines do ! read next line read(unit= file_unit_VMF3_data, fmt= '(a)', iostat= read_status) first_char ! test if end of file is reached and exit loop in this case if (is_iostat_end(read_status)) exit ! test if the first character of the line is a comment sign ("%" or "!") if (first_char == '%' .or. first_char == '!') then num_comment_lines = num_comment_lines + 1 else exit end if end do ! rewind the file rewind(unit = file_unit_VMF3_data) ! loop over all lines in the file up to the maximum index do i= 1, maxval(index_p)+num_comment_lines ! skip all comment lines if (i<=num_comment_lines) then ! read next line read(unit= file_unit_VMF3_data, fmt= '(a)', iostat= read_status) first_char cycle end if ! raise the counter of the index and read the data ind_data= ind_data + 1 read(unit= file_unit_VMF3_data, fmt=*) VMF3_grid_file % VMF3_data_all(i_file,i,:) end do ! close the file close(unit= file_unit_VMF3_data) ! reduce data to the respective indices VMF3_data(i_file,:,:) = VMF3_grid_file % VMF3_data_all(i_file,index_p,:) end do else ! reduce data to the respective indices do i_file = 1,size(filename) VMF3_data(i_file,:,:) = VMF3_grid_file % VMF3_data_all(i_file,index_p,:) end do end if ! perform the linear temporal interpolation if (size(mjd_all)==1) then ! if the observation epoch coincides with an NWM epoch VMF3_data_int_h0(:,1:6) = VMF3_data(1,:,1:6) else ! else perform the linear interpolation VMF3_data_int_h0(:,1:6) = VMF3_data(1,:,:) + (VMF3_data(2,:,:)-VMF3_data(1,:,:))*(mjd-mjd_int(1))/(mjd_int(2)-mjd_int(1)) ! the appendix 'h0' means that the values are valid at zero height end if ! the first four columns are equal VMF3_data_int_h1(:,1:4) = VMF3_data_int_h0(:,1:4) !---------------------------------------------------------------------- ! (5) bring mfh, mfw, zhd and zwd of the surrounding grid points to the respective height of the location !---------------------------------------------------------------------- ! (a) zhd ! to be exact, the latitudes of the respective grid points would have to be used instead of the latitude of the station (lat). However, the loss of accuracy is only in the sub-micrometer range. VMF3_data_int_h0(:,7) = (VMF3_data_int_h0(:,5)/0.0022768d0) * (1-0.00266d0*cos(2*lat)-0.00000028d0*VMF3_grid_file % orography_ell(index_p)) ! (1) convert the hydrostatic zenith delay at grid height to the respective pressure value VMF3_data_int_h1(:,7) = VMF3_data_int_h0(:,7)*(1-0.0000226d0*(h_ell-VMF3_grid_file % orography_ell(index_p)))**5.225d0 ! (2) lift the pressure each from grid height to site height VMF3_data_int_h1(:,5) = 0.0022768d0*VMF3_data_int_h1(:,7) / (1-0.00266d0*cos(2*lat)-0.00000028d0*h_ell) ! (3) convert the lifted pressure to zhd again (as proposed by Kouba, 2008) ! (b) zwd ! simple exponential decay approximation function VMF3_data_int_h1(1:4,6) = VMF3_data_int_h0(1:4,6) * exp(-(h_ell-VMF3_grid_file % orography_ell(index_p))/2000) ! convert zenith distance to elevation el = pi/2 - zd ! (c) ah => mfh, aw => mfw ! first check if the specified year is leap year or not (logical output) if ( (modulo(year(1),4) == 0 .AND. modulo(year(1),100) /= 0) .OR. modulo(year(1),400) == 0 ) then leapYear = 1 else leapYear = 0 end if days = (/ 31, 28, 31, 30, 31, 30, 31, 31, 30, 31, 30, 31 /) doy = sum(days(1:month(1)-1)) + day(1) if (leapYear == 1 .AND. month(1) > 2) then doy = doy + 1 end if doy = doy + mjd-floor(mjd) ! add decimal places ! read the latitudes of the neighboring grid points lat_red = VMF3_data_int_h0(1:4,1)*pi/180 polDist_red = pi/2 - lat_red! convert the latitudes of the 4 surrounding grid points to polar distances lon_red = VMF3_data_int_h0(1:4,2)*pi/180 ! legendre function coefficients for bh, bw, ch and cw (from calculate_spherical_harmonics_coefficients_VMF3_5x5.m) data(anm_bh_temp(i),i=1,455) & /0.0027128586310995d0, -1.39197786008938d-06, 1.34955672002719d-06, 2.71686279717968d-07, 1.56659301773925d-06, & 9.80476624811974d-06, -5.83922611260673d-05, -2.07307023860417d-05, 1.14628726961148d-06, 4.93610283608719d-06, & -1.03443106534268d-05, -2.05536138785961d-06, 2.09692641914244d-06, -1.55491034130965d-08, -1.89706404675801d-07, & -3.00353961749658d-05, 2.37284447073503d-05, 2.02236885378918d-05, 1.69276006349609d-06, 8.72156681243892d-07, & -7.99121077044035d-07, -5.39048313389504d-06, -4.21234502039861d-06, -2.70944149806894d-06, -6.80894455531746d-07, & 7.51439609883296d-07, 3.85509708865520d-07, 4.41508016098164d-08, -2.07507808307757d-08, 4.95354985050743d-08, & 2.21790962160087d-05, -5.56986238775212d-05, -1.81287885563308d-05, -4.41076013532589d-06, 4.93573223917278d-06, & -4.47639989737328d-06, -2.60452893072120d-06, 2.56376320011189d-06, 4.41600992220479d-07, 2.93437730332869d-07, & 8.14992682244945d-07, 2.03945571424434d-07, 1.11832498659806d-08, 3.25756664234497d-08, 3.01029040414968d-08, & -7.96927680907488d-08, -3.66953150925865d-08, -6.74742632186619d-09, -1.30315731273651d-08, -2.00748924306947d-09, & -2.16138375166934d-05, 1.67350317962556d-05, 1.93768260076821d-05, 1.99595120161850d-06, -2.42463528222014d-06, & 5.34360283708044d-07, -3.64189022040600d-06, -2.99935375194279d-06, -2.06880962903922d-06, -9.40815692626002d-07, & 6.80235884441822d-07, 1.33023436079845d-07, -1.80349593705226d-08, 2.51276252565192d-08, -1.43240592002794d-09, & -7.13790897253802d-08, 7.81998506267559d-09, 1.13826909570178d-09, -5.89629600214654d-09, -4.20760865522804d-09, & -5.80109372399116d-09, 1.13702284491976d-09, 7.29046067602764d-10, -9.10468988754012d-10, -2.58814364808642d-10, & 1.75558618192965d-05, -2.85579168876063d-05, -1.47442190284602d-05, -6.29300414335248d-06, -5.12204538913460d-07, & -1.90788558291310d-06, -1.62144845155361d-06, 7.57239241641566d-07, 6.93365788711348d-07, 6.88855644570695d-07, & 2.27050351488552d-07, 1.03925791277660d-07, -3.31105076632079d-09, 2.88065761026675d-08, -8.00256848229136d-09, & -2.77028851807614d-08, -5.96251132206930d-09, 2.95987495527251d-10, -5.87644249625625d-09, -3.28803981542337d-09, & -1.89918479865558d-08, 3.54083436578857d-09, 8.10617835854935d-10, 4.99207055948336d-10, -1.52691648387663d-10, & 1.04022499586096d-09, -2.36437143845013d-10, -2.25110813484842d-10, -7.39850069252329d-11, 7.95929405440911d-11, & -3.11579421267630d-05, -3.43576336877494d-06, 5.81663608263384d-06, 8.31534700351802d-07, 4.02619520312154d-06, & 6.00037066879001d-07, -1.12538760056168d-07, -3.86745332115590d-07, -3.88218746020826d-07, -6.83764967176388d-07, & -9.79583981249316d-08, 9.14964449851003d-08, 4.77779838549237d-09, 2.44283811750703d-09, -6.26361079345158d-09, & -2.37742207548109d-08, -5.53336301671633d-09, -3.73625445257115d-09, -1.92304189572886d-09, -7.18681390197449d-09, & -6.58203463929583d-09, 9.28456148541896d-10, 2.47218904311077d-10, 1.10664919110218d-10, -4.20390976974043d-11, & 9.45857603373426d-10, -3.29683402990254d-11, -8.15440375865127d-11, -1.21615589356628d-12, -9.70713008848085d-12, & 1.61377382316176d-10, 6.84326027598147d-12, -4.66898885683671d-12, 2.31211355085535d-12, 2.39195112937346d-12, & 2.99634365075821d-07, 8.14391615472128d-06, 6.70458490942443d-06, -9.92542646762000d-07, -3.04078064992750d-06, & -6.52697933801393d-07, 2.87255329776428d-07, -1.78227609772085d-08, 2.65525429849935d-07, 8.60650570551813d-08, & -1.62727164011710d-07, 1.09102479325892d-07, 4.97827431850001d-09, 7.86649963082937d-11, -6.67193813407656d-09, & -2.96370000987760d-09, 1.20008401576557d-09, 1.75885448022883d-09, -1.74756709684384d-09, 3.21963061454248d-09, & -9.91101697778560d-10, 7.54541713140752d-10, -2.95880967800875d-10, 1.81009160501278d-10, 8.31547411640954d-11, & 1.21268051949609d-10, -5.93572774509587d-11, -5.03295034994351d-11, 3.05383430975252d-11, 3.56280438509939d-11, & 6.92012970333794d-11, -9.02885345797597d-12, -3.44151832744880d-12, 2.03164894681921d-12, -5.44852265137606d-12, & 5.56731263672800d-12, 3.57272150106101d-12, 2.25885622368678d-12, -2.44508240047675d-13, -6.83314378535235d-13, & 3.96883487797254d-06, -4.57100506169608d-06, -3.30208117813256d-06, 3.32599719134845d-06, 4.26539325549339d-06, & 1.10123151770973d-06, 4.58046760144882d-07, 1.86831972581926d-07, -1.60092770735081d-07, -5.58956114867062d-07, & -3.40344900506653d-08, 2.87649741373047d-08, -1.83929753066251d-08, -9.74179203885847d-09, -2.42064137485043d-09, & -6.49731596932566d-09, -3.07048108404447d-09, -2.84380614669848d-09, 1.55123146524283d-09, 4.53694984588346d-10, & 5.45175793803325d-10, -3.73287624700125d-10, -1.16293122618336d-10, 7.25845618602690d-11, -4.34112440021627d-11, & 1.89481447552805d-10, 3.67431482211078d-12, -1.72180065021194d-11, 1.47046319023226d-11, 1.31920481414062d-11, & 2.10125915737167d-12, -3.08420783495975d-12, -4.87748712363020d-12, 1.16363599902490d-14, 1.26698255558605d-13, & -8.07894928696254d-12, 9.19344620512607d-13, 3.26929173307443d-13, 2.00438149416495d-13, -9.57035765212079d-15, & 1.38737151773284d-12, 1.09340178371420d-13, 5.15714202449053d-14, -5.92156438588931d-14, -3.29586752336143d-14, & 6.38137197198254d-06, 4.62426300749908d-06, 4.42334454191034d-06, 1.15374736092349d-06, -2.61859702227253d-06, & -2.25320619636149d-07, 3.21907705479353d-07, -3.34834530764823d-07, -4.82132753601810d-07, -3.22410936343355d-07, & 3.48894515496995d-09, 3.49951261408458d-08, -6.01128959281142d-09, 4.78213900943443d-09, 1.46012816168576d-08, & -9.66682871952083d-11, 3.75806627535317d-09, 2.38984004956705d-09, 2.07545049877203d-09, 1.58573595632766d-09, & 1.06834370693917d-09, -4.07975055112153d-10, -2.37598937943957d-10, 5.89327007480137d-11, 1.18891820437634d-10, & 5.22433722695807d-11, 6.02011995016293d-12, -7.80605402956048d-12, 1.50873145627341d-11, -1.40550093106311d-12, & 2.13396242187279d-13, -1.71939313965536d-12, -3.57625378660975d-14, -5.01675184988446d-14, -1.07805487368797d-12, & -1.24352330043311d-12, 8.26105883301606d-13, 4.63606970128517d-13, 6.39517888984486d-14, -7.35135439920086d-14, & -5.39023859065631d-13, 2.54188315588243d-14, 1.30933833278664d-14, 6.06153473304781d-15, -4.24722717533726d-14, & 3.12767756884813d-14, -2.29517847871632d-15, 2.53117304424948d-16, 7.07504914138118d-16, -1.20089065310688d-15, & 2.08311178819214d-06, -1.22179185044174d-06, -2.98842190131044d-06, 3.07310218974299d-06, 2.27100346036619d-06, & -3.94601643855452d-07, -5.44014825116083d-07, -6.16955333162507d-08, -2.31954821580670d-07, 1.14010813005310d-07, & 6.11067575043044d-08, -3.93240193194272d-08, -1.62979132528933d-08, 1.01339204652581d-08, 1.97319601566071d-08, & 2.57770508710055d-09, 1.87799543582899d-09, 1.95407654714372d-09, 1.15276419281270d-09, 2.25397005402120d-09, & 7.16926338026236d-10, -3.65857693313858d-10, -1.54864067050915d-11, 6.50770211276549d-11, -7.85160007413546d-12, & 4.90007693914221d-12, 3.31649396536340d-12, 4.81664871165640d-13, 7.26080745617085d-12, 2.30960953372164d-12, & 9.75489202240545d-13, -1.68967954531421d-13, 7.38383391334110d-13, -3.58435515913239d-13, -3.01564710027450d-13, & -3.79533601922805d-13, 2.76681830946617d-13, 1.21480375553803d-13, -1.57729077644850d-14, -8.87664977818700d-14, & -3.96462845480288d-14, 2.94155690934610d-14, 6.78413205760717d-15, -4.12135802787361d-15, -1.46373307795619d-14, & -8.64941937408121d-15, -1.91822620970386d-15, -8.01725413560744d-16, 5.02941051180784d-16, -1.07572628474344d-15, & -4.13816294742758d-15, -7.43602019785880d-17, -5.54248556346072d-17, -4.83999456005158d-17, -1.19622559730466d-16, & -8.34852132750364d-07, -7.45794677612056d-06, -6.58132648865533d-06, -1.38608110346732d-06, 5.32326534882584d-07, & -2.75513802414150d-07, 3.64713745106279d-08, -7.12385417940442d-08, -7.86206067228882d-08, 2.28048393207161d-08, & -4.26696415431918d-08, -4.65599668635087d-09, 7.35037936327566d-09, 1.17098354115804d-08, 1.44594777658035d-08, & 1.12407689274199d-09, 7.62142529563709d-10, -6.72563708415472d-10, -1.18094592485992d-10, -1.17043815733292d-09, & 1.76612225246125d-10, -1.01188552503192d-10, 7.32546072616968d-11, 1.79542821801610d-11, -2.23264859965402d-11, & -9.35960722512375d-12, 1.90894283812231d-12, -6.34792824525760d-13, 3.98597963877826d-12, -4.47591409078971d-12, & -3.34623858556099d-12, 4.56384903915853d-14, 2.72561108521416d-13, -3.57942733300468d-15, 1.99794810657713d-13, & -6.16775522568954d-14, 8.25316968328823d-14, 7.19845814260518d-14, -2.92415710855106d-14, -5.49570017444031d-15, & -8.50728802453217d-15, 8.38161600916267d-15, 3.43651657459983d-15, -8.19429434115910d-16, -4.08905746461100d-15, & 4.39042894275548d-15, -3.69440485320477d-16, 1.22249256876779d-16, -2.09359444520984d-16, -3.34211740264257d-16, & -5.36054548134225d-16, 3.29794204041989d-17, 2.13564354374585d-17, -1.37838993720865d-18, -1.29188342867753d-17, & -3.26421841529845d-17, 7.38235405234126d-18, 2.49291659676210d-18, 8.18252735459593d-19, 1.73824952279230d-20, & 4.67237509268208d-06, 1.93611283787239d-06, 9.39035455627622d-07, -5.84565118072823d-07, -1.76198705802101d-07, & -3.33739157421993d-07, 4.12139555299163d-07, 1.58754695700856d-07, 1.37448753329669d-07, 1.04722936936873d-07, & 6.64200603076386d-09, 1.45412222625734d-08, 1.82498796118030d-08, 2.86633517581614d-09, 1.06066984548100d-09, & 5.25549696746655d-09, -1.33677183394083d-09, 7.60804375937931d-11, -1.07918624219037d-10, 8.09178898247941d-10, & 1.89318454110039d-10, 9.23092164791765d-11, 5.51434573131180d-11, 3.86696392289240d-11, -1.15208165047149d-11, & -1.02252706006226d-12, -7.25921015411136d-13, -1.98110126887620d-12, -2.18964868282672d-13, -7.18834476685625d-13, & -2.69770025318548d-12, -2.17850340796321d-14, 4.73040820865871d-13, 1.57947421572149d-13, 1.86925164972766d-13, & 1.07831718354771d-13, 2.26681841611017d-14, 2.56046087047783d-14, -1.14995851659554d-14, -2.27056907624485d-14, & 6.29825154734712d-15, 8.04458225889001d-16, 9.53173540411138d-16, 1.16892301877735d-15, -1.04324684545047d-15, & -5.57345639727027d-16, -2.93949227634932d-16, 7.47621406284534d-18, -5.36416885470756d-17, -2.87213280230513d-16, & 1.73219775047208d-16, 2.05017387523061d-17, 9.08873886345587d-18, -2.86881547225742d-18, -1.25303645304992d-17, & -7.30829109684568d-18, 2.03711261415353d-18, 7.62162636124024d-19, -7.54847922012517d-19, -8.85105098195030d-19, & 5.62039968280587d-18, -1.38144206573507d-19, 1.68028711767211d-20, 1.81223858251981d-19, -8.50245194985878d-20/ data(anm_bw_temp(i),i=1,455) & /0.0013612746740122d0,-6.83476317823061d-07,-1.37211986707674d-06, 7.02561866200582d-07,-2.16342338010651d-07, & -9.53197486400299d-06, 6.58703762338336d-06, 2.42000663952044d-06,-6.04283463108935d-07, 2.02144424676990d-07, & -6.76728911259359d-06, 6.03830755085583d-07,-8.72568628835897d-08, 2.21750344140938d-06, 1.05146032931020d-06, & -3.21102832397338d-05,-7.88685357568093d-06,-2.55495673641049d-06,-1.99601934456719d-06,-4.62005252198027d-07, & -7.84639263523250d-07, 3.11624739733849d-06, 9.02170019697389d-07, 6.37066632506008d-07,-9.44485038780872d-09, & 2.19476873575507d-06,-2.20580510638233d-07, 6.94761415598378d-07, 4.80770865279717d-07,-1.34357837196401d-07, & 2.18469215148328d-05,-1.80674174262038d-06,-1.52754285605060d-06,-3.51212288219241d-07, 2.73741237656351d-06, & 2.85579058479116d-06, 1.57201369332361d-07,-2.80599072875081d-07,-4.91267304946072d-07,-2.11648188821805d-07, & 2.81729255594770d-06, 3.02487362536122d-07,-1.64836481475431d-07,-2.11607615408593d-07,-6.47817762225366d-08, & 1.31809947620223d-07,-1.58289524114549d-07,-7.05580919885505d-08, 5.56781440550867d-08, 1.23403290710365d-08, & -1.29252282695869d-05,-1.07247072037590d-05,-3.31109519638196d-06, 2.13776673779736d-06,-1.49519398373391d-07, & 1.81685152305722d-06,-1.17362204417861d-06,-3.19205277136370d-08, 4.09166457255416d-07, 1.53286667406152d-07, & 1.63477723125362d-06,-2.68584775517243d-08, 4.94662064805191d-09,-7.09027987928288d-08, 4.44353430574937d-08, & -2.13090618917978d-07, 4.05836983493219d-08, 2.94495876336549d-08,-1.75005469063176d-08,-3.03015988647002d-09, & -2.16074435298006d-09, 9.37631708987675d-09,-2.05996036369828d-08, 6.97068002894092d-09,-8.90988987979604d-09, & 1.38047798906967d-05, 2.05528261553901d-05, 1.59072148872708d-05, 7.34088731264443d-07, 1.28226710383580d-06, & 7.08175753966264d-07,-9.27988276636505d-07, 1.60535820026081d-07,-3.27296675122065d-07,-2.20518321170684d-07, & 1.90932483086199d-07,-7.44215272759193d-08, 1.81330673333187d-08, 4.37149649043616d-08, 4.18884335594172d-08, & -5.37009063880924d-08, 2.22870057779431d-08, 1.73740123037651d-08,-4.45137302235032d-09, 9.44721910524571d-09, & -6.83406949047909d-08,-1.95046676795923d-10, 2.57535903049686d-09, 4.82643164083020d-09, 3.37657333705158d-09, & 3.96128688448981d-09,-6.63809403270686d-10, 2.44781464212534d-10, 5.92280853590699d-11,-4.78502591970721d-10, & 1.75859399041414d-05,-2.81238050668481d-06,-2.43670534594848d-06, 3.58244562699714d-06,-1.76547446732691d-06, & -1.06451311473304d-07, 1.54336689617184d-06,-2.00690000442673d-07, 1.38790047911880d-09,-1.62490619890017d-07, & -2.72757421686155d-07, 1.71139266205398d-07,-2.55080309401917d-08,-8.40793079489831d-09,-1.01129447760167d-08, & 2.92966025844079d-08,-2.07556718857313d-08, 5.45985315647905d-09, 8.76857690274150d-09, 1.06785510440474d-08, & -1.22059608941331d-08, 6.52491630264276d-09,-1.79332492326928d-10, 3.75921793745396d-10,-7.06416506254786d-10, & 1.63224355776652d-09, 4.95586028736232d-10,-3.07879011759040d-10,-7.78354087544277d-11, 1.43959047067250d-10, & 3.86319414653663d-10,-2.06467134617933d-10, 4.37330971382694d-11,-5.00421056263711d-11,-9.40237773015723d-12, & -1.23856142706451d-05, 7.61047394008415d-06,-1.99104114578138d-07, 6.86177748886858d-07,-1.09466747592827d-07, & 2.99866062403128d-07, 1.87525561397390d-07, 4.99374806994715d-08, 4.86229763781404d-07, 4.46570575517658d-07, & -5.05748332368430d-07, 1.95523624722285d-08,-9.17535435911345d-08,-2.56671607433547d-08,-7.11896201616653d-08, & -2.66062200406494d-08,-5.40470019739274d-09,-2.29718660244954d-09,-3.73328592264404d-09, 3.38748313712376d-09, & 5.30855327954894d-10, 5.28851845648032d-10,-2.22278913745418d-10,-5.52628653064771d-11,-9.24825145219684d-10, & 6.03737227573716d-10,-3.52190673510919d-12,-1.30371720641414d-10,-9.12787239944822d-12, 6.42187285537238d-12, & 1.78081862458539d-10, 2.93772078656037d-12,-1.04698379945322d-11,-2.82260024833024d-11,-5.61810459067525d-12, & 9.35003092299580d-12,-8.23133834521577d-13, 5.54878414224198d-13,-3.62943215777181d-13, 2.38858933771653d-12, & -1.31216096107331d-05,-5.70451670731759d-06,-5.11598683573971d-06,-4.99990779887599d-06, 1.27389320221511d-07, & -1.23108260369048d-06, 5.53093245213587d-07, 8.60093183929302d-07, 2.65569700925696d-07, 1.95485134805575d-07, & -2.29647072638049d-07,-5.45266515081825d-08, 2.85298129762263d-08, 1.98167939680185d-08, 5.52227340898335d-09, & -2.73844745019857d-08,-4.48345173291362d-10,-1.93967347049382d-09,-1.41508853776629d-09,-1.75456962391145d-09, & -2.68863184376108d-11,-2.20546981683293d-09, 6.56116990576877d-10, 1.27129855674922d-10,-2.32334506413213d-10, & 1.98303136881156d-10, 6.04782006047075d-11, 2.91291115431570d-11, 6.18098615782757d-11,-3.82682292530379d-11, & 9.48294455071158d-12,-3.05873596453015d-13, 5.31539408055057d-13,-7.31016438665600d-12,-1.19921002209198d-11, & -2.25188050845725d-11,-3.91627574966393d-13,-6.80217235976769d-13, 5.91033607278405d-13, 5.02991534452191d-13, & 1.29532063896247d-12, 1.66337285851564d-13, 3.25543028344555d-13, 1.89143357962363d-13, 3.32288378169726d-13, & -2.45864358781728d-06, 4.49460524898260d-06, 1.03890496648813d-06,-2.73783420376785d-06, 7.12695730642593d-07, & -9.27805078535168d-07,-4.97733876686731d-07, 9.18680298906510d-08,-2.47200617423980d-07, 6.16163630140379d-08, & -1.39623661883136d-08,-1.12580495666505d-07, 2.61821435950379d-08,-2.31875562002885d-08, 5.72679835033659d-08, & -9.52538983318497d-09,-5.40909215302433d-09, 1.88698793952475d-09,-4.08127746406372d-09, 1.09534895853812d-10, & 3.79767457525741d-09, 1.11549801373366d-10,-6.45504957274111d-10, 3.05477141010356d-10, 1.26261210565856d-10, & 5.08813577945300d-11, 1.43250547678637d-11, 8.81616572082448d-12, 2.58968878880804d-11, 3.83421818249954d-11, & 8.95094368142044d-12,-3.26220304555971d-12,-1.28047847191896d-12, 2.67562170258942d-12, 2.72195031576670d-12, & -6.47181697409757d-12, 1.13776457455685d-12, 2.84856274334969d-13,-7.63667272085395d-14,-1.34451657758826d-13, & -1.25291265888343d-12, 8.63500441050317d-14,-1.21307856635548d-13, 5.12570529540511d-14, 3.32389276976573d-14, & 3.73573418085813d-14,-5.37808783042784d-16,-4.23430408270850d-16,-4.75110565740493d-15, 6.02553212780166d-15, & 8.95483987262751d-06,-3.90778212666235d-06,-1.12115019808259d-06, 1.78678942093383d-06, 1.46806344157962d-06, & -4.59185232678613d-07, 1.09497995905419d-07, 1.31663977640045d-07, 4.20525791073626d-08,-9.71470741607431d-08, & 1.63399802579572d-07, 1.50909360648645d-08,-1.11480472593347d-08,-1.84000857674573d-08, 7.82124614794256d-09, & 1.22887452385094d-08,-4.06647399822746d-10,-6.49120327585597d-10, 8.63651225791194d-10,-2.73440085913102d-09, & 2.51748630889583d-09, 4.79895880425564d-10,-2.44908073860844d-10, 2.56735882664876d-10,-1.64815306286912d-10, & 4.85671381736718d-11,-2.51742732115131d-11,-2.60819437993179d-11, 6.12728324086123d-12, 2.16833310896138d-11, & 4.11389702320298d-12,-8.09433180989935d-13,-1.19812498226024d-12, 1.46885737888520d-12, 3.15807685137836d-12, & -1.47614580597013d-12, 4.66726413909320d-13, 1.72089709006255d-13, 1.13854935381418d-13, 2.77741161317003d-13, & -1.02257724967727d-13, 1.10394382923502d-13,-3.14153505370805d-15, 2.41103099110106d-14, 2.13853053149771d-14, & -3.19080885842786d-14,-9.53904307973447d-15, 2.74542788156379d-15, 2.33797859107844d-15,-2.53192474907304d-15, & -5.87702222126367d-15,-1.80133850930249d-15,-3.09793125614454d-16,-1.04197538975295d-16, 3.72781664701327d-16, & 1.86187054729085d-06, 8.33098045333428d-06, 3.18277735484232d-06,-7.68273797022231d-07,-1.52337222261696d-06, & -5.07076646593648d-07,-8.61959553442156d-07,-3.51690005432816d-07,-4.20797082902431d-07,-3.07652993252673d-07, & -7.38992472164147d-08,-8.39473083080280d-08,-2.51587083298935d-08, 7.30691259725451d-09,-3.19457155958983d-08, & -1.99777182012924d-09,-3.21265085916022d-09,-4.84477421865675d-10,-1.82924814205799d-09,-3.46664344655997d-10, & -7.05788559634927d-11, 1.21840735569025d-10, 7.97347726425926d-11, 1.08275679614409d-10,-1.17891254809785d-10, & 1.10299718947774d-11,-3.22958261390263d-11,-1.43535798209229d-11, 6.87096504209595d-12,-6.64963212272352d-12, & -6.47393639740084d-12, 1.03156978325120d-12,-9.20099775082358d-14,-2.40150316641949d-13, 1.14008812047857d-12, & -1.23957846397250d-13, 2.85996703969692d-13, 1.91579874982553d-13, 5.20597174693064d-14,-4.06741434883370d-14, & -2.35479068911236d-14, 1.97847338186993d-14, 1.58935977518516d-15,-2.32217195254742d-15,-8.48611789490575d-15, & 1.03992320391626d-14, 1.54017082092642d-15, 1.05950035082788d-16,-1.17870898461353d-15,-1.10937420707372d-15, & -1.09011948374520d-15,-6.04168007633584d-16,-9.10901998157436d-17, 1.98379116989461d-16,-1.03715496658498d-16, & -1.38171942108278d-16,-6.33037999097522d-17,-1.38777695011470d-17, 1.94191397045401d-17, 5.70055906754485d-18, & 1.92989406002085d-06,-3.82662130483128d-06,-4.60189561036048d-07, 2.24290587856309d-06, 1.40544379451550d-06, & 6.49033717633394d-08, 2.41396114435326d-07, 2.73948898223321d-07, 1.10633664439332d-07,-3.19555270171075d-08, & -2.91988966963297d-08,-6.03828192816571d-09, 1.18462386444840d-08, 1.32095545004128d-08,-5.06572721528914d-09, & 7.31079058474148d-09,-8.42775299751834d-10, 1.10190810090667d-09, 1.96592273424306d-09,-2.13135932785688d-09, & 7.06656405314388d-11, 1.43441125783756d-10, 1.46962246686924d-10, 7.44592776425197d-11,-3.64331892799173d-11, & -2.52393942119372d-11, 1.07520964869263d-11, 5.84669886072094d-12, 6.52029744217103d-12, 1.82947123132059d-12, & -4.15669940115121d-12,-1.95963254053648d-13, 2.16977822834301d-13,-2.84701408462031d-13, 4.27194601040231d-13, & 3.07891105454129d-13, 1.91523190672955d-13, 1.05367297580989d-13,-5.28136363920236d-14,-3.53364110005917d-14, & 7.02156663274738d-15, 9.52230536780849d-15,-3.41019408682733d-15,-3.59825303352899d-15,-2.62576411636150d-15, & -1.75110277413804d-15, 5.29265220719483d-16, 4.45015980897919d-16,-3.80179856341347d-16,-4.32917763829695d-16, & 1.16038609651443d-16,-6.69643574373352d-17, 2.65667154817303d-17,-9.76010333683956d-17, 4.07312981076655d-17, & 5.72659246346386d-18, 1.30357528108671d-18, 2.49193258417535d-18, 1.76247014075584d-18, 7.59614374197688d-19, & 1.03352170833303d-17,-2.30633516638829d-18, 2.84777940620193d-18,-7.72161347944693d-19, 6.07028034506380d-19/ data(anm_ch_temp(i),i=1,455) & /0.0571481238161787d0, 3.35402081801137d-05, 3.15988141788728d-05,-1.34477341887086d-05,-2.61831023577773d-07, & 5.77367395845715d-05,-0.0006690571852096d0,-6.51057691648904d-05,-1.61830149147091d-06, 8.96771209464758d-05, & -8.50773002452907d-05,-4.87106614880272d-05, 4.03431160775277d-05, 2.54090162741464d-06,-5.59109319864264d-06, & 0.0015053642318771d0, 0.0006116822588927d0, 0.0003697300246149d0,-1.95658439780282d-05,-3.46246726553700d-05, & -2.32168718433966d-05,-0.0001274786865538d0,-9.00292451740728d-05,-6.07834315901830d-05,-1.04628419422714d-05, & -1.38607250922551d-06,-3.97271603842309d-06,-8.16155320152118d-07, 5.73266706046665d-07, 2.00366060212696d-07, & 6.52491559188663d-05,-0.0011222432346018d0,-0.0003449679583041d0,-7.67282640947300d-05, 0.0001079071105520d0, & -0.0001388704614480d0,-7.29995695401936d-05, 5.35986591445824d-05, 9.03804869703890d-06, 8.61370129482732d-06, & -9.98524443968768d-07,-6.84966792665998d-08, 1.47478021860771d-07, 1.94857794008064d-06, 7.17176852732910d-07, & 1.27066367911720d-06, 1.12113289164288d-06, 2.71525688515375d-07,-2.76125723009239d-07,-1.05429690305013d-07, & -0.0003772649999817d0, 0.0002626912170243d0, 0.0001836397858376d0, 3.93177048515576d-06,-6.66187081899168d-06, & -4.93720951871921d-05,-0.0001028200304058d0,-5.69904376301748d-05,-3.79603438055116d-05,-3.96726017834930d-06, & -2.21881958961135d-06,-1.40207117987894d-06, 1.60956630798516d-07, 2.06121145135022d-06, 6.50944708093149d-07, & 2.21876332411271d-07, 1.92272880430386d-07,-6.44016558013941d-09,-1.40954921332410d-07,-4.26742169137667d-07, & -3.51738525149881d-08, 2.89616194332516d-08,-3.40343352397886d-08,-2.89763392721812d-08,-6.40980581663785d-10, & 3.51240856823468d-05,-0.0007258950153458d0,-0.0003225140371080d0,-0.0001061437599816d0, 4.08153152459337d-05, & -2.36269716929413d-05,-4.20691836557932d-05, 1.43926743222922d-05, 2.61811210631784d-05, 2.09610762194903d-05, & -7.91765756673890d-07, 1.64556789159745d-06,-9.43930166276555d-07, 6.46641738736139d-07,-5.91509547299176d-07, & 3.92768838766879d-07,-1.98027731703690d-07,-5.41303590057253d-08,-4.21705797874207d-07,-6.06042329660681d-08, & -1.56650141024305d-08, 7.61808165752027d-08,-1.81900460250934d-08, 1.30196216971675d-08, 1.08616031342379d-08, & -2.80964779829242d-08,-7.25951488826103d-09,-2.59789823306225d-09,-2.79271942407154d-09, 4.10558774868586d-09, & -0.0006382278576483d0,-0.0001548140453634d0, 7.78518327501759d-05,-2.95961469342381d-05, 1.15965225055757d-06, & 4.47833146915112d-06, 1.33712284237555d-05, 3.61048816552123d-06,-2.50717844073547d-06,-1.28100822021734d-05, & -2.26958070007455d-06, 2.57779960912242d-06, 1.08395653197976d-06, 1.29403393862805d-07,-1.04854652812567d-06, & -3.98954043463392d-07,-2.26931182815454d-07,-1.09169545045028d-07,-1.49509536031939d-07,-3.98376793949903d-07, & 2.30418911071110d-08, 1.23098508481555d-08,-1.71161401463708d-08, 2.35829696577657d-09, 1.31136164162040d-08, & 3.69423793101582d-09, 3.49231027561927d-10,-1.18581468768647d-09, 5.43180735828820d-10, 5.43192337651588d-10, & -1.38608847117992d-09,-1.86719145546559d-10,-8.13477384765498d-10, 2.01919878240491d-10, 1.00067892622287d-10, & -4.35499078415956d-05, 0.0004507279679578d0, 0.0003289784942689d0,-3.05249478582848d-05,-3.21914834544310d-05, & 1.24887940973241d-05, 1.34275239548403d-05, 1.11275518344713d-06, 7.46733554562851d-06,-2.12458664760353d-06, & 9.50250784948476d-07, 2.34367372695203d-06,-5.43099244798980d-07,-4.35196904508734d-07,-8.31852234345897d-07, & 5.91775478636535d-09,-1.48970922508592d-07, 2.99840061173840d-08,-1.30595933407792d-07, 1.27136765045597d-07, & -1.78491083554475d-08, 1.76864919393085d-08,-1.96740493482011d-08, 1.21096708004261d-08, 2.95518703155064d-10, & 1.75053510088658d-09,-1.31414287871615d-09,-1.44689439791928d-09, 1.14682483668460d-09, 1.74488616540169d-09, & 1.08152964586251d-09,-3.85678162063266d-10,-2.77851016629979d-10, 3.89890578625590d-11,-2.54627365853495d-10, & -1.88340955578221d-10, 5.19645384002867d-11, 2.14131326027631d-11, 1.24027770392728d-11,-9.42818962431967d-12, & 0.0003597777298439d0,-0.0001116926199962d0,-6.87103418744904d-05, 0.0001151289738796d0, 7.59796247722486d-05, & 5.23717968000879d-05, 1.32279078116467d-05,-5.72277317139479d-07,-7.56326558610214d-06,-1.95749622214651d-05, & 1.00109213210139d-06,-2.75515216592735d-07,-1.13393194050846d-06,-4.75049734870663d-07,-3.21499480530932d-07, & -2.07013716598890d-07,-7.31392258077707d-08,-3.96445714084160d-08, 3.21390452929387d-08,-1.43738764991525d-08, & 2.03081434931767d-09,-1.35423687136122d-08,-4.47637454261816d-09, 2.18409121726643d-09,-3.74845286805217d-09, & 3.17469255318367d-09, 2.44221027314129d-10,-2.46820614760019d-10, 7.55851003884434d-10, 6.98980592550891d-10, & 9.89541493531067d-11,-2.78762878057315d-11,-2.10947962916771d-10, 3.77882267360636d-11,-1.20009542671532d-12, & 5.01720575730940d-11, 1.66470417102135d-11,-7.50624817938091d-12, 9.97880221482238d-12, 4.87141864438892d-12, & 2.53137945301589d-11, 1.93030083090772d-12,-1.44708804231290d-12,-1.77837100743423d-12,-8.10068935490951d-13, & 0.0001157353415207d0, 0.0001169105910484d0, 8.36315620479475d-05, 1.61095702669207d-05,-7.53084853489862d-05, & -9.76879433427199d-06, 9.16968438003335d-06,-8.72755127288830d-06,-1.30077933880053d-05,-9.78841937993320d-06, & 1.04902782517565d-07, 2.14036988364936d-07,-7.19358686652888d-07, 1.12529592946332d-07, 7.07316352860448d-07, & 7.63177265285080d-08, 1.22781974434290d-07, 8.99971272969286d-08, 5.63482239352990d-08, 4.31054352285547d-08, & 3.29855763107355d-09,-6.95004336734441d-09,-6.52491370576354d-09, 1.97749180391742d-09, 3.51941791940498d-09, & 3.85373745846559d-10, 1.65754130924183d-10,-3.31326088103057d-10, 5.93256024580436d-10, 1.27725220636915d-10, & -1.08840956376565d-10,-4.56042860268189d-11,-4.77254322645633d-12,-2.94405398621875d-12,-3.07199979999475d-11, & 2.07389879095010d-11, 1.51186798732451d-11, 9.28139802941848d-12, 5.92738269687687d-12, 9.70337402306505d-13, & -2.85879708060306d-12, 1.92164314717053d-13, 4.02664678967890d-14, 5.18246319204277d-13,-7.91438726419423d-13, & 6.91890667590734d-13,-8.49442290988352d-14,-5.54404947212402d-15, 9.71093377538790d-15,-5.33714333415971d-14, & -5.06132972789792d-05,-4.28348772058883d-05,-6.90746551020305d-05, 8.48380415176836d-05, 7.04135614675053d-05, & -1.27945598849788d-05,-1.92362865537803d-05,-2.30971771867138d-06,-8.98515975724166d-06, 5.25675205004752d-06, & -8.71907027470177d-07,-1.02091512861164d-06,-1.69548051683864d-07, 4.87239045855761d-07, 9.13163249899837d-07, & -6.23651943425918d-08, 6.98993315829649d-08, 5.91597766733390d-08, 4.36227124230661d-08, 6.45321798431575d-08, & -1.46315079552637d-10,-7.85142670184337d-09, 1.48788168857903d-09, 2.16870499912160d-09,-1.16723047065545d-09, & 3.31888494450352d-10, 1.90931898336457d-10,-3.13671901557599d-11, 2.60711798190524d-10, 8.45240112207997d-11, & 1.36645682588537d-11,-5.68830303783976d-12, 1.57518923848140d-11,-1.61935794656758d-11,-4.16568077748351d-12, & 9.44684950971905d-13, 7.30313977131995d-12, 3.14451447892684d-12, 6.49029875639842d-13,-9.66911019905919d-13, & -8.13097374090024d-13, 5.23351897822186d-13, 8.94349188113951d-14,-1.33327759673270d-13,-4.04549450989029d-13, & -3.76176467005839d-14,-6.19953702289713d-14,-3.74537190139726d-14, 1.71275486301958d-14,-3.81946773167132d-14, & -4.81393385544160d-14, 3.66084990006325d-15, 3.10432030972253d-15,-4.10964475657416d-15,-6.58644244242900d-15, & -7.81077363746945d-05,-0.0002547736321973d0,-0.0002145385080095d0,-3.80780934346726d-05, 1.83495359193990d-05, & 5.89140224113144d-06,-3.17312632433258d-06,-3.81872516710791d-06,-2.27592226861647d-06, 1.57044619888023d-06, & -1.44272505088690d-06,-1.10236588903758d-07, 2.64336813084693d-07, 4.76074163332460d-07, 4.28623587694570d-07, & 3.98889120733904d-08,-1.29638005554027d-08,-4.13668481273828d-08, 1.27686793719542d-09,-3.54202962042383d-08, & 1.60726837551750d-09,-2.70750776726156d-09, 2.79387092681070d-09,-3.01419734793998d-10,-1.29101669438296d-10, & -2.55708290234943d-10, 2.27878015173471d-11,-6.43063443462716d-12, 1.26531554846856d-10,-1.65822147437220d-10, & -3.35886470557484d-11,-3.51895009091595d-12, 5.80698399963198d-12,-2.84881487149207d-12, 8.91708061745902d-12, & -3.12788523950588d-12, 3.35366912964637d-12, 2.52236848033838d-12,-8.12801050709184d-13,-2.63510394773892d-13, & 6.83791881183142d-14, 2.41583263270381d-13, 8.58807794189356d-14,-5.12528492761045d-14,-1.40961725631276d-13, & -1.28585349115321d-14,-2.11049721804969d-14, 5.26409596614749d-15,-4.31736582588616d-15,-1.60991602619068d-14, & -9.35623261461309d-15,-3.94384886372442d-16, 5.04633016896942d-16,-5.40268998456055d-16,-1.07857944298104d-15, & 8.79756791888023d-16, 4.52529935675330d-16, 1.36886341163227d-16,-1.12984402980452d-16, 6.30354561057224d-18, & 0.0001178292568848d0, 2.67013591698442d-05, 2.57913446775250d-05,-4.40766244878807d-05,-1.60651761172523d-06, & -1.87058092029105d-05, 1.34371169060024d-05, 5.59131416451555d-06, 4.50960364635647d-06, 2.87612873904633d-06, & 2.79835536517287d-07, 8.93092708148293d-07, 8.37294601021795d-07,-1.99029785860896d-08,-8.87240405168977d-08, & 4.95854313394905d-08,-1.44694570735912d-08, 2.51662229339375d-08,-3.87086600452258d-09, 2.29741919071270d-08, & 4.71497840986162d-09, 2.47509999454076d-09, 1.67323845102824d-09, 8.14196768283530d-10,-3.71467396944165d-10, & -1.07340743907054d-10,-8.07691657949326d-11,-5.99381660248133d-11, 2.33173929639378d-12,-2.26994195544563d-11, & -3.83130441984224d-11,-5.82499946138714d-12, 1.43286311435124d-11, 3.15150503353387d-12, 5.97891025146774d-12, & -5.64389191072230d-13, 9.57258316335954d-13, 1.12055192185939d-12,-4.42417706775420d-13,-9.93190361616481d-13, & 1.78188860269677d-13, 7.82582024904950d-14, 5.18061650118009d-14, 2.13456507353387d-14,-5.26202113779510d-14, & -8.18481324740893d-15,-3.71256746886786d-15, 4.23508855164371d-16,-2.91292502923102d-15,-1.15454205389350d-14, & 6.16578691696810d-15, 6.74087154080877d-16, 5.71628946437034d-16,-2.05251213979975d-16,-7.25999138903781d-16, & 9.35481959699383d-17, 6.23535830498083d-17, 3.18076728802060d-18,-2.92353209354587d-17, 7.65216088665263d-19, & 2.34173078531701d-17,-8.30342420281772d-18,-4.33602329912952d-18, 1.90226281379981d-18,-7.85507922718903d-19/ data(anm_cw_temp(i),i=1,455) & /0.0395329695826997d0,-0.0001311143807619d0,-0.0001163310090062d0, 6.23548420410646d-05, 5.72641113425116d-05, & -0.0004418376408807d0, 0.0007012886486549d0, 0.0003384898028583d0, 3.76700309908602d-05,-8.70889013574699d-06, & 1.30418530496887d-05,-0.0001850465475974d0, 4.31032103066723d-05, 0.0001055833341243d0, 3.23045436993589d-05, & 3.68918433448519d-05,-0.0002194330146815d0, 3.46768613485000d-06,-9.17185187163528d-05,-3.69243242456081d-05, & -6.50227201116778d-06, 2.07614874282187d-05,-5.09131314798362d-05,-3.08053225174359d-05,-4.18483655873918d-05, & 2.67879176459056d-05,-6.89303730743691d-05, 2.11046783217168d-06, 1.93163912538178d-05,-1.97877143887704d-06, & 0.0003939375950074d0,-0.0004529483812364d0,-0.0001365178460738d0, 0.0001382392479895d0, 0.0001331752329779d0, & 5.00214539435002d-05, 3.57229726719727d-05,-9.38010547535432d-07,-3.52586798317563d-05,-7.01218677681254d-06, & 3.91965314099929d-05, 1.02236686806489d-05,-1.95710695226022d-05,-5.93904795230695d-06, 3.24339769876093d-06, & 6.68158778290653d-06,-8.10468752307024d-06,-9.91192994096109d-06,-1.89755520007723d-07,-3.26799467595579d-06, & 0.0003141968177539d0,-0.0002965484471620d0,-0.0002184101532636d0,-1.57318389871000d-05, 4.69789570185785d-05, & 0.0001045977211240d0,-3.31000119089319d-05, 5.60326793626348d-05, 4.71895007710715d-05, 3.57432326236664d-05, & 8.95483021572039d-06, 1.44019305383365d-05, 4.87912790492931d-06,-3.45826387853503d-06, 3.23960320438157d-06, & -1.35249651009930d-05,-2.49349762695977d-06,-2.51509483521132d-06,-9.14254874104858d-07,-8.57897406100890d-07, & -1.68143325235195d-06, 1.72073417594235d-06, 1.38765993969565d-06, 4.09770982137530d-07,-6.60908742097123d-07, & -0.0006398893664872d0, 0.0012019404247469d0, 0.0007532585988877d0, 3.87356377414663d-05, 1.31231811175345d-05, & 2.77062763606783d-05,-9.51425270178477d-06,-6.61068056107547d-06,-1.38713669012109d-05, 9.84662092961671d-06, & -2.69398078539471d-06, 6.50860676783123d-06, 3.80855926988090d-06,-1.98076068364785d-06, 1.17187335666772d-06, & -2.63719028151905d-06, 5.03149473656743d-07, 7.38964893399716d-07,-8.38892485369078d-07, 1.30943917775613d-06, & -1.56634992245479d-06,-2.97026487417045d-08, 5.06602801102463d-08,-4.60436007958792d-08,-1.62536449440997d-07, & -2.37493912770935d-07, 1.69781593069938d-08, 8.35178275224265d-08,-4.83564044549811d-08,-4.96448864199318d-08, & 0.0013401225958759d0,-0.0002509893692532d0,-2.97647945512547d-05,-6.47889968094926d-05, 8.41302130716859d-05, & -0.0001132871849009d0, 4.78918993866293d-05,-3.14572113583139d-05,-2.10518256626847d-05,-2.03933633847417d-05, & -4.97413321312139d-07, 3.72599822034753d-06,-3.53221588399266d-06,-1.05232048036416d-06,-2.74821498198519d-06, & 4.81988542428155d-06, 4.21400219782474d-07, 1.02814808667637d-06, 4.40299068486188d-09, 3.37103399036634d-09, & 1.10140301678818d-08, 1.90257670180182d-07,-1.00831353341885d-08, 1.44860642389714d-08,-5.29882089987747d-08, & 6.12420414245775d-08,-4.48953461152996d-09,-1.38837603709003d-08,-2.05533675904779d-08, 1.49517908802329d-09, & 9.17090243673643d-10,-9.24878857867367d-09,-2.30856560363943d-09,-4.36348789716735d-09,-4.45808881183025d-10, & -0.0004249126996091d0,-0.0001143654384715d0,-0.0004032009818272d0, 4.19949560550194d-05,-3.02068483713739d-05, & 3.85435472851225d-05,-5.70726887668306d-05, 4.96313706308613d-07, 1.02395703617082d-05, 5.85550000567006d-06, & -7.38204470183331d-06,-4.56638770109511d-06,-3.94007992121367d-06,-2.16666812189101d-06,-4.55694264113194d-06, & 5.89841165408527d-07, 1.40862905173449d-08, 1.08149086563211d-07,-2.18592601537944d-07,-3.78927431428119d-07, & 4.85164687450468d-08, 8.34273921293655d-08, 1.47489605513673d-08, 6.01494125001291d-08, 6.43812884159484d-09, & 1.13055580655363d-08, 3.50568765400469d-09,-5.09396162501750d-09,-1.83362063152411d-09,-4.11227251553035d-09, & 3.16454132867156d-09,-1.39634794131087d-09,-7.34085003895929d-10,-7.55541371271796d-10,-1.57568747643705d-10, & 1.27572900992112d-09,-3.51625955080441d-10,-4.84132020565098d-10, 1.52427274930711d-10, 1.27466120431317d-10, & -0.0004816556662365d0,-0.0002454233139038d0,-0.0002394999028167d0,-0.0001571329473510d0, 5.54583099258017d-05, & -1.52987254785589d-05, 2.78383892116245d-05, 4.32299123991860d-05, 1.70981319744327d-05,-1.35090841769225d-06, & -8.65400907717798d-06,-6.51882656990376d-06,-2.43810171017369d-07, 8.54348785752623d-07, 2.98371863248143d-07, & -1.68155571776752d-06,-3.53602587563318d-07,-1.00404435881759d-07,-2.14162249012859d-08,-2.42131535531526d-07, & -1.08048603277187d-08,-9.78850785763030d-08,-2.32906554437417d-08, 2.22003630858805d-08,-2.27230368089683d-09, & -5.98864391551041d-09, 7.38970926486848d-09, 3.61322835311957d-09, 3.70037329172919d-09,-3.41121137081362d-09, & -7.33113754909726d-10,-9.08374249335220d-11,-1.78204392133739d-10, 8.28618491929026d-11,-1.32966817912373d-10, & -5.23340481314676d-10, 1.36403528233346d-10,-7.04478837151279d-11,-6.83175201536443d-12,-2.86040864071134d-12, & 3.75347503578356d-11,-1.08518134138781d-11,-2.53583751744508d-12, 1.00168232812303d-11, 1.74929602713312d-11, & -0.0006868053363706d0, 0.0005918498145857d0, 0.0004751173783280d0,-2.59339398048415d-05, 3.74825110514968d-05, & 3.35231363034093d-05, 2.38331521146909d-05, 7.43545963794093d-06,-3.41430817541849d-06, 7.20180957675353d-06, & 3.60564374432978d-07,-3.13300039589662d-06,-6.38974746108020d-07,-8.63985524672024d-07, 2.43367665208655d-06, & -4.09605238516094d-07,-2.51158699554904d-07,-1.29359217235188d-07,-2.27744642483133d-07, 7.04065989970205d-08, & 6.74886341820129d-08,-1.02009407061935d-08,-3.30790296448812d-08, 1.64959795655031d-08, 1.40641779998855d-08, & 1.31706886235108d-09,-1.06243701278671d-09,-2.85573799673944d-09, 3.72566568681289d-09, 2.48402582003925d-09, & -3.68427463251097d-11,-1.90028122983781d-10,-3.98586561768697d-11, 1.14458831693287d-11,-2.27722300377854d-12, & -7.90029729611056d-11, 3.81213646526419d-11, 4.63303426711788d-11, 1.52294835905903d-11,-2.99094751490726d-12, & -2.36146602045017d-11, 1.03852674709985d-11,-4.47242126307100d-12, 5.30884113537806d-12, 1.68499023262969d-12, & -3.30107358134527d-13,-4.73989085379655d-13, 5.17199549822684d-13, 2.34951744478255d-13, 2.05931351608192d-13, & 0.0004302156875118d0,-0.0001328313730000d0,-3.41830835017045d-05, 4.70312161436033d-06,-3.84807179340006d-05, & 1.66861163032403d-05,-8.10092908523550d-06, 8.20658107437905d-06, 6.12399025026683d-06,-1.85536495631911d-06, & 1.53552093641337d-06, 2.19486495660361d-06,-1.07253805120137d-06,-4.72141767909137d-07, 4.00744581573216d-07, & 2.56647305130757d-07,-8.07492046592274d-08,-2.05858469296168d-07, 1.09784168930599d-07,-7.76823030181225d-08, & 1.77744008115031d-08, 1.64134677817420d-08, 4.86163044879020d-09, 1.13334251800856d-08,-7.17260621115426d-09, & 1.61133063219326d-09,-1.85414677057024d-09,-2.13798537812651d-09, 1.15255123229679d-09, 2.24504700129464d-09, & 1.23344223096739d-10,-1.20385012169848d-10,-2.18038256346433d-12, 3.23033120628279d-11, 8.01179568213400d-11, & -6.55745274387847d-12, 1.22127104697198d-11, 5.83805016355883d-12,-8.31201582509817d-12, 1.90985373872656d-12, & -2.89199983667265d-12, 5.05962500506667d-12, 1.28092925110279d-12, 5.60353813743813d-13, 1.76753731968770d-12, & -1.61678729774956d-13,-3.92206170988615d-13,-9.04941327579237d-14, 1.89847694200763d-13, 4.10008676756463d-14, & -1.16808369005656d-13,-9.97464591430510d-14, 7.46366550245722d-15, 2.53398578153179d-14, 1.06510689748906d-14, & -0.0001137169213848d0,-0.0001319027226515d0,-0.0001628448864858d0, 7.90171538739454d-06,-0.0001787680669614d0, & -2.13146535366500d-06,-3.57818705543597d-05,-1.50825855069298d-05,-2.17909259570022d-05,-8.19332236308581d-06, & -2.88001138617357d-06,-2.09957465440793d-06, 6.81466526687552d-08, 3.58308906974448d-07,-4.18502067223724d-07, & -1.10761444317605d-07, 6.91773860777929d-08, 8.17125372450372d-08,-2.16476237959181d-08, 7.59221970502074d-08, & -9.56994224818941d-09, 6.64104921728432d-09, 6.33077902928348d-09, 2.85721181743727d-09,-6.39666681678123d-09, & 4.62558627839842d-10,-1.69014863754621d-09,-2.80260429599733d-10, 4.27558937623863d-11,-1.66926133269027d-10, & -7.23385132663753d-11, 5.51961193545280d-11, 3.04070791942335d-11, 3.23227055919062d-12, 8.47312431934829d-11, & -1.61189613765486d-11, 1.66868155925172d-11, 1.05370341694715d-11,-4.41495859079592d-12,-2.24939051401750d-12, & -8.72229568056267d-13, 1.88613726203286d-12, 1.21711137534390d-14,-1.13342372297867d-12,-6.87151975256052d-13, & 7.99311988544090d-15, 4.46150979586709d-14, 7.50406779454998d-14,-3.20385428942275d-14,-1.26543636054393d-14, & 4.80503817699514d-14,-3.35545623603729d-14,-1.18546423610485d-14, 4.19419209985980d-15,-1.73525614436880d-14, & -1.20464898830163d-15,-8.80752065000456d-16,-1.22214298993313d-15, 1.69928513019657d-15, 1.93593051311405d-16, & 1.68528879784841d-05, 3.57144412031081d-05,-1.65999910125077d-05, 5.40370336805755d-05, 0.0001181381228514d0, & -3.28151779115881d-05, 1.04231790790798d-05,-2.80761862890640d-06, 2.98996152515593d-06,-2.67641158709985d-06, & -2.08664816151978d-06,-1.64463884697475d-06, 6.79099429284834d-08, 7.23955842946495d-07,-6.86378427465657d-07, & -2.88205823027255d-09, 2.38319699493291d-09, 1.14169347509045d-07, 8.12981074994402d-08,-1.56957943666988d-07, & -7.09711403570189d-09, 6.29470515502988d-09, 3.50833306577579d-09, 8.31289199649054d-09,-2.14221463168338d-09, & -8.11910123910038d-10, 3.34047829618955d-10, 3.70619377446490d-10, 3.30426088213373d-10, 4.86297305597865d-11, & 1.98628160424161d-11,-4.98557831380098d-12,-5.90523187802174d-12,-1.27027116925122d-12, 1.49982368570355d-11, & 2.62289263262748d-12, 3.91242360693861d-12, 6.56035499387192d-12,-1.17412941089401d-12,-9.40878197853394d-13, & -3.37805010124487d-13, 5.39454874299593d-13,-2.41569839991525d-13,-2.41572016820792d-13,-3.01983673057198d-13, & -1.85034053857964d-13, 4.31132161871815d-14, 4.13497222026824d-15,-4.60075514595980d-14,-1.92454846400146d-14, & 2.96113888929854d-15,-1.11688534391626d-14, 3.76275373238932d-15,-3.72593295948136d-15, 1.98205490249604d-16, & 1.40074667864629d-15,-5.15564234798333d-16, 3.56287382196512d-16, 5.07242777691587d-16,-2.30405782826134d-17, & 2.96822530176851d-16,-4.77029898301223d-17, 1.12782285532775d-16, 1.58443229778573d-18, 8.22141904662969d-17/ data(bnm_bh_temp(i),i=1,455) & /0, 0, 0, 0, 0, & 0, 0, 0, 0, 0, & -2.29210587053658d-06,-2.33805004374529d-06,-7.49312880102168d-07,-5.12022747852006d-07, 5.88926055066172d-07, & 0, 0, 0, 0, 0, & -4.63382754843690d-06,-2.23853015662938d-06, 8.14830531656518d-07, 1.15453269407116d-06,-4.53555450927571d-07, & -6.92432096320778d-07,-2.98734455136141d-07, 1.48085153955641d-08, 1.37881746148773d-07,-6.92492118460215d-09, & 0, 0, 0, 0, 0, & -1.91507979850310d-06,-1.83614825459598d-06,-7.46807436870647d-07,-1.28329122348007d-06, 5.04937180063059d-07, & -8.07527103916713d-07, 2.83997840574570d-08,-6.01890498063025d-08,-2.48339507554546d-08, 2.46284627824308d-08, & -2.82995069303093d-07, 1.38818274596408d-09, 3.22731214161408d-09, 2.87731153972404d-10, 1.53895537278496d-08, & 0, 0, 0, 0, 0, & -6.68210270956800d-07,-2.19104833297845d-06, 1.30116691657253d-07, 4.78445730433450d-07,-4.40344300914051d-07, & -2.36946755740436d-07,-1.32730991878204d-07, 1.83669593693860d-08, 7.90218931983569d-08,-4.70161979232584d-08, & 1.07746083292179d-07,-4.17088637760330d-09,-1.83296035841109d-09,-5.80243971371211d-09,-2.11682361167439d-09, & -5.44712355496109d-08, 1.89717032256923d-09, 2.27327316287804d-10, 7.78400728280038d-10, 8.82380487618991d-12, & 0, 0, 0, 0, 0, & -5.61707049615673d-08,-1.09066447089585d-06,-2.25742250174119d-07,-8.64367795924377d-07, 1.06411275240680d-08, & 2.41782935157918d-08,-3.65762298303819d-08,-6.93420659586875d-08,-3.97316214341991d-08,-2.08767816486390d-08, & 6.38293030383436d-08, 1.11377936334470d-08, 6.91424941454782d-09, 1.39887159955004d-09, 5.25428749022906d-09, & 1.09291268489958d-08, 1.23935926756516d-10, 3.92917259954515d-10,-1.79144682483562d-10,-9.11802874917597d-10, & -4.40957607823325d-09, 1.45751390560667d-10, 1.24641258165301d-10,-6.45810339804674d-11,-8.92894658893326d-12, & 0, 0, 0, 0, 0, & 1.54754294162102d-08,-1.60154742388847d-06,-4.08425188394881d-07, 6.18170290113531d-09,-2.58919765162122d-07, & 1.37130642286873d-08,-6.67813955828458d-08,-7.01410996605609d-09, 3.82732572660461d-08,-2.73381870915135d-08, & 2.19113155379218d-08, 4.11027496396868d-09, 6.33816020485226d-09,-1.49242411327524d-09,-6.14224941851705d-10, & 6.26573021218961d-09, 5.17137416480052d-10,-3.49784328298676d-10, 1.13578756343208d-10, 2.80414613398411d-10, & 1.65048133258794d-11, 1.00047239417239d-10, 1.05124654878499d-10,-3.03826002621926d-11, 4.57155388334682d-11, & 6.20221691418381d-11, 9.75852610098156d-12,-5.46716005756984d-12, 1.31643349569537d-11, 3.61618775715470d-12, & 0, 0, 0, 0, 0, & -1.03938913012708d-06,-1.78417431315664d-07, 2.86040141364439d-07, 1.83508599345952d-08,-1.34452220464346d-07, & -4.36557481393662d-08, 7.49780206868834d-09,-8.62829428674082d-09, 5.50577793039009d-09,-9.46897502333254d-09, & 3.43193738406672d-10, 1.13545447306468d-08, 1.25242388852214d-09, 6.03221501959620d-10, 1.57172070361180d-09, & -4.73307591021391d-10, 1.70855824051391d-10,-2.62470421477037d-11, 2.04525835988874d-10,-1.17859695928164d-10, & -3.36185995299839d-10, 3.19243054562183d-11, 1.17589412418126d-10,-1.35478747434514d-12, 5.11192214558542d-11, & 3.19640547592136d-11, 2.94297823804643d-12,-1.00651526276990d-11,-1.67028733953153d-12, 3.03938833625503d-12, & 1.68928641118173d-11,-7.90032886682002d-13,-1.40899773539137d-12, 7.76937592393354d-13, 7.32539820298651d-13, & 0, 0, 0, 0, 0, & 2.32949756055277d-07, 1.46237594908093d-07,-1.07770884952484d-07, 1.26824870644476d-07,-2.36345735961108d-08, & 8.89572676497766d-08, 7.24810004121931d-08, 2.67583556180119d-08, 2.48434796111361d-08,-3.55004782858686d-09, & -1.00823909773603d-08, 8.84433929029076d-10,-2.55502517594511d-10,-5.48034274059119d-10,-8.50241938494079d-10, & 1.13259819566467d-09, 5.55186945221216d-10, 7.63679807785295d-11,-1.70067998092043d-11, 1.57081965572493d-10, & -2.37748192185353d-10, 2.45463764948000d-11, 3.23208414802860d-11,-2.72624834520723d-12, 8.14449183666500d-12, & -1.54977633126025d-11, 4.58754903157884d-12,-1.25864665839074d-12, 2.44139868157872d-12,-1.82827441958193d-12, & 3.28285563794513d-12,-1.10072329225465d-12,-7.23470501810935d-13, 5.85309745620389d-13, 4.11317589687125d-13, & 4.57596974384170d-13, 9.84198128213558d-14, 3.34503817702830d-14, 7.08431086558307d-15, 2.79891177268807d-14, & 0, 0, 0, 0, 0, & -3.67820719155580d-07, 6.98497901205902d-07, 1.83397388750300d-07, 2.39730262495372d-07,-2.58441984368194d-07, & 5.17793954077994d-08, 5.54614175977835d-08, 1.75026214305232d-09,-2.55518450411346d-09,-6.12272723006537d-09, & -7.94292648157198d-09,-1.01709107852895d-09,-1.49251241812310d-09, 9.32827213605682d-10,-8.24490722043118d-10, & 1.36410408475679d-11, 2.16390220454971d-10, 1.24934806872235d-10,-6.82507825145903d-11,-4.01575177719668d-11, & -1.41619917600555d-11,-1.54733230409082d-11, 1.36792829351538d-11, 1.11157862104733d-12, 2.08548465892268d-11, & -3.56521723755846d-12, 4.47877185884557d-12,-6.34096209274637d-16,-1.13010624512348d-12,-2.82018136861041d-13, & 2.22758955943441d-12,-4.63876465559380d-13,-5.80688019272507d-13, 2.45878690598655d-13, 1.49997666808106d-13, & -6.26833903786958d-14, 2.73416335780807d-14, 1.91842340758425d-14, 1.67405061129010d-14,-2.45268543953704d-17, & 1.81972870222228d-14, 5.43036245069085d-15, 1.92476637107321d-15, 8.78498602508626d-17,-1.42581647227657d-15, & 0, 0, 0, 0, 0, & 9.74322164613392d-07,-5.23101820582724d-07,-2.81997898176227d-07, 4.54762451707384d-08,-3.34645078118827d-08, & -6.75813194549663d-09, 3.49744702199583d-08,-5.09170419895883d-09, 5.24359476874755d-09, 4.96664262534662d-09, & 4.53858847892396d-10,-1.49347392165963d-09,-2.00939511362154d-09, 9.30987163387955d-10, 9.74450200826854d-11, & -4.92900885858693d-10, 5.34223033225688d-12, 1.08501839729368d-10,-6.43526142089173d-11,-3.11063319142619d-11, & 1.38469246386690d-11,-7.91180584906922d-12, 2.26641656746936d-13, 4.55251515177956d-12, 6.05270575117769d-12, & 4.02247935664225d-12, 1.82776657951829d-12,-1.28348801405445d-13,-2.16257301300350d-13,-5.54363979435025d-14, & 4.15005914461687d-13,-2.00647573581168d-13,-1.67278251942946d-13, 1.30332398257985d-13, 1.52742363652434d-13, & 6.36376500056974d-14, 1.65794532815776d-14,-3.80832559052662d-15,-6.40262894005341d-16, 2.42577181848072d-15, & -5.55273521249151d-15, 3.69725182221479d-15, 2.02114207545759d-15,-4.50870833392161d-16, 9.62950493696677d-17, & 1.00935904205024d-17, 6.54751873609395d-17,-1.09138810997186d-16,-8.62396750098759d-17,-3.82788257844306d-17, & 0, 0, 0, 0, 0, & 4.21958510903678d-07,-8.30678271007705d-08,-3.47006439555247d-07,-3.36442823712421d-08, 9.90739768222027d-08, & 2.64389033612742d-08, 2.65825090066479d-09,-1.28895513428522d-08,-7.07182694980098d-10, 7.10907165301180d-09, & 6.31203524153492d-09,-1.67038260990134d-09, 1.33104703539822d-09, 8.34376495185149d-10,-2.52478613522612d-10, & 1.18414896299279d-10,-2.57745052288455d-11, 2.88295935685818d-11,-3.27782977418354d-11,-1.05705000036156d-11, & -4.20826459055091d-12,-6.97430607432268d-12,-3.90660545970607d-12,-3.90449239948755d-13,-4.60384797517466d-13, & -9.47668356558200d-13, 6.53305025354881d-13, 2.63240185434960d-13, 1.40129115015734d-13, 3.85788887132074d-14, & 2.23947810407291d-13, 7.35262771548253d-15,-3.83348211931292d-14, 4.20376514344176d-14, 4.26445836468461d-14, & -3.88008154470596d-16, 2.28561424667750d-15,-8.73599966653373d-16, 2.14321147947665d-15, 6.38631825071920d-16, & -8.62165565535721d-15, 1.79742912149810d-15, 1.01541125038661d-15,-7.91027655831866d-17,-4.06505132825230d-16, & -2.35355054392189d-16,-6.13997759731013d-17,-2.73490528665965d-17, 2.63895177155121d-17,-4.47531057245187d-18, & 6.01909706823530d-17, 5.35520010856833d-18,-2.15530106132531d-18,-2.46778496746231d-18,-7.09947296442799d-19, & 0, 0, 0, 0, 0, & -3.75005956318736d-07,-5.39872297906819d-07,-1.19929654883034d-07, 4.52771083775007d-08, 1.82790552943564d-07, & 7.82606642505646d-09,-1.68890832383153d-08,-8.45995188378997d-09, 1.42958730598502d-09, 3.21075754133531d-09, & 4.28818421913782d-09,-1.07501469928219d-09, 8.84086350297418d-10, 9.74171228764155d-10, 8.59877149602304d-12, & 1.28983712172521d-10,-6.96375160373676d-11,-2.13481436408896d-11, 1.33516375568179d-11,-1.65864626508258d-11, & -4.48914384622368d-12, 9.68953616831263d-13,-1.61372463422897d-12,-2.09683563440448d-12,-1.90096826314068d-12, & -1.12626619779175d-13, 3.34903159106509d-14,-1.21721528343657d-13, 7.46246339290354d-14, 3.68424909859186d-13, & 5.08294274367790d-14, 2.83036159977090d-14, 1.48074873486387d-14,-9.59633528834945d-15,-1.26231060951100d-14, & -4.01464098583541d-16, 1.97047929526674d-15,-5.29967950447497d-16,-3.59120406619931d-16, 1.69690933982683d-16, & -1.73919209873841d-15, 7.52792462841274d-16, 3.65589287101147d-16,-7.79247612043812d-17,-8.24599670368999d-17, & -4.61555616150128d-17, 4.94529746019753d-19,-1.09858157212270d-17, 3.95550811124928d-18, 3.23972399884100d-18, & -2.27040686655766d-17,-3.27855689001215d-18,-3.30649011116861d-19, 9.08748546536849d-19, 8.92197599890994d-19, & 5.67241944733762d-18, 3.84449400209976d-19, 1.77668058015537d-19, 2.00432838283455d-20,-2.00801461564767d-19/ data(bnm_bw_temp(i),i=1,455) & /0, 0, 0, 0, 0, & 0, 0, 0, 0, 0, & -9.56715196386889d-06,-3.68040633020420d-08, 1.27846786489883d-07, 1.32525487755973d-06, 1.53075361125066d-06, & 0, 0, 0, 0, 0, & -7.17682617983607d-06, 2.89994188119445d-06,-2.97763578173405d-07, 8.95742089134942d-07, 3.44416325304006d-07, & -8.02661132285210d-07, 3.66738692077244d-07,-3.02880965723280d-07, 3.54144282036103d-07,-1.68873066391463d-07, & 0, 0, 0, 0, 0, & -2.89640569283461d-06,-7.83566373343614d-07,-8.36667214682577d-07,-7.41891843549121d-07,-9.23922655636489d-08, & -1.06144662284862d-06, 1.57709930505924d-07, 1.04203025714319d-07, 1.20783300488461d-07,-1.38726055821134d-07, & -4.16549018672265d-07,-1.35220897698872d-07,-6.40269964829901d-08, 1.63258283210837d-08,-2.57958025095959d-08, & 0, 0, 0, 0, 0, & 3.52324885892419d-06,-2.26705543513814d-07, 1.53835589488292d-06,-3.75263061267433d-07, 3.69384057396017d-07, & -2.06569149157664d-07,-9.36260183227175d-08,-3.55985284353048d-08,-9.13671163891094d-08, 6.93156256562600d-09, & 1.32437594740782d-07, 4.44349887272663d-08,-3.38192451721674d-08,-3.97263855781102d-08,-1.93087822995800d-09, & -1.29595244818942d-07,-1.40852985547683d-08, 1.42587592939760d-09, 7.05779876554001d-09,-1.00996269264535d-08, & 0, 0, 0, 0, 0, & 4.06960756215938d-06,-1.97898540226986d-06, 7.21905857553588d-08,-1.19908881538755d-06,-5.67561861536903d-08, & 6.53369660286999d-08,-2.42818687866392d-07,-1.66203004559493d-08,-2.41512414151897d-08, 4.45426333411018d-08, & 1.44650670663281d-07, 8.50666367433859d-09,-4.61165612004307d-09, 4.88527987491045d-09, 1.06277326713172d-08, & 1.86770937103513d-08,-6.44197940288930d-10,-7.60456736846174d-09,-9.97186468682689d-10, 8.73229752697716d-10, & -1.00206566229113d-08, 1.33934372663121d-09, 1.41691503439220d-09, 8.72352590578753d-10,-8.04561626629829d-10, & 0, 0, 0, 0, 0, & 3.07161843116618d-06, 1.82962085656470d-06, 1.87728623016069d-07, 7.10611617623261d-07, 2.26499092250481d-07, & 4.50766403064905d-08,-1.67752393078256d-07, 2.47844723639070d-08,-3.56484348424869d-09,-1.56634836636584d-08, & 3.77011651881090d-08,-7.23045828480496d-09, 5.22995988863761d-09,-1.03740320341306d-09, 4.57839777217789d-09, & 8.09495635883121d-09,-3.01977244420529d-10,-2.30104544933093d-09, 3.63658580939428d-10, 4.39320811714867d-10, & 9.37087629961269d-11, 1.00780920426635d-09, 1.28140539913350d-10,-6.65795285522138d-12, 4.71732796198631d-11, & -8.88504487069155d-11,-1.63253810435461d-10, 7.22669710644299d-11, 5.64715132584527d-11,-1.08949308197617d-12, & 0, 0, 0, 0, 0, & -2.64054293284174d-07,-2.37611606117256d-06,-1.83671059706264d-06,-3.12199354841993d-07,-1.05598289276114d-07, & 7.41706968747147d-08,-1.64359098062646d-08,-3.09750224040234d-08,-9.68640079410317d-09,-7.90399057863403d-08, & -1.00254376564271d-08, 1.12528248631191d-08,-2.67841549174100d-09,-2.69481819323647d-09, 1.56550607475331d-09, & -2.18568129350729d-09, 6.26422056977450d-10, 1.95007291427316d-09, 3.14226463591125d-10,-3.62000388344482d-10, & -9.30451291747549d-10, 5.62175549482704d-11, 1.01022849902012d-10, 5.18675856498499d-11, 5.37561696283235d-11, & 5.33151334468794d-11, 1.07571307336725d-10,-1.31714567944652d-11,-4.17524405900018d-11,-2.16737797893502d-12, & 4.69916869001309d-11,-4.34516364859583d-12,-6.61054225868897d-12,-5.75845818545368d-12,-2.32180293529175d-12, & 0, 0, 0, 0, 0, & -3.50305843086926d-06, 1.76085131953403d-06, 8.16661224478572d-07, 4.09111042640801d-07,-9.85414469804995d-08, & 1.44670876127274d-07,-1.41331228923029d-08,-3.06530152369269d-08,-1.46732098927996d-08,-2.30660839364244d-08, & -2.00043052422933d-08, 1.72145861031776d-09, 2.13714615094209d-09, 1.02982676689194d-09,-1.64945224692217d-10, & 1.23552540016991d-09, 1.42028470911613d-09, 8.79622616627508d-10,-7.44465600265154d-10,-7.17124672589442d-11, & -6.67749524914644d-10,-5.77722874934050d-11, 3.40077806879472d-11, 4.26176076541840d-11, 8.23189659748212d-11, & -4.62771648935992d-11,-7.24005305716782d-13, 1.18233730497485d-12, 5.18156973532267d-12,-1.53329687155297d-12, & 4.75581699468619d-12,-3.79782291469732d-12, 1.33077109836853d-12,-1.02426020107120d-12, 3.10385019249130d-13, & 1.66486090578792d-12, 1.08573672403649d-12, 1.26268044166279d-13,-1.23509297742757d-13,-1.81842007284038d-13, & 0, 0, 0, 0, 0, & 9.93870680202303d-08,-1.85264736035628d-06,-5.58942734710854d-07,-5.54183448316270d-07,-3.95581289689398d-08, & 7.88329069002365d-08, 2.04810091451078d-08, 3.74588851000076d-09, 3.42429296613803d-08,-2.00840228416712d-08, & -5.93700447329696d-10,-6.57499436973459d-10,-6.90560448220751d-09, 3.56586371051089d-09, 7.33310245621566d-11, & -6.38101662363634d-11, 4.23668020216529d-10,-2.43764895979202d-10,-9.31466610703172d-11,-3.17491457845975d-10, & 1.50943725382470d-11,-6.11641188685078d-11,-4.37018785685645d-11,-2.32871158949602d-11, 4.19757251950526d-11, & -1.18165328825853d-11,-9.91299557532438d-13, 6.40908678055865d-14, 2.41049422936434d-12,-8.20746054454953d-14, & 6.01892101914838d-12,-8.78487122873450d-13,-1.58887481332294d-12,-3.13556902469604d-13, 5.14523727801645d-14, & -1.50791729401891d-13,-1.45234807159695d-13, 1.65302377570887d-13,-5.77094211651483d-15, 9.22218953528393d-14, & -1.85618902787381d-14, 5.64333811864051d-14,-9.94311377945570d-15,-2.40992156199999d-15,-2.19196760659665d-14, & 0, 0, 0, 0, 0, & -8.16252352075899d-08, 1.61725487723444d-06, 9.55522506715921d-07, 4.02436267433511d-07,-2.80682052597712d-07, & 7.68684790328630d-09,-5.00940723761353d-09,-2.43640127974386d-08,-2.59119930503129d-08, 3.35015169182094d-08, & 7.97903115186673d-09, 3.73803883416618d-09, 3.27888334636662d-09, 1.37481300578804d-09,-1.10677168734482d-10, & -1.67853012769912d-09,-1.61405252173139d-10,-1.98841576520056d-10,-1.46591506832192d-11, 9.35710487804660d-11, & 4.08807084343221d-11,-3.74514169689568d-11,-3.03638493323910d-11,-5.02332555734577d-12,-8.03417498408344d-12, & 6.48922619024579d-12, 1.96166891023817d-12,-1.96968755122868d-12,-5.20970156382361d-12,-1.62656885103402d-12, & 1.28603518902875d-12,-4.88146958435109d-13,-3.37034886991840d-13, 1.37393696103000d-14, 4.41398325716943d-14, & 1.48670014793021d-13, 4.41636026364555d-14, 2.06210477976005d-14,-3.43717583585390d-14,-1.21693704024213d-14, & -1.67624180330244d-14, 6.59317111144238d-15, 2.57238525440646d-15,-3.21568425020512d-17, 5.29659568026553d-15, & 7.85453466393227d-16, 6.91252183915939d-16,-1.20540764178454d-15,-3.85803892583301d-16, 3.46606994632006d-16, & 0, 0, 0, 0, 0, & 2.86710087625579d-06,-1.68179842305865d-06,-8.48306772016870d-07,-7.08798062479598d-07,-1.27469453733635d-07, & 2.11824305734993d-09, 2.02274279084379d-08, 1.61862253091554d-08, 3.25597167111807d-08, 3.40868964045822d-09, & 1.21757111431438d-08, 1.68405530472906d-09, 1.55379338018638d-09,-3.81467795805531d-10, 2.53316405545058d-09, & -9.98413758659768d-11, 5.38382145421318d-10, 3.92629628330704d-10,-1.43067134097778d-10, 3.74959329667113d-12, & -1.57270407028909d-11,-9.02797202317592d-12, 8.45997059887690d-12, 4.71474382524218d-12, 5.41880986596427d-12, & -1.20658618702054d-12, 7.12940685593433d-13, 1.02148613026937d-12, 1.63063852348169d-13, 1.74048793197708d-13, & 3.80559390991789d-13, 1.19678271353485d-13, 9.72859455604188d-14, 5.42642400031729d-14, 8.18796710714586d-14, & -4.69629218656902d-14, 5.59889038686206d-15, 2.05363292795059d-15, 5.38599403288686d-15,-2.68929559474202d-15, & -1.88759348081742d-14, 5.20975954705924d-15,-4.43585653096395d-16, 5.57436617793556d-16,-3.95922805817677d-16, & -9.80871456373282d-16, 2.50857658461759d-17,-1.24253000050963d-16, 6.00857065211394d-17, 3.53799635311500d-18, & 2.49370713054872d-16,-1.49119714269816d-17,-3.12276052640583d-17,-2.42001662334001d-17,-1.69766504318143d-17, & 0, 0, 0, 0, 0, & -1.69222102455713d-06, 1.64277906173064d-06, 5.28855114364096d-07, 4.28159853268650d-07,-1.57362445882665d-07, & 1.67656782413678d-08,-3.77746114074055d-08,-2.21564555842165d-08,-3.37071806992217d-08, 1.47454008739800d-08, & 1.06080499491408d-08, 3.21990403709678d-09, 3.87301757435359d-09, 2.92241827834347d-10,-1.86619473655742d-11, & 1.62399669665839d-10, 3.51322865845172d-10, 2.67086377702958d-11,-1.31596563625491d-10, 3.14164569507034d-11, & -2.02180016657259d-11, 2.03305178342732d-11, 6.34969032565839d-12, 5.99522296668787d-12,-4.46275273451008d-12, & -9.88409290158885d-13,-1.47692750858224d-13, 3.14655550730530d-13,-2.41857189187879d-13, 4.47727504501486d-13, & 1.71430777754854d-13, 1.73950835042486d-13, 5.92323956541558d-14, 8.06625710171825d-15, 2.33252485755634d-14, & -1.74184545690134d-15,-8.18003353124179d-16,-6.62369006497819d-16, 4.16303374396147d-15, 7.06513748014024d-15, & -6.02936238677014d-15, 1.89241084885229d-15, 1.99097881944270d-17,-6.99974290696640d-16,-2.69504942597709d-17, & -4.65632962602379d-16, 3.70281995445114d-18,-9.04232973763345d-17, 2.20847370761932d-17, 7.62909453726566d-17, & -6.25921477907943d-17,-2.10532795609842d-17,-1.03808073867183d-17, 1.15091380049019d-18, 4.66794445408388d-19, & 9.39427013576903d-18, 9.17044662931859d-19, 2.04132745117549d-18,-1.72364063154625d-19,-1.18098896532163d-18/ data(bnm_ch_temp(i),i=1,455) & /0, 0, 0, 0, 0, & 0, 0, 0, 0, 0, & 3.44092035729033d-05,-1.21876825440561d-05,-1.87490665238967d-05,-2.60980336247863d-05, 4.31639313264615d-06, & 0, 0, 0, 0, 0, & -2.60125613000133d-05, 1.70570295762269d-05, 3.08331896996832d-05, 1.66256596588688d-05,-1.07841055501996d-05, & 8.74011641844073d-06,-2.25874169896607d-06, 6.50985196673747d-07, 1.30424765493752d-06,-1.85081244549542d-07, & 0, 0, 0, 0, 0, & 3.77496505484964d-05,-1.08198973553337d-05,-1.67717574544937d-05,-3.22476096673598d-05, 1.12281888201134d-05, & -7.68623378647958d-07,-4.01400837153063d-06,-2.16390246700835d-06,-1.76912959937924d-06,-1.12740084951955d-06, & -2.37092815818895d-06,-9.52317223759653d-07,-2.22722065579131d-07,-6.25157619772530d-08, 1.86582003894639d-08, & 0, 0, 0, 0, 0, & -6.10254317785872d-05,-2.51815503068494d-05, 2.01046207874667d-05, 7.21107723367308d-06,-1.30692058660457d-05, & -9.60655417241537d-06,-7.31381721742373d-06,-2.52767927589636d-06, 9.09039973214621d-07,-6.76454911344246d-07, & -2.25743206384908d-08, 2.33058746737575d-07, 2.24746779293445d-07, 6.78551351968876d-08, 1.25076011387284d-07, & -2.25744112770133d-07,-1.44429560891636d-07,-2.96810417448652d-08,-5.93858519742856d-08,-2.43210229455420d-08, & 0, 0, 0, 0, 0, & 7.45721015256308d-06,-3.81396821676410d-05,-1.41086198468687d-05,-2.28514517574713d-05, 7.28638705683277d-06, & -5.77517778169692d-06,-3.93061211403839d-06,-2.17369763310752d-06,-1.48060935583664d-07,-2.74200485662814d-07, & 4.52962035878238d-07, 9.80990375495214d-07, 4.67492045269286d-07,-8.31032252212116d-09, 1.69426023427740d-07, & 7.20536791795515d-10, 2.75612253452141d-09, 2.47772119382536d-09, 4.30621825021233d-09,-2.86498479499428d-08, & -2.46253956492716d-08,-3.10300833499669d-09, 8.06559148724445d-09, 2.98197408430123d-10, 6.32503656532846d-09, & 0, 0, 0, 0, 0, & -6.01147094179306d-05,-3.16631758509869d-05, 4.10038115100010d-06, 3.55215057231403d-07,-2.23606515237408d-06, & -2.85937516921923d-06,-3.67775706610630d-06,-5.06445540401637d-07, 8.21776759711184d-07,-5.98690271725558d-07, & 7.77122595418965d-07, 3.60896376754085d-07, 3.88610487893381d-07,-4.39533892679537d-08,-6.26882227849174d-08, & 1.05759993661891d-07, 2.58009912408833d-08,-1.51356049060972d-08,-1.13335813107412d-09, 5.37470857850370d-10, & 7.99831506181984d-09, 1.67423735327465d-09, 2.94736760548677d-09,-1.56727133704788d-09, 8.46186800849124d-10, & 3.07727104043851d-09, 3.93584215798484d-10, 3.86721562770643d-11, 1.72181091277391d-10,-2.16915737920145d-10, & 0, 0, 0, 0, 0, & -1.16335389078126d-05,-1.39864676661484d-05, 2.52546278407717d-06,-8.79152625440188d-06,-8.97665132187974d-06, & -3.95874550504316d-06,-1.17976262528730d-07, 7.03189926369300d-07, 3.38907065351535d-07,-3.67714052493558d-07, & 2.29082449370440d-07, 5.72961531093329d-07, 4.21969662578894d-08, 1.24112958141431d-08, 9.56404486571888d-08, & 1.44631865298671d-09, 6.19368473895584d-09, 1.67110424041236d-09, 2.57979463602951d-09,-6.90806907510366d-09, & 1.77235802019153d-09,-8.14388846228970d-10, 4.50421956523579d-09, 5.67452314909707d-10, 2.47610443675560d-09, & 4.85932343880617d-10, 2.24864117422804d-10,-2.22534534468511d-10,-7.96395824973477d-11, 3.12587399902493d-12, & -3.20173937255409d-11,-1.29872402028088d-11,-4.24092901203818d-11, 2.66570185704416d-11,-5.25164954403909d-12, & 0, 0, 0, 0, 0, & -1.36010179191872d-05, 1.77873053642413d-05, 4.80988546657119d-06, 3.46859608161212d-06,-1.73247520896541d-06, & 2.00020483116258d-06, 2.43393064079673d-06, 1.21478843695862d-06, 1.95582820041644d-07,-3.11847995109088d-07, & -8.13287218979310d-09, 1.05206830238665d-08, 6.54040136224164d-09,-1.96402660575990d-08,-1.40379796070732d-08, & 4.01291020310740d-08, 2.92634301047947d-08, 6.04179709273169d-09, 8.61849065020545d-10, 5.98065429697245d-09, & -1.06149335032911d-09,-4.39748495862323d-10, 8.83040310269353d-10, 3.49392227277679d-10, 8.57722299002622d-10, & -1.25049888909390d-11, 2.05203288281631d-10, 1.37817670505319d-11, 6.82057794430145d-11,-9.41515631694254d-11, & 7.47196022644130d-12,-2.51369898528782d-11,-2.12196687809200d-11, 1.55282119505201d-11, 9.99224438231805d-12, & -7.90534019004874d-13, 3.55824506982589d-12, 8.00835777767281d-13, 8.73460019069655d-13, 1.34176126600106d-12, & 0, 0, 0, 0, 0, & 3.12855262465316d-05, 1.31629386003608d-05, 2.65598119437581d-06, 8.68923340949135d-06,-7.51164082949678d-06, & 1.56870792650533d-06, 1.89227301685370d-06, 4.15620385341985d-07,-2.74253787880603d-07,-4.28826210119200d-07, & -9.99176994565587d-08,-1.10785129426286d-07,-1.10318125091182d-07, 6.22726507350764d-09,-3.39214566386250d-08, & 1.24872975018433d-08, 1.10663206077249d-08, 5.40658975901469d-09,-2.79119137105115d-09,-2.47500096192502d-09, & 1.11518917154060d-10,-4.21965763244849d-10, 3.26786005211229d-10, 1.93488254914545d-10, 7.00774679999972d-10, & 1.50889220040757d-10, 1.03130002661366d-10,-3.09481760816903d-11,-4.47656630703759d-11,-7.36245021803800d-12, & -1.91144562110285d-12,-1.11355583995978d-11,-1.76207323352556d-11, 8.15289793192265d-12, 3.45078925412654d-12, & -2.73248710476019d-12,-1.65089342283056d-13,-2.20125355220819d-13, 5.32589191504356d-13, 5.70008982140874d-13, & 8.06636928368811d-13, 1.30893069976672d-13, 9.72079137767479d-14, 3.87410156264322d-14,-5.56410013263563d-14, & 0, 0, 0, 0, 0, & 2.02454485403216d-05,-9.77720471118669d-06,-4.35467548126223d-06, 2.19599868869063d-06,-3.26670819043690d-06, & -3.21839256310540d-08, 8.38760368015005d-07,-5.08058835724060d-07, 4.16177282491396d-08, 1.53842592762120d-07, & -1.57377633165313d-07,-7.86803586842404d-08,-7.40444711426898d-08, 3.15259864117954d-08, 5.60536231567172d-09, & -3.26080428920229d-10,-3.14576780695439d-09, 8.46796096612981d-10,-2.59329379174262d-09,-8.01054756588382d-10, & -4.58725236153576d-11,-6.87847958546571d-11, 8.18226480126754d-12, 1.81082075625897d-10, 1.74510532938256d-10, & 7.60233505328792d-11, 4.76463939581321d-11,-2.47198455442033d-11,-8.83439688929965d-12, 5.93967446277316d-13, & -8.92919292558887d-12,-4.38524572312029d-12,-4.02709146060896d-12, 4.84344426425295d-12, 5.12869042781520d-12, & 1.91518361809952d-12, 3.06846255371817d-13,-2.44830265306345d-13, 7.86297493099244d-14, 2.72347805801980d-13, & 9.09936624159538d-14, 7.20650818861447d-15, 2.45383991578283d-14,-4.79580974186462d-15, 3.64604724046944d-14, & -4.63611142770709d-14, 1.73908246420636d-15,-4.41651410674801d-15,-6.61409045306922d-16,-1.60016049099639d-15, & 0, 0, 0, 0, 0, & 6.17105245892845d-06,-1.04342983738457d-05,-1.72711741097994d-05,-8.16815967888426d-07, 3.42789959967593d-06, & -2.44014060833825d-07, 2.06991837444652d-07,-3.85805819475679d-07, 1.67162359832166d-08, 4.15139610402483d-07, & 8.18199006804020d-08,-3.20013409049159d-08, 5.94000906771151d-08, 2.24122167188946d-08,-1.33796186160409d-08, & 7.66269294674338d-11,-6.07862178874828d-10, 4.95795757186248d-10,-3.07589245481422d-10, 3.44456287710689d-10, & -1.84076250254929d-10,-1.30985312312781d-10,-1.52547325533276d-10,-2.51000125929512d-11,-1.93924012590455d-11, & -2.93307452197665d-11, 2.88627386757582d-11, 5.58812021182217d-12,-1.68692874069187d-13, 1.80464313900575d-12, & -9.59053874473003d-13, 6.04803122874761d-13,-9.80015608958536d-13, 1.70530372034214d-12, 1.70458664160775d-12, & 2.80169588226043d-13, 9.09573148053551d-14, 2.16449186617004d-14, 1.15550091496353d-13, 4.97772796761321d-14, & -3.04524400761371d-14, 3.42845631349694d-14, 2.44230630602064d-14, 5.76017546103056d-16,-9.74409465961093d-15, & 5.98765340844291d-15,-2.63942474859535d-15,-1.80204805804437d-15,-1.84981819321183d-16,-5.85073392163660d-16, & -2.37069441910133d-15, 2.87429226086856d-16,-1.67055963193389d-16, 2.72110684914090d-18, 8.46646962667892d-17, & 0, 0, 0, 0, 0, & -2.71386164105722d-05,-1.41834938338454d-05,-2.00777928859929d-07, 5.94329804681196d-07, 8.61856994375586d-06, & -3.93656495458664d-08,-6.36432821807576d-07,-2.47887475106438d-07,-2.64906446204966d-08, 1.10689794197004d-07, & 5.25319489188562d-08, 9.00866357158695d-09, 5.00693379572512d-08, 2.47269011056404d-08,-7.27648556194598d-09, & 1.87207107149043d-09,-1.46428282396138d-09,-2.71812237167257d-10, 8.44902265891466d-10,-5.62683870906027d-10, & -1.08295119666184d-10, 4.75553388543793d-11,-5.49429386495686d-11,-6.60907871731611d-11,-5.97347322824822d-11, & -4.95118306815571d-12, 5.31083735234970d-13,-1.93679746327378d-12,-1.61770521840510d-12, 1.23276727202510d-11, & 6.68582682909900d-13, 7.38288575160449d-13, 5.47630483499201d-13,-1.00770258118914d-13,-1.65564928475981d-13, & 5.80963409268471d-14, 6.93474288078737d-14, 6.60728092794315d-15,-5.21029056725202d-15,-1.11283532854883d-16, & -4.10567742688903d-15, 1.62252646805882d-14, 1.00774699865989d-14,-2.44793214897877d-16,-1.59283906414563d-15, & 1.84669506619904d-17, 8.28473337813919d-17,-1.53400662078899d-16,-5.01060672199689d-17,-2.20727935766132d-16, & 2.65355116203636d-16,-3.70233146147684d-17, 3.52689394451586d-18,-8.62215942516328d-18, 9.26909361974526d-18, & 9.94266950643135d-17, 4.17028699663441d-18,-7.65153491125819d-21,-5.62131270981041d-18,-3.03732817297438d-18/ data(bnm_cw_temp(i),i=1,455) & /0, 0, 0, 0, 0, & 0, 0, 0, 0, 0, & -0.0002091048729126d0,-1.41530274973540d-05, 3.00318745764815d-05,-1.82864291318284d-05,-7.62965409959238d-06, & 0, 0, 0, 0, 0, & -0.0001863365199003d0, 0.0001912565539356d0, 7.28356195304996d-05, 3.59637869639906d-05,-2.53927226167388d-05, & 0.0001081953437995d0,-6.97050977217619d-05,-6.68037133871099d-05, 2.30387653190503d-05,-1.22735483925784d-05, & 0, 0, 0, 0, 0, & 0.0001199410912770d0,-7.70547844186875d-05,-8.15376297964528d-05, 1.06005789545203d-05, 2.31177232268720d-05, & -1.77494760217164d-05,-1.37061385686605d-05,-1.74805936475816d-05,-6.91745900867532d-07,-7.10231790947787d-06, & -1.47564103733219d-05, 2.08890785485260d-06, 3.19876879447867d-06, 9.43984664503715d-07,-4.90480527577521d-06, & 0, 0, 0, 0, 0, & 4.93300138389457d-05,-6.77641298460617d-05,-3.25043347246397d-05, 8.33226714911921d-06, 8.11499972792905d-06, & -2.80449863471272d-05,-1.04367606414606d-05, 1.64473584641163d-07,-3.57420965807816d-06, 2.95887156564038d-06, & 1.88835280111533d-06, 5.69125761193702d-07,-2.22757382799409d-06,-1.96699131032252d-07,-2.91861219283659d-07, & -4.69918971436680d-06,-7.00778948636735d-07, 2.97544157334673d-09, 3.86100512544410d-07, 2.30939653701027d-07, & 0, 0, 0, 0, 0, & 1.77050610394149d-05,-3.18353071311574d-05, 3.04232260950316d-05,-6.26821316488169d-05,-1.75094810002378d-06, & 9.25605901565775d-06,-8.25179123302247d-06, 6.74032752408358d-06, 3.22192289084524d-06, 6.09414500075259d-06, & 4.28233825242200d-06, 2.10470570087927d-07,-4.75050074985668d-07,-4.89382663470592d-07, 8.75232347469207d-07, & 8.50393520366934d-07, 1.58764911467186d-07,-2.16267638321210d-07,-7.43341300487416d-10, 1.75131729813230d-07, & -2.87064111623119d-07, 4.50393893102830d-08, 6.63315044416690d-08, 7.61199387418853d-08,-6.05694385243652d-09, & 0, 0, 0, 0, 0, & -1.95692079507947d-05, 5.15486098887851d-05, 3.00852761598173d-05, 1.21485028343416d-05,-6.72450521493428d-06, & 5.34496867088158d-06, 3.90973451680699d-06, 3.70148924718425d-06, 5.73731499938212d-08, 5.52258220288780d-07, & 3.39950838185315d-07,-5.63443976772634d-07, 4.52082211980595d-07,-2.57094645806243d-07,-6.84885762924729d-08, & 2.15793276880684d-07, 2.05911354090873d-07, 1.33747872341142d-08,-2.07997626478952d-08,-3.69812938736019d-08, & 2.11952749403224d-09, 4.04317822544732d-08, 2.40972024883650d-09, 8.56289126938059d-09, 2.31035283490200d-08, & -2.08402298813248d-09,-8.50243600879112d-09, 2.60895410117768d-09,-6.69156841738591d-10,-5.16280278087006d-09, & 0, 0, 0, 0, 0, & 0.0001249012914367d0,-5.70770326719086d-05,-8.44887248105015d-05,-3.11442665354698d-05,-1.12982893252046d-05, & -8.38934444233944d-06, 1.56860091415414d-06,-1.77704563531825d-06,-5.70219068898717d-08,-4.30377735031244d-06, & 3.72965318017681d-07, 6.98175439446187d-07, 1.75760544807919d-08, 1.59731284857151d-07, 3.62363848767891d-07, & -2.32148850787091d-07,-4.21888751852973d-08, 8.35926113952108d-08,-2.24572480575674d-08,-6.92114100904503d-08, & -2.92635642210745d-09, 3.38086229163415d-09, 4.72186694662901d-09,-8.32354437305758d-11, 4.19673890995627d-09, & -1.26452887692900d-09, 1.91309690886864d-09, 1.54755631983655d-09,-1.09865169400249d-09, 1.83645326319994d-10, & 9.92539437011905d-10,-2.96318203488300d-10, 1.17466020823486d-10,-5.00185957995526d-10,-8.54777591408537d-11, & 0, 0, 0, 0, 0, & -0.0001828853354049d0, 7.27424724520089d-05, 3.05286278023427d-05, 2.55324463432562d-05,-6.39859510763234d-06, & -5.21449265232557d-06,-6.70572386081398d-06,-3.95473351292738d-06,-6.41023334372861d-07,-3.11616331059009d-06, & 2.37090789071727d-07, 3.58427517014705d-07, 2.55709192777007d-07, 8.44593804408541d-08, 9.27243162355359d-09, & 7.24370898432057d-08,-7.43945120337710d-09, 8.61751911975683d-10,-2.34651212610623d-08, 2.94052921681456d-09, & -1.22127317934425d-08,-3.89758984276768d-09, 4.12890383904924d-11, 2.06528068002723d-09, 1.73488696972270d-09, & -5.44137406907620d-10,-4.81034553189921d-10,-2.56101759039694d-11, 3.21880564410154d-10,-2.70195343165250d-11, & 1.08394225300546d-10,-7.99525492688661d-11, 1.73850287030654d-10,-8.06390014426271d-11,-7.63143364291160d-13, & -3.41446959267441d-11, 2.72675729042792d-11, 5.69674704865345d-12,-3.38402998344892d-12,-2.96732381931007d-12, & 0, 0, 0, 0, 0, & 2.91161315987250d-05,-7.24641166590735d-05,-8.58323519857884d-06,-1.14037444255820d-05, 1.32244819451517d-05, & 1.24266748259826d-06,-4.13127038469802d-06,-8.47496394492885d-07, 5.48722958754267d-07,-1.98288551821205d-06, & -1.70671245196917d-08, 1.36891127083540d-08,-2.80901972249870d-07,-5.45369793946222d-09,-9.58796303763498d-08, & 1.14115335901746d-08, 2.79308166429178d-08,-1.71144803132413d-08, 4.86116243565380d-09,-8.13061459952280d-09, & -1.19144311035824d-09,-1.28197815211763d-09,-1.22313592972373d-09, 6.23116336753674d-10, 2.11527825898689d-09, & 4.94618645030426d-10,-1.01554483531252d-10,-3.58808808952276d-10, 1.23499783028794d-10,-1.21017599361833d-10, & 1.33959569836451d-10,-1.87140898812283d-11,-3.04265350158941d-11,-1.42907553051431d-11,-1.09873858099638d-11, & 1.30277419203512d-11,-4.95312627777245d-12, 2.23070215544358d-12, 1.66450226016423d-12, 6.26222944728474d-12, & -4.40721204874728d-12, 2.99575133064885d-12,-1.54917262009097d-12, 8.90015664527060d-14,-1.59135267012937d-12, & 0, 0, 0, 0, 0, & -4.17667211323160d-05, 1.39005215116294d-05, 1.46521361817829d-05, 3.23485458024416d-05,-8.57936261085263d-06, & 9.48491026524450d-07, 1.67749735481991d-06, 6.80159475477603d-07,-1.34558044496631d-06, 1.62108231492249d-06, & -2.67545753355631d-07,-3.31848493018159d-08, 1.05837219557465d-07, 1.55587655479400d-07,-2.84996014386667d-08, & -5.15113778734878d-08, 8.83630725241303d-09, 3.36579455982772d-09,-6.22350102096402d-09, 5.03959133095369d-09, & 2.04635880823035d-11,-1.07923589059151d-09,-6.96482137669712d-10,-4.70238500452793d-10,-6.60277903598297d-10, & -2.41897168749189d-11, 1.33547763615216d-10,-5.13534673658908d-11,-8.32767177662817d-11, 5.72614717082428d-11, & 7.55170562359940d-12,-1.57123461699055d-11,-1.48874069619124d-11,-7.10529462981252d-13,-7.99006335025107d-12, & 2.41883156738960d-12, 2.97346980183361d-12, 1.28719977731450d-12,-2.49240876894143d-12, 6.71155595793198d-13, & 4.16995565336914d-13,-1.71584521275288d-13,-7.23064067359978d-14, 2.45405880599037d-13, 4.43532934905830d-13, & 3.56937508828997d-14, 2.43012511260300d-14,-7.96090778289326d-14,-1.59548529636358d-14, 8.99103763000507d-15, & 0, 0, 0, 0, 0, & 0.0001175792583995d0,-4.52648448635772d-05,-2.69130037097862d-05,-3.82266335794366d-05,-4.36549257701084d-06, & -1.43270371215502d-06, 1.21565440183855d-06, 8.53701136074284d-07, 1.52709810023665d-06, 1.22382663462904d-06, & 3.06089147519664d-07, 9.79084123751975d-08, 7.96524661441178d-08, 4.54770947973458d-08, 2.22842369458882d-07, & -9.94254707745127d-09, 1.43251376378012d-08, 1.93911753685160d-08,-6.52214645690987d-09,-1.97114016452408d-09, & -9.20751919828404d-10,-9.44312829629076d-10, 7.24196738163952d-11,-6.71801072324561d-11, 2.33146774065873d-10, & -1.43544298956410d-11, 1.78464235318769d-10, 7.69950023012326d-11,-4.22390057304453d-12, 3.05176324574816d-11, & -7.88053753973990d-12,-3.20207793051003d-12, 1.01527407317625d-12, 6.02788185858449d-12, 1.14919530900453d-11, & -1.21558899266069d-12, 5.31300597882986d-13, 3.44023865079264d-13,-6.22598216726224d-14,-5.47031650765402d-14, & -4.15627948750943d-13, 2.77620907292721d-13,-8.99784134364011d-14, 1.07254247320864d-13, 6.85990080564196d-14, & -3.91837863922901d-14, 9.74714976816180d-15, 6.79982450963903d-15,-2.41420876658572d-15,-2.20889384455344d-15, & 9.25912068402776d-15,-4.02621719248224d-15,-2.43952036351187d-15,-1.97006876049866d-15, 1.03065621527869d-16, & 0, 0, 0, 0, 0, & -0.0001037620369402d0, 4.38145356960292d-05, 2.43406920349913d-05, 7.89103527673736d-06,-1.66841465339160d-05, & -1.18428449371744d-06,-1.30188721737259d-06,-1.88013557116650d-06,-1.01342046295303d-06, 9.21813037802502d-07, & 1.51836068712460d-07, 1.11362553803933d-07, 1.55375052233052d-07, 1.94450910788747d-09,-1.73093755828342d-08, & -3.77758211813121d-09, 1.23323969583610d-08, 1.72510045250302d-09,-1.88609789458597d-09, 1.28937597985937d-09, & -1.07947760393523d-09, 5.26051570105365d-10,-3.67657536332496d-11, 3.16110123523840d-10,-3.24273198242170d-10, & -2.00385649209820d-12, 2.54703869682390d-11, 4.08563622440851d-12,-4.83350348928636d-11,-3.98153443845079d-13, & 2.73094467727215d-12, 5.08900664114903d-12,-7.66669089075134d-13, 2.50015592643012d-12, 4.29763262853853d-12, & 6.53946487537890d-13,-2.24958413781008d-13, 6.74638861781238d-15, 3.28537647613903d-14, 2.54199700290116d-13, & -1.09122051193505d-13, 8.36362392931501d-14,-3.90750153912300d-14,-5.44915910741950d-14, 2.43816947219217d-14, & -1.41882561550134d-14, 1.00455397812713d-14, 2.63347255121581d-15, 1.53043256823601d-15, 2.49081021428095d-15, & -1.17256193152654d-15, 1.05648985031971d-16, 1.31778372453016d-16, 1.44815198666577d-16,-3.72532768618480d-16, & 2.66203457773766d-16,-7.67224608659658d-17, 3.51487351031864d-18, 4.10287131339291d-17,-6.72171711728514d-17/ ! reshape the arrays to matrices anm_bh = transpose(reshape(anm_bh_temp,(/5,91/))) anm_bw = transpose(reshape(anm_bw_temp,(/5,91/))) anm_ch = transpose(reshape(anm_ch_temp,(/5,91/))) anm_cw = transpose(reshape(anm_cw_temp,(/5,91/))) bnm_bh = transpose(reshape(bnm_bh_temp,(/5,91/))) bnm_bw = transpose(reshape(bnm_bw_temp,(/5,91/))) bnm_ch = transpose(reshape(bnm_ch_temp,(/5,91/))) bnm_cw = transpose(reshape(bnm_cw_temp,(/5,91/))) ! read the respective lines from the matrix anm_bh_A0 = anm_bh(:,1) anm_bh_A1 = anm_bh(:,2) anm_bh_B1 = anm_bh(:,3) anm_bh_A2 = anm_bh(:,4) anm_bh_B2 = anm_bh(:,5) anm_bw_A0 = anm_bw(:,1) anm_bw_A1 = anm_bw(:,2) anm_bw_B1 = anm_bw(:,3) anm_bw_A2 = anm_bw(:,4) anm_bw_B2 = anm_bw(:,5) anm_ch_A0 = anm_ch(:,1) anm_ch_A1 = anm_ch(:,2) anm_ch_B1 = anm_ch(:,3) anm_ch_A2 = anm_ch(:,4) anm_ch_B2 = anm_ch(:,5) anm_cw_A0 = anm_cw(:,1) anm_cw_A1 = anm_cw(:,2) anm_cw_B1 = anm_cw(:,3) anm_cw_A2 = anm_cw(:,4) anm_cw_B2 = anm_cw(:,5) bnm_bh_A0 = bnm_bh(:,1) bnm_bh_A1 = bnm_bh(:,2) bnm_bh_B1 = bnm_bh(:,3) bnm_bh_A2 = bnm_bh(:,4) bnm_bh_B2 = bnm_bh(:,5) bnm_bw_A0 = bnm_bw(:,1) bnm_bw_A1 = bnm_bw(:,2) bnm_bw_B1 = bnm_bw(:,3) bnm_bw_A2 = bnm_bw(:,4) bnm_bw_B2 = bnm_bw(:,5) bnm_ch_A0 = bnm_ch(:,1) bnm_ch_A1 = bnm_ch(:,2) bnm_ch_B1 = bnm_ch(:,3) bnm_ch_A2 = bnm_ch(:,4) bnm_ch_B2 = bnm_ch(:,5) bnm_cw_A0 = bnm_cw(:,1) bnm_cw_A1 = bnm_cw(:,2) bnm_cw_B1 = bnm_cw(:,3) bnm_cw_A2 = bnm_cw(:,4) bnm_cw_B2 = bnm_cw(:,5) ! calculate legendre polynomials ! polar coordinates x = sin(polDist_red)*cos(lon_red) y = sin(polDist_red)*sin(lon_red) z = cos(polDist_red) ! do this for all 4 surrounding grid points do i_grid = 1,4 ! Legendre polynomials V(1,1) = 1 W(1,1) = 0 V(2,1) = z(i_grid) * V(1,1) W(2,1) = 0 do n = 2,nmax V(n+1,1) = ((2*n-1) * z(i_grid) * V(n,1) - (n-1) * V(n-1,1)) / n W(n+1,1) = 0 end do do m = 1,nmax V(m+1,m+1) = (2*m-1) * (x(i_grid)*V(m,m) - y(i_grid)*W(m,m)) W(m+1,m+1) = (2*m-1) * (x(i_grid)*W(m,m) + y(i_grid)*V(m,m)) if (m < nmax) then V(m+2,m+1) = (2*m+1) * z(i_grid) * V(m+1,m+1) W(m+2,m+1) = (2*m+1) * z(i_grid) * W(m+1,m+1) end if do n = m+2,nmax V(n+1,m+1) = ((2*n-1)*z(i_grid)*V(n,m+1) - (n+m-1)*V(n-1,m+1)) / (n-m) W(n+1,m+1) = ((2*n-1)*z(i_grid)*W(n,m+1) - (n+m-1)*W(n-1,m+1)) / (n-m) end do end do ! determine the coefficients ! initialize bh_A0 = 0 bh_A1 = 0 bh_B1 = 0 bh_A2 = 0 bh_B2 = 0 bw_A0 = 0 bw_A1 = 0 bw_B1 = 0 bw_A2 = 0 bw_B2 = 0 ch_A0 = 0 ch_A1 = 0 ch_B1 = 0 ch_A2 = 0 ch_B2 = 0 cw_A0 = 0 cw_A1 = 0 cw_B1 = 0 cw_A2 = 0 cw_B2 = 0 i = 0 do n = 0,nmax do m = 0,n i = i+1 bh_A0 = bh_A0 + (anm_bh_A0(i)*V(n+1,m+1) + bnm_bh_A0(i)*W(n+1,m+1)) bh_A1 = bh_A1 + (anm_bh_A1(i)*V(n+1,m+1) + bnm_bh_A1(i)*W(n+1,m+1)) bh_B1 = bh_B1 + (anm_bh_B1(i)*V(n+1,m+1) + bnm_bh_B1(i)*W(n+1,m+1)) bh_A2 = bh_A2 + (anm_bh_A2(i)*V(n+1,m+1) + bnm_bh_A2(i)*W(n+1,m+1)) bh_B2 = bh_B2 + (anm_bh_B2(i)*V(n+1,m+1) + bnm_bh_B2(i)*W(n+1,m+1)) bw_A0 = bw_A0 + (anm_bw_A0(i)*V(n+1,m+1) + bnm_bw_A0(i)*W(n+1,m+1)) bw_A1 = bw_A1 + (anm_bw_A1(i)*V(n+1,m+1) + bnm_bw_A1(i)*W(n+1,m+1)) bw_B1 = bw_B1 + (anm_bw_B1(i)*V(n+1,m+1) + bnm_bw_B1(i)*W(n+1,m+1)) bw_A2 = bw_A2 + (anm_bw_A2(i)*V(n+1,m+1) + bnm_bw_A2(i)*W(n+1,m+1)) bw_B2 = bw_B2 + (anm_bw_B2(i)*V(n+1,m+1) + bnm_bw_B2(i)*W(n+1,m+1)) ch_A0 = ch_A0 + (anm_ch_A0(i)*V(n+1,m+1) + bnm_ch_A0(i)*W(n+1,m+1)) ch_A1 = ch_A1 + (anm_ch_A1(i)*V(n+1,m+1) + bnm_ch_A1(i)*W(n+1,m+1)) ch_B1 = ch_B1 + (anm_ch_B1(i)*V(n+1,m+1) + bnm_ch_B1(i)*W(n+1,m+1)) ch_A2 = ch_A2 + (anm_ch_A2(i)*V(n+1,m+1) + bnm_ch_A2(i)*W(n+1,m+1)) ch_B2 = ch_B2 + (anm_ch_B2(i)*V(n+1,m+1) + bnm_ch_B2(i)*W(n+1,m+1)) cw_A0 = cw_A0 + (anm_cw_A0(i)*V(n+1,m+1) + bnm_cw_A0(i)*W(n+1,m+1)) cw_A1 = cw_A1 + (anm_cw_A1(i)*V(n+1,m+1) + bnm_cw_A1(i)*W(n+1,m+1)) cw_B1 = cw_B1 + (anm_cw_B1(i)*V(n+1,m+1) + bnm_cw_B1(i)*W(n+1,m+1)) cw_A2 = cw_A2 + (anm_cw_A2(i)*V(n+1,m+1) + bnm_cw_A2(i)*W(n+1,m+1)) cw_B2 = cw_B2 + (anm_cw_B2(i)*V(n+1,m+1) + bnm_cw_B2(i)*W(n+1,m+1)) end do end do ! determine the exact empirical values for the coefficients bh(i_grid) = bh_A0 + bh_A1*cos(doy/365.25d0*2*pi) + bh_B1*sin(doy/365.25d0*2*pi) + & bh_A2*cos(doy/365.25d0*4*pi) + bh_B2*sin(doy/365.25d0*4*pi) bw(i_grid) = bw_A0 + bw_A1*cos(doy/365.25d0*2*pi) + bw_B1*sin(doy/365.25d0*2*pi) + & bw_A2*cos(doy/365.25d0*4*pi) + bw_B2*sin(doy/365.25d0*4*pi) ch(i_grid) = ch_A0 + ch_A1*cos(doy/365.25d0*2*pi) + ch_B1*sin(doy/365.25d0*2*pi) + & ch_A2*cos(doy/365.25d0*4*pi) + ch_B2*sin(doy/365.25d0*4*pi) cw(i_grid) = cw_A0 + cw_A1*cos(doy/365.25d0*2*pi) + cw_B1*sin(doy/365.25d0*2*pi) + & cw_A2*cos(doy/365.25d0*4*pi) + cw_B2*sin(doy/365.25d0*4*pi) end do ! read the a coefficients ah = VMF3_data_int_h0(:,3) aw = VMF3_data_int_h0(:,4) ! calculating the hydrostatic and wet mapping function VMF3_data_int_h1(:,8) = (1+(ah/(1+bh/(1+ch)))) / (sin(el)+(ah/(sin(el)+bh/(sin(el)+ch)))) VMF3_data_int_h1(:,9) = (1+(aw/(1+bw/(1+cw)))) / (sin(el)+(aw/(sin(el)+bw/(sin(el)+cw)))) ! height correction for the hydrostatic part [Niell, 1996] a_ht = 2.53d-5 b_ht = 5.49d-3 c_ht = 1.14d-3 ht_corr_coef = 1/sin(el) - (1+(a_ht/(1+b_ht/(1+c_ht)))) / (sin(el)+(a_ht/(sin(el)+b_ht/(sin(el)+c_ht)))) ht_corr = ht_corr_coef * h_ell/1000 VMF3_data_int_h1(:,8) = VMF3_data_int_h1(:,8) + ht_corr !---------------------------------------------------------------------- ! (6) perform the bilinear interpolation !---------------------------------------------------------------------- if ( index_p(1)==index_p(2) .AND. index_p(2)==index_p(3) .AND. index_p(3)==index_p(4) ) then ! if the point is directly on a grid point zhd = VMF3_data_int_h1(1,5) zwd = VMF3_data_int_h1(1,6) mfh = VMF3_data_int_h1(1,8) mfw = VMF3_data_int_h1(1,9) else ! bilinear interpolation (interpreted as two 1D linear interpolations for lat and lon, but programmed without subfunctions) ! (a) linear interpolation for longitude if (VMF3_data_int_h1(1,2) /= VMF3_data_int_h1(2,2)) then ! if longitude must be interpolated zhd_lon1 = VMF3_data_int_h1(1,5) + (VMF3_data_int_h1(2,5)-VMF3_data_int_h1(1,5))*(lon_deg-VMF3_data_int_h1(1,2))/(VMF3_data_int_h1(2,2)-VMF3_data_int_h1(1,2)) zhd_lon2 = VMF3_data_int_h1(3,5) + (VMF3_data_int_h1(4,5)-VMF3_data_int_h1(3,5))*(lon_deg-VMF3_data_int_h1(3,2))/(VMF3_data_int_h1(4,2)-VMF3_data_int_h1(3,2)) zwd_lon1 = VMF3_data_int_h1(1,6) + (VMF3_data_int_h1(2,6)-VMF3_data_int_h1(1,6))*(lon_deg-VMF3_data_int_h1(1,2))/(VMF3_data_int_h1(2,2)-VMF3_data_int_h1(1,2)) zwd_lon2 = VMF3_data_int_h1(3,6) + (VMF3_data_int_h1(4,6)-VMF3_data_int_h1(3,6))*(lon_deg-VMF3_data_int_h1(3,2))/(VMF3_data_int_h1(4,2)-VMF3_data_int_h1(3,2)) mfh_lon1 = VMF3_data_int_h1(1,8) + (VMF3_data_int_h1(2,8)-VMF3_data_int_h1(1,8))*(lon_deg-VMF3_data_int_h1(1,2))/(VMF3_data_int_h1(2,2)-VMF3_data_int_h1(1,2)) mfh_lon2 = VMF3_data_int_h1(3,8) + (VMF3_data_int_h1(4,8)-VMF3_data_int_h1(3,8))*(lon_deg-VMF3_data_int_h1(3,2))/(VMF3_data_int_h1(4,2)-VMF3_data_int_h1(3,2)) mfw_lon1 = VMF3_data_int_h1(1,9) + (VMF3_data_int_h1(2,9)-VMF3_data_int_h1(1,9))*(lon_deg-VMF3_data_int_h1(1,2))/(VMF3_data_int_h1(2,2)-VMF3_data_int_h1(1,2)) mfw_lon2 = VMF3_data_int_h1(3,9) + (VMF3_data_int_h1(4,9)-VMF3_data_int_h1(3,9))*(lon_deg-VMF3_data_int_h1(3,2))/(VMF3_data_int_h1(4,2)-VMF3_data_int_h1(3,2)) else ! if the station coincides with the longitude of the grid zhd_lon1 = VMF3_data_int_h1(1,5) zhd_lon2 = VMF3_data_int_h1(3,5) zwd_lon1 = VMF3_data_int_h1(1,6) zwd_lon2 = VMF3_data_int_h1(3,6) mfh_lon1 = VMF3_data_int_h1(1,8) mfh_lon2 = VMF3_data_int_h1(3,8) mfw_lon1 = VMF3_data_int_h1(1,9) mfw_lon2 = VMF3_data_int_h1(3,9) end if ! linear interpolation for latitude if (VMF3_data_int_h1(1,1) /= VMF3_data_int_h1(3,1)) then zhd = zhd_lon1 + (zhd_lon2-zhd_lon1)*(lat_deg-VMF3_data_int_h1(1,1))/(VMF3_data_int_h1(3,1)-VMF3_data_int_h1(1,1)) zwd = zwd_lon1 + (zwd_lon2-zwd_lon1)*(lat_deg-VMF3_data_int_h1(1,1))/(VMF3_data_int_h1(3,1)-VMF3_data_int_h1(1,1)) mfh = mfh_lon1 + (mfh_lon2-mfh_lon1)*(lat_deg-VMF3_data_int_h1(1,1))/(VMF3_data_int_h1(3,1)-VMF3_data_int_h1(1,1)) mfw = mfw_lon1 + (mfw_lon2-mfw_lon1)*(lat_deg-VMF3_data_int_h1(1,1))/(VMF3_data_int_h1(3,1)-VMF3_data_int_h1(1,1)) else ! if the station coincides with the latitude of the grid zhd = zhd_lon1 zwd = zwd_lon1 mfh = mfh_lon1 mfw = mfw_lon1 end if end if end subroutine