New URL for NEMO forge!   http://forge.nemo-ocean.eu

Since March 2022 along with NEMO 4.2 release, the code development moved to a self-hosted GitLab.
This present forge is now archived and remained online for history.
Changeset 11182 – NEMO

Changeset 11182


Ignore:
Timestamp:
2019-06-26T12:08:17+02:00 (5 years ago)
Author:
laurent
Message:

LB: adding possibility to use dew-point temperature rather than specific humidity as "air humidity" => ln_humi_dpt@namsbc_blk

Location:
NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC
Files:
5 edited
1 moved

Legend:

Unmodified
Added
Removed
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbc_oce.F90

    r11111 r11182  
    114114   !! wndm is used onmpute surface gases exchanges in ice-free ocean or leads 
    115115   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:) ::   wndm              !: wind speed module at T-point (=|U10m-Uoce|)  [m/s] 
     116   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:) ::   rhoa              !: air density at "rn_zu" m above the sea       [kg/m3] !LB 
    116117   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:) ::   qsr               !: sea heat flux:     solar                     [W/m2] 
    117118   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:) ::   qns    , qns_b    !: sea heat flux: non solar                     [W/m2] 
     
    173174      ! 
    174175      ALLOCATE( utau(jpi,jpj) , utau_b(jpi,jpj) , taum(jpi,jpj) ,     & 
    175          &      vtau(jpi,jpj) , vtau_b(jpi,jpj) , wndm(jpi,jpj) , STAT=ierr(1) )  
     176         &      vtau(jpi,jpj) , vtau_b(jpi,jpj) , wndm(jpi,jpj) , rhoa(jpi,jpj) , STAT=ierr(1) )  
    176177         ! 
    177178      ALLOCATE( qns_tot(jpi,jpj) , qns  (jpi,jpj) , qns_b(jpi,jpj),        & 
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbcblk.F90

    r11111 r11182  
    5656   USE prtctl         ! Print control 
    5757 
    58    USE sbcblk_phymbl  !LB: all thermodynamics functions, rho_air, q_sat, etc... 
     58   USE sbcblk_phy     !LB: all thermodynamics functions in the marine boundary layer, rho_air, q_sat, etc... 
    5959 
    6060    
     
    109109   !LB: 
    110110   LOGICAL  ::   ln_skin        ! use the cool-skin / warm-layer parameterization (only available in ECMWF and COARE algorithms) !LB 
    111    !LB: => sbc_oce.F90: REAL(wp), ALLOCATABLE, SAVE, DIMENSION(:,:) ::   tsk                       ! sea-surface skin temperature out of the cool-skin/warm-layer parameterization [Celsius] 
     111   LOGICAL  ::   ln_humi_dpt    ! humidity read in files ("sn_humi") is dew-point temperature if .true. (specific humidity espected if .false.) !LB 
    112112   !LB. 
    113113    
     
    175175         &                 cn_dir , ln_taudif, rn_zqt, rn_zu,                         &  
    176176         &                 rn_pfac, rn_efac, rn_vfac, ln_Cd_L12, ln_Cd_L15,           & 
    177          &                 ln_skin                                                        ! cool-skin / warm-layer param. !LB 
     177         &                 ln_skin, ln_humi_dpt                                                        ! cool-skin / warm-layer param. !LB 
    178178      !!--------------------------------------------------------------------- 
    179179      ! 
     
    292292         WRITE(numout,*) 
    293293         WRITE(numout,*) '      use cool-skin/warm-layer parameterization (SSST)     ln_skin     = ', ln_skin !LB 
     294         WRITE(numout,*) 
     295         WRITE(numout,*) '      air humidity read in files is dew-point temperature? ln_humi_dpt = ', ln_humi_dpt !LB 
    294296         ! 
    295297      ENDIF 
     
    346348         ENDIF  
    347349         tatm_ice(:,:)    = sf(jp_tair)%fnow(:,:,1) 
    348          qatm_ice(:,:)    = sf(jp_humi)%fnow(:,:,1) 
     350         !LB: 
     351         IF ( ln_humi_dpt ) THEN 
     352            qatm_ice(:,:) = q_sat( sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1) ) 
     353         ELSE 
     354            qatm_ice(:,:) = sf(jp_humi)%fnow(:,:,1) 
     355         END IF 
     356         !LB. 
    349357         tprecip(:,:)     = sf(jp_prec)%fnow(:,:,1) * rn_pfac 
    350358         sprecip(:,:)     = sf(jp_snow)%fnow(:,:,1) * rn_pfac 
     
    386394      REAL(wp) ::   zztmp                ! local variable 
    387395      REAL(wp), DIMENSION(jpi,jpj) ::   zwnd_i, zwnd_j    ! wind speed components at T-point 
    388       REAL(wp), DIMENSION(jpi,jpj) ::   zsq               ! specific humidity at pst 
     396      REAL(wp), DIMENSION(jpi,jpj) ::   zsq               ! specific humidity at pst  [kg/kg] 
    389397      REAL(wp), DIMENSION(jpi,jpj) ::   zqlw, zqsb        ! long wave and sensible heat fluxes 
    390398      REAL(wp), DIMENSION(jpi,jpj) ::   zqla, zevap       ! latent heat fluxes and evaporation 
     
    392400      REAL(wp), DIMENSION(jpi,jpj) ::   zU_zu             ! bulk wind speed at height zu  [m/s] 
    393401      REAL(wp), DIMENSION(jpi,jpj) ::   ztpot             ! potential temperature of air at z=rn_zqt [K] 
    394       REAL(wp), DIMENSION(jpi,jpj) ::   zrhoa             ! density of air   [kg/m^3] 
     402      REAL(wp), DIMENSION(jpi,jpj) ::   zqair             ! specific humidity     of air at z=rn_zqt [kg/kg] !LB 
    395403      !!--------------------------------------------------------------------- 
    396404      ! 
     
    443451      ! ... specific humidity at SST and IST tmask( 
    444452      zsq(:,:) = rdct_qsat_salt * q_sat( zst(:,:), sf(jp_slp)%fnow(:,:,1) ) 
    445       !! 
     453 
     454      !LB: 
     455      ! spec. hum. of air at "rn_zqt" m above thes sea: 
     456      IF ( ln_humi_dpt ) THEN 
     457         ! spec. hum. of air is deduced from dew-point temperature and SLP: q_air = q_sat( d_air, slp) 
     458         IF (lwp) PRINT *, ' *** LB(sbcblk.F90) => computing q_air out of d_air and slp !' 
     459         zqair(:,:) = q_sat( sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1) ) 
     460      ELSE          
     461         zqair(:,:) = sf(jp_humi)%fnow(:,:,1) ! what we read in file is already a spec. humidity! 
     462      END IF 
     463      !LB. 
     464 
    446465      !! Estimate of potential temperature at z=rn_zqt, based on adiabatic lapse-rate 
    447466      !!    (see Josey, Gulev & Yu, 2013) / doi=10.1016/B978-0-12-391851-2.00005-2 
    448467      !!    (since reanalysis products provide T at z, not theta !) 
    449       ztpot = sf(jp_tair)%fnow(:,:,1) + gamma_moist( sf(jp_tair)%fnow(:,:,1), sf(jp_humi)%fnow(:,:,1) ) * rn_zqt 
     468      ztpot = sf(jp_tair)%fnow(:,:,1) + gamma_moist( sf(jp_tair)%fnow(:,:,1), zqair(:,:) ) * rn_zqt 
    450469 
    451470      SELECT CASE( nblk )        !==  transfer coefficients  ==!   Cd, Ch, Ce at T-point 
    452471      ! 
    453       CASE( np_NCAR      )   ;   CALL turb_ncar    ( rn_zqt, rn_zu, zst, ztpot, zsq, sf(jp_humi)%fnow, wndm,   &  ! NCAR-COREv2 
     472      CASE( np_NCAR      )   ;   CALL turb_ncar    ( rn_zqt, rn_zu, zst, ztpot, zsq, zqair, wndm,   &  ! NCAR-COREv2 
    454473         &                                           Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce ) 
    455       CASE( np_COARE_3p0 )   ;   CALL turb_coare   ( rn_zqt, rn_zu, zst, ztpot, zsq, sf(jp_humi)%fnow, wndm,   &  ! COARE v3.0 
     474      CASE( np_COARE_3p0 )   ;   CALL turb_coare   ( rn_zqt, rn_zu, zst, ztpot, zsq, zqair, wndm,   &  ! COARE v3.0 
    456475         &                                           Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce ) 
    457       CASE( np_COARE_3p5 )   ;   CALL turb_coare3p5( rn_zqt, rn_zu, zst, ztpot, zsq, sf(jp_humi)%fnow, wndm,   &  ! COARE v3.5 
     476      CASE( np_COARE_3p5 )   ;   CALL turb_coare3p5( rn_zqt, rn_zu, zst, ztpot, zsq, zqair, wndm,   &  ! COARE v3.5 
    458477         &                                           Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce ) 
    459478 
     
    463482            !IF (lwp) PRINT *, ' *** LB(sbcblk.F90) => calling "turb_ecmwf" WITH CSWL optional arrays!!!' 
    464483            !IF (lwp) PRINT *, ' *** LB(sbcblk.F90) => BEFORE ZST(40:50,30) =', zst(40:50,30) 
    465             CALL turb_ecmwf   ( rn_zqt, rn_zu, zst, ztpot, zsq, sf(jp_humi)%fnow, wndm,   &  ! ECMWF          
    466                &                                           Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce, & 
    467                &                                           Qsw=qsr(:,:), rad_lw=sf(jp_qlw)%fnow(:,:,1), slp=sf(jp_slp)%fnow(:,:,1)) 
     484            CALL turb_ecmwf   ( rn_zqt, rn_zu, zst, ztpot, zsq, zqair, wndm,   &  ! ECMWF          
     485               &                Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce, & 
     486               &                Qsw=qsr(:,:), rad_lw=sf(jp_qlw)%fnow(:,:,1), slp=sf(jp_slp)%fnow(:,:,1)) 
    468487            !LB: "zst" and "zsq" have been updated with skin temp. !!! (from bulk SST)... 
    469488            zst(:,:) = zst(:,:)*tmask(:,:,1) 
     
    472491         ELSE 
    473492            IF (lwp) PRINT *, ' *** LB(sbcblk.F90) => calling "turb_ecmwf" WITHOUT CSWL optional arrays!!!' 
    474             CALL turb_ecmwf   ( rn_zqt, rn_zu, zst, ztpot, zsq, sf(jp_humi)%fnow, wndm,   &  ! ECMWF          
     493            CALL turb_ecmwf   ( rn_zqt, rn_zu, zst, ztpot, zsq, zqair, wndm,   &  ! ECMWF          
    475494               &                                           Cd_atm, Ch_atm, Ce_atm, t_zu, q_zu, zU_zu, cdn_oce, chn_oce, cen_oce ) 
    476495         END IF 
     
    487506 
    488507      !                          ! Compute true air density : 
    489       IF( ABS(rn_zu - rn_zqt) > 0.01 ) THEN     ! At zu: (probably useless to remove zrho*grav*rn_zu from SLP...) 
    490          zrhoa(:,:) = rho_air( t_zu(:,:)              , q_zu(:,:)              , sf(jp_slp)%fnow(:,:,1) ) 
     508      IF( ABS(rn_zu - rn_zqt) > 0.01 ) THEN     ! At zu: (probably useless to remove rhoa*grav*rn_zu from SLP...) 
     509         rhoa(:,:) = rho_air( t_zu(:,:)              , q_zu(:,:)              , sf(jp_slp)%fnow(:,:,1) ) 
    491510      ELSE                                      ! At zt: 
    492          zrhoa(:,:) = rho_air( sf(jp_tair)%fnow(:,:,1), sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1) ) 
     511         rhoa(:,:) = rho_air( sf(jp_tair)%fnow(:,:,1), zqair(:,:), sf(jp_slp)%fnow(:,:,1) ) 
    493512      END IF 
    494513 
     
    498517      DO jj = 1, jpj             ! tau module, i and j component 
    499518         DO ji = 1, jpi 
    500             zztmp = zrhoa(ji,jj)  * zU_zu(ji,jj) * Cd_atm(ji,jj)   ! using bulk wind speed 
     519            zztmp = rhoa(ji,jj)  * zU_zu(ji,jj) * Cd_atm(ji,jj)   ! using bulk wind speed 
    501520            taum  (ji,jj) = zztmp * wndm  (ji,jj) 
    502521            zwnd_i(ji,jj) = zztmp * zwnd_i(ji,jj) 
     
    527546 
    528547      ! zqla used as temporary array, for rho*U (common term of bulk formulae): 
    529       zqla(:,:) = zrhoa(:,:) * zU_zu(:,:) * tmask(:,:,1) 
     548      zqla(:,:) = rhoa(:,:) * zU_zu(:,:) * tmask(:,:,1) 
    530549 
    531550      IF( ABS( rn_zu - rn_zqt) < 0.01_wp ) THEN 
    532551         !! q_air and t_air are given at 10m (wind reference height) 
    533          zevap(:,:) = rn_efac*MAX( 0._wp,             zqla(:,:)*Ce_atm(:,:)*(zsq(:,:) - sf(jp_humi)%fnow(:,:,1)) ) ! Evaporation, using bulk wind speed 
    534          zqsb (:,:) = cp_air(sf(jp_humi)%fnow(:,:,1))*zqla(:,:)*Ch_atm(:,:)*(zst(:,:) - ztpot(:,:)             )   ! Sensible Heat, using bulk wind speed 
     552         zevap(:,:) = rn_efac*MAX( 0._wp,             zqla(:,:)*Ce_atm(:,:)*(zsq(:,:) - zqair(:,:)) ) ! Evaporation, using bulk wind speed 
     553         zqsb (:,:) = cp_air(zqair(:,:))*zqla(:,:)*Ch_atm(:,:)*(zst(:,:) - ztpot(:,:)             )   ! Sensible Heat, using bulk wind speed 
    535554      ELSE 
    536555         !! q_air and t_air are not given at 10m (wind reference height) 
    537556         ! Values of temp. and hum. adjusted to height of wind during bulk algorithm iteration must be used!!! 
    538557         zevap(:,:) = rn_efac*MAX( 0._wp,             zqla(:,:)*Ce_atm(:,:)*(zsq(:,:) - q_zu(:,:) ) ) ! Evaporation, using bulk wind speed 
    539          zqsb (:,:) = cp_air(sf(jp_humi)%fnow(:,:,1))*zqla(:,:)*Ch_atm(:,:)*(zst(:,:) - t_zu(:,:) )   ! Sensible Heat, using bulk wind speed 
     558         zqsb (:,:) = cp_air(zqair(:,:))*zqla(:,:)*Ch_atm(:,:)*(zst(:,:) - t_zu(:,:) )   ! Sensible Heat, using bulk wind speed 
    540559      ENDIF 
    541560 
     
    584603      ! 
    585604      !!#LB: NO WHY???? IF ( nn_ice == 0 ) THEN 
    586          CALL iom_put( "rho_air" ,   zrhoa )                ! output air density (kg/m^3) !#LB 
     605         CALL iom_put( "rho_air" ,   rhoa )                 ! output air density (kg/m^3) !#LB 
    587606         CALL iom_put( "qlw_oce" ,   zqlw )                 ! output downward longwave heat over the ocean 
    588607         CALL iom_put( "qsb_oce" , - zqsb )                 ! output downward sensible heat over the ocean 
     
    638657      REAL(wp) ::   zwndi_f , zwndj_f, zwnorm_f   ! relative wind module and components at F-point 
    639658      REAL(wp) ::   zwndi_t , zwndj_t             ! relative wind components at T-point 
    640       REAL(wp), DIMENSION(jpi,jpj) ::   zrhoa     ! transfer coefficient for momentum      (tau) 
    641659      !!--------------------------------------------------------------------- 
    642660      ! 
     
    673691 
    674692      ! local scalars ( place there for vector optimisation purposes) 
    675       ! Computing density of air! Way denser that 1.2 over sea-ice !!! 
    676       zrhoa (:,:) =  rho_air(sf(jp_tair)%fnow(:,:,1), sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1)) 
    677693 
    678694      !!gm brutal.... 
     
    687703      DO jj = 2, jpjm1 
    688704         DO ji = fs_2, fs_jpim1   ! vect. opt. 
    689             utau_ice(ji,jj) = 0.5 * zrhoa(ji,jj) * Cd_atm(ji,jj) * ( wndm_ice(ji+1,jj  ) + wndm_ice(ji,jj) )            & 
     705            utau_ice(ji,jj) = 0.5 * rhoa(ji,jj) * Cd_atm(ji,jj) * ( wndm_ice(ji+1,jj  ) + wndm_ice(ji,jj) )            & 
    690706               &          * ( 0.5 * (sf(jp_wndi)%fnow(ji+1,jj,1) + sf(jp_wndi)%fnow(ji,jj,1) ) - rn_vfac * u_ice(ji,jj) ) 
    691             vtau_ice(ji,jj) = 0.5 * zrhoa(ji,jj) * Cd_atm(ji,jj) * ( wndm_ice(ji,jj+1  ) + wndm_ice(ji,jj) )            & 
     707            vtau_ice(ji,jj) = 0.5 * rhoa(ji,jj) * Cd_atm(ji,jj) * ( wndm_ice(ji,jj+1  ) + wndm_ice(ji,jj) )            & 
    692708               &          * ( 0.5 * (sf(jp_wndj)%fnow(ji,jj+1,1) + sf(jp_wndj)%fnow(ji,jj,1) ) - rn_vfac * v_ice(ji,jj) ) 
    693709         END DO 
     
    732748      REAL(wp), DIMENSION(jpi,jpj,jpl) ::   z_dqsb        ! sensible  heat sensitivity over ice 
    733749      REAL(wp), DIMENSION(jpi,jpj)     ::   zevap, zsnw   ! evaporation and snw distribution after wind blowing (SI3) 
    734       REAL(wp), DIMENSION(jpi,jpj)     ::   zrhoa 
     750      REAL(wp), DIMENSION(jpi,jpj)     ::   zqair         ! specific humidity of air at z=rn_zqt [kg/kg] !LB 
    735751      !!--------------------------------------------------------------------- 
    736752      ! 
     
    738754      zcoef_dqla = -rLsub * 11637800._wp * (-5897.8_wp) !LB: BAD! 
    739755      ! 
    740       zrhoa(:,:) = rho_air( sf(jp_tair)%fnow(:,:,1), sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1) ) 
    741       ! 
     756 
     757      !LB: 
     758      ! spec. hum. of air at "rn_zqt" m above thes sea: 
     759      IF ( ln_humi_dpt ) THEN 
     760         ! spec. hum. of air is deduced from dew-point temperature and SLP: q_air = q_sat( d_air, slp) 
     761         IF (lwp) PRINT *, ' *** LB(sbcblk.F90) => ICE !!! computing q_air out of d_air and slp !' 
     762         zqair(:,:) = q_sat( sf(jp_humi)%fnow(:,:,1), sf(jp_slp)%fnow(:,:,1) ) 
     763      ELSE 
     764         zqair(:,:) = sf(jp_humi)%fnow(:,:,1) ! what we read in file is already a spec. humidity! 
     765      END IF 
     766      !LB. 
     767 
    742768      zztmp = 1. / ( 1. - albo ) 
    743769      WHERE( ptsu(:,:,:) /= 0._wp )   ;   z1_st(:,:,:) = 1._wp / ptsu(:,:,:) 
     
    766792               ! ... turbulent heat fluxes with Ch_atm recalculated in blk_ice_tau 
    767793               ! Sensible Heat 
    768                z_qsb(ji,jj,jl) = zrhoa(ji,jj) * rCp_air * Ch_atm(ji,jj) * wndm_ice(ji,jj) * (ptsu(ji,jj,jl) - sf(jp_tair)%fnow(ji,jj,1)) 
     794               z_qsb(ji,jj,jl) = rhoa(ji,jj) * rCp_air * Ch_atm(ji,jj) * wndm_ice(ji,jj) * (ptsu(ji,jj,jl) - sf(jp_tair)%fnow(ji,jj,1)) 
    769795               ! Latent Heat 
    770                qla_ice(ji,jj,jl) = rn_efac * MAX( 0.e0, zrhoa(ji,jj) * rLsub  * Ch_atm(ji,jj) * wndm_ice(ji,jj) *  & 
    771                   &                ( 11637800. * EXP( -5897.8 * z1_st(ji,jj,jl) ) / zrhoa(ji,jj) - sf(jp_humi)%fnow(ji,jj,1) ) ) 
     796               qla_ice(ji,jj,jl) = rn_efac * MAX( 0.e0, rhoa(ji,jj) * rLsub  * Ch_atm(ji,jj) * wndm_ice(ji,jj) *  & 
     797                  &                ( 11637800. * EXP( -5897.8 * z1_st(ji,jj,jl) ) / rhoa(ji,jj) - zqair(ji,jj) ) ) 
    772798               ! Latent heat sensitivity for ice (Dqla/Dt) 
    773799               IF( qla_ice(ji,jj,jl) > 0._wp ) THEN 
     
    779805 
    780806               ! Sensible heat sensitivity (Dqsb_ice/Dtn_ice) 
    781                z_dqsb(ji,jj,jl) = zrhoa(ji,jj) * rCp_air * Ch_atm(ji,jj) * wndm_ice(ji,jj) 
     807               z_dqsb(ji,jj,jl) = rhoa(ji,jj) * rCp_air * Ch_atm(ji,jj) * wndm_ice(ji,jj) 
    782808 
    783809               ! ----------------------------! 
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbcblk_algo_coare.F90

    r11111 r11182  
    3131   USE sbc_ice         ! Surface boundary condition: ice fields 
    3232#endif 
    33    USE sbcblk_phymbl  !LB: all thermodynamics functions, rho_air, q_sat, etc... 
     33   USE sbcblk_phy     !LB: all thermodynamics functions, rho_air, q_sat, etc... 
    3434   USE in_out_manager ! I/O manager 
    3535   USE iom            ! I/O manager library 
     
    104104      INTEGER :: j_itt 
    105105      LOGICAL :: l_zt_equal_zu = .FALSE.      ! if q and t are given at same height as U 
    106  
     106      ! 
    107107      REAL(wp), DIMENSION(jpi,jpj) ::  & 
    108108         &  u_star, t_star, q_star, & 
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbcblk_algo_ecmwf.F90

    r11111 r11182  
    3838 
    3939   USE sbc_oce         ! Surface boundary condition: ocean fields 
    40    USE sbcblk_phymbl   !LB: all thermodynamics functions, rho_air, q_sat, etc... 
     40   USE sbcblk_phy   !LB: all thermodynamics functions, rho_air, q_sat, etc... 
    4141   USE sbcblk_skin     ! cool-skin/warm layer scheme (CSWL_ECMWF) 
    4242 
     
    265265         Linv = ztmp0*func_m*func_m/func_h / zu     ! From Eq. 3.23, Chap.3.2.3, IFS doc - Cy40r1 
    266266         !! Note: it is slightly different that the L we would get with the usual 
    267          !! expression, as in coare algorithm or in 'mod_phymbl.f90' (One_on_L_MO()) 
     267         !! expression, as in coare algorithm or in 'mod_phy.f90' (One_on_L_MO()) 
    268268         Linv = SIGN( MIN(ABS(Linv),200._wp), Linv ) ! (prevent FPE from stupid values from masked region later on...) !#LOLO 
    269269 
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbcblk_phy.F90

    r11181 r11182  
    1 MODULE sbcblk_phymbl 
     1MODULE sbcblk_phy 
    22   !!====================================================================== 
    3    !!                       ***  MODULE  sbcblk_phymbl  *** 
     3   !!                       ***  MODULE  sbcblk_phy  *** 
    44   !! A set of functions to compute air themodynamics parameters 
    55   !!                     needed by Aerodynamic Bulk Formulas 
     
    1515   !!   visc_air      : kinematic viscosity (aka Nu_air) of air from temperature 
    1616    
    17    USE oce            ! ocean dynamics and tracers 
    1817   USE dom_oce        ! ocean space and time domain 
    1918   USE phycst         ! physical constants 
    20    !USE sbc_oce        ! Surface boundary condition: ocean fields 
    21    !USE sbcdcy         ! surface boundary condition: diurnal cycle 
    22    !USE sbcwave , ONLY :   cdn_wave ! wave module 
    23    !USE sbc_ice        ! Surface boundary condition: ice fields 
    24    USE lib_fortran    ! to use key_nosignedzero 
    25    ! 
    26    !USE iom            ! I/O manager library 
    27    !USE in_out_manager ! I/O manager 
    28    USE lib_mpp        ! distribued memory computing library 
    29    !USE lbclnk         ! ocean lateral boundary conditions (or mpp link) 
    30    !USE prtctl         ! Print control 
    3119 
    3220   IMPLICIT NONE 
     
    9886      ! 
    9987      INTEGER  ::   ji, jj         ! dummy loop indices 
    100       REAL(wp) ::   ze_sat, ztmp   ! local scalar 
     88      REAL(wp) ::   zta, ze_sat, ztmp   ! local scalar 
    10189      !!---------------------------------------------------------------------------------- 
    10290      ! 
     
    10492         DO ji = 1, jpi 
    10593            ! 
    106             ztmp = rt0 / ptak(ji,jj) 
     94            zta = MAX( ptak(ji,jj) , 180._wp )   ! air temp., prevents fpe0 errors dute to unrealistically low values over masked regions... 
     95            ztmp = rt0 / zta 
    10796            ! 
    10897            ! Vapour pressure at saturation [hPa] : WMO, (Goff, 1957) 
    109             ze_sat = 10.**( 10.79574*(1. - ztmp) - 5.028*LOG10(ptak(ji,jj)/rt0)        & 
    110                &    + 1.50475*10.**(-4)*(1. - 10.**(-8.2969*(ptak(ji,jj)/rt0 - 1.)) )  & 
     98            ze_sat = 10.**( 10.79574*(1. - ztmp) - 5.028*LOG10(zta/rt0)        & 
     99               &    + 1.50475*10.**(-4)*(1. - 10.**(-8.2969*(zta/rt0 - 1.)) )  & 
    111100               &    + 0.42873*10.**(-3)*(10.**(4.76955*(1. - ztmp)) - 1.) + 0.78614  ) 
    112101            ! 
     
    191180 
    192181   !!====================================================================== 
    193 END MODULE sbcblk_phymbl 
     182END MODULE sbcblk_phy 
  • NEMO/branches/2019/dev_r11085_ASINTER-05_Brodeau_Advanced_Bulk/src/OCE/SBC/sbcblk_skin.F90

    r11111 r11182  
    2525   USE sbc_oce         ! Surface boundary condition: ocean fields 
    2626 
    27    USE sbcblk_phymbl  !LOLO: all thermodynamics functions, rho_air, q_sat, etc... 
     27   USE sbcblk_phy      !LOLO: all thermodynamics functions, rho_air, q_sat, etc... 
    2828 
    2929   USE lib_mpp         ! distribued memory computing library 
Note: See TracChangeset for help on using the changeset viewer.