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 12724 for NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests – NEMO

Ignore:
Timestamp:
2020-04-08T21:37:59+02:00 (4 years ago)
Author:
techene
Message:

branch KERNEL-06 : merge with trunk@12698 #2385 - in duplcated files : changes to comply to the new trunk variables and some loop bug fixes

Location:
NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3
Files:
2 deleted
64 edited
1 copied

Legend:

Unmodified
Added
Removed
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3

    • Property svn:externals
      •  

        old new  
        33^/utils/build/mk@HEAD         mk 
        44^/utils/tools@HEAD            tools 
        5 ^/vendors/AGRIF/dev_r11615_ENHANCE-04_namelists_as_internalfiles_agrif@HEAD      ext/AGRIF 
         5^/vendors/AGRIF/dev@HEAD      ext/AGRIF 
        66^/vendors/FCM@HEAD            ext/FCM 
        77^/vendors/IOIPSL@HEAD         ext/IOIPSL 
         8 
         9# SETTE 
         10^/utils/CI/sette@HEAD         sette 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/BENCH/EXPREF/namelist_cfg_orca025_like

    r11536 r12724  
    3636&namdom        !   time and space domain 
    3737!----------------------------------------------------------------------- 
    38    rn_rdt      =    900.   !  time step for the dynamics (and tracer if nn_acc=0) 
     38   rn_Dt      =    900.   !  time step for the dynamics (and tracer if nn_acc=0) 
    3939   rn_atfp     =   0.05    !  asselin time filter parameter 
    4040/ 
     
    5050!----------------------------------------------------------------------- 
    5151  ln_usr      = .true.    !  user defined formulation                  (T => check usrdef_sbc) 
     52  nn_ice      = 2         !  =0 no ice boundary condition 
     53     !                    !  =1 use observed ice-cover                 (  => fill namsbc_iif ) 
     54     !                    !  =2 or 3 for SI3 and CICE, respectively 
    5255  ln_traqsr   = .true.    !  Light penetration in the ocean            (T => fill namtra_qsr) 
    5356/ 
     
    189192   ln_dynspg_ts   = .true.   ! split-explicit free surface 
    190193      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    191          nn_baro      =  30         ! =F : the number of sub-step in rn_rdt seconds 
     194         nn_e      =  30         ! =F : the number of sub-step in rn_Dt seconds 
    192195/ 
    193196!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/BENCH/EXPREF/namelist_cfg_orca12_like

    r11536 r12724  
    3636&namdom        !   time and space domain 
    3737!----------------------------------------------------------------------- 
    38    rn_rdt      =    300.   !  time step for the dynamics (and tracer if nn_acc=0) 
     38   rn_Dt      =    300.   !  time step for the dynamics (and tracer if nn_acc=0) 
    3939   rn_atfp     =   0.05    !  asselin time filter parameter 
    4040/ 
     
    5050!----------------------------------------------------------------------- 
    5151  ln_usr      = .true.    !  user defined formulation                  (T => check usrdef_sbc) 
     52  nn_ice      = 2         !  =0 no ice boundary condition 
     53     !                    !  =1 use observed ice-cover                 (  => fill namsbc_iif ) 
     54     !                    !  =2 or 3 for SI3 and CICE, respectively 
    5255  ln_traqsr   = .true.    !  Light penetration in the ocean            (T => fill namtra_qsr) 
    5356/ 
     
    188191   ln_dynspg_ts   = .true.   ! split-explicit free surface 
    189192      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    190          nn_baro      =  30         ! =F : the number of sub-step in rn_rdt seconds 
     193         nn_e      =  30         ! =F : the number of sub-step in rn_Dt seconds 
    191194/ 
    192195!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/BENCH/EXPREF/namelist_cfg_orca1_like

    r11536 r12724  
    3636&namdom        !   time and space domain 
    3737!----------------------------------------------------------------------- 
    38    rn_rdt      =   3600.   !  time step for the dynamics (and tracer if nn_acc=0) 
     38   rn_Dt      =   3600.   !  time step for the dynamics (and tracer if nn_acc=0) 
    3939   rn_atfp     =   0.05    !  asselin time filter parameter 
    4040/ 
     
    5050!----------------------------------------------------------------------- 
    5151  ln_usr      = .true.    !  user defined formulation                  (T => check usrdef_sbc) 
     52  nn_ice      = 2         !  =0 no ice boundary condition 
     53     !                    !  =1 use observed ice-cover                 (  => fill namsbc_iif ) 
     54     !                    !  =2 or 3 for SI3 and CICE, respectively 
    5255  ln_traqsr   = .true.    !  Light penetration in the ocean            (T => fill namtra_qsr) 
    5356/ 
     
    188191   ln_dynspg_ts   = .true.   ! split-explicit free surface 
    189192      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    190          nn_baro      =  30         ! =F : the number of sub-step in rn_rdt seconds 
     193         nn_e      =  30         ! =F : the number of sub-step in rn_Dt seconds 
    191194/ 
    192195!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/BENCH/EXPREF/namelist_pisces_cfg

    r10343 r12724  
    8181/ 
    8282!----------------------------------------------------------------------- 
    83 &nampissbc     !   parameters for inputs deposition 
     83&nampisbc      !   parameters for inputs deposition 
    8484!----------------------------------------------------------------------- 
    85    ln_dust     =  .false.   ! boolean for dust input from the atmosphere 
    86    ln_solub    =  .false.   ! boolean for variable solubility of atm. Iron 
    87    ln_river    =  .false.   ! boolean for river input of nutrients 
    88    ln_ndepo    =  .false.   ! boolean for atmospheric deposition of N 
    8985   ln_ironsed  =  .false.   ! boolean for Fe input from sediments 
    9086   ln_ironice  =  .false.   ! boolean for Fe input from sea ice 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/BENCH/MY_SRC/usrdef_nam.F90

    r12377 r12724  
    5555      !                              !!* nammpp namelist *!! 
    5656      INTEGER          ::   jpni, jpnj 
    57       LOGICAL          ::   ln_nnogather 
     57      LOGICAL          ::   ln_nnogather, ln_listonly 
    5858      !! 
    5959      NAMELIST/namusr_def/ nn_isize, nn_jsize, nn_ksize, nn_perio 
    60       NAMELIST/nammpp/ jpni, jpnj, ln_nnogather 
     60      NAMELIST/nammpp/ jpni, jpnj, ln_nnogather, ln_listonly 
    6161      !!----------------------------------------------------------------------      
    6262      ! 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/EXPREF/namelist_cfg

    r12377 r12724  
    5959!----------------------------------------------------------------------- 
    6060   ln_linssh   =  .false.  !  =T  linear free surface  ==>>  model level are fixed in time 
    61    rn_rdt      =   1440.   !  time step for the dynamics (and tracer if nn_acc=0) 
     61   rn_Dt      =   1440.   !  time step for the dynamics (and tracer if nn_acc=0) 
    6262   rn_atfp     =   0.05    !  asselin time filter parameter 
    6363/ 
     
    208208      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    209209         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    210          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    211          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     210         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     211         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    212212      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    213          nn_baro      =  24         ! =F : the number of sub-step in rn_rdt seconds 
     213         nn_e      =  24         ! =F : the number of sub-step in rn_Dt seconds 
    214214/ 
    215215!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/MY_SRC/diawri.F90

    r12377 r12724  
    169169 
    170170      IF ( iom_use("taubot") ) THEN                ! bottom stress 
    171          zztmp = rau0 * 0.25 
     171         zztmp = rho0 * 0.25 
    172172         z2d(:,:) = 0._wp 
    173173         DO jj = 2, jpjm1 
     
    212212      IF( iom_use('w_masstr') .OR. iom_use('w_masstr2') ) THEN   ! vertical mass transport & its square value 
    213213         ! Caution: in the VVL case, it only correponds to the baroclinic mass transport. 
    214          z2d(:,:) = rau0 * e1e2t(:,:) 
     214         z2d(:,:) = rho0 * e1e2t(:,:) 
    215215         DO jk = 1, jpk 
    216216            z3d(:,:,jk) = ww(:,:,jk) * z2d(:,:) 
     
    272272            END DO 
    273273         END DO 
    274          CALL iom_put( "heatc", rau0_rcp * z2d )   ! vertically integrated heat content (J/m2) 
     274         CALL iom_put( "heatc", rho0_rcp * z2d )   ! vertically integrated heat content (J/m2) 
    275275      ENDIF 
    276276 
     
    284284            END DO 
    285285         END DO 
    286          CALL iom_put( "saltc", rau0 * z2d )          ! vertically integrated salt content (PSU*kg/m2) 
     286         CALL iom_put( "saltc", rho0 * z2d )          ! vertically integrated salt content (PSU*kg/m2) 
    287287      ENDIF 
    288288      ! 
     
    296296            END DO 
    297297         END DO 
    298          CALL iom_put( "salt2c", rau0 * z2d )          ! vertically integrated salt content (PSU*kg/m2) 
     298         CALL iom_put( "salt2c", rho0 * z2d )          ! vertically integrated salt content (PSU*kg/m2) 
    299299      ENDIF 
    300300      ! 
     
    395395         z2d(:,:) = 0.e0 
    396396         DO jk = 1, jpkm1 
    397             z3d(:,:,jk) = rau0 * uu(:,:,jk,Kmm) * e2u(:,:) * e3u(:,:,jk,Kmm) * umask(:,:,jk) 
     397            z3d(:,:,jk) = rho0 * uu(:,:,jk,Kmm) * e2u(:,:) * e3u(:,:,jk,Kmm) * umask(:,:,jk) 
    398398            z2d(:,:) = z2d(:,:) + z3d(:,:,jk) 
    399399         END DO 
     
    432432         z3d(:,:,jpk) = 0.e0 
    433433         DO jk = 1, jpkm1 
    434             z3d(:,:,jk) = rau0 * vv(:,:,jk,Kmm) * e1v(:,:) * e3v(:,:,jk,Kmm) * vmask(:,:,jk) 
     434            z3d(:,:,jk) = rho0 * vv(:,:,jk,Kmm) * e1v(:,:) * e3v(:,:,jk,Kmm) * vmask(:,:,jk) 
    435435         END DO 
    436436         CALL iom_put( "v_masstr", z3d )              ! mass transport in j-direction 
     
    473473         END DO 
    474474         CALL lbc_lnk( 'diawri', z2d, 'T', -1. ) 
    475          CALL iom_put( "tosmint", rau0 * z2d )        ! Vertical integral of temperature 
     475         CALL iom_put( "tosmint", rho0 * z2d )        ! Vertical integral of temperature 
    476476      ENDIF 
    477477      IF( iom_use("somint") ) THEN 
     
    485485         END DO 
    486486         CALL lbc_lnk( 'diawri', z2d, 'T', -1. ) 
    487          CALL iom_put( "somint", rau0 * z2d )         ! Vertical integral of salinity 
     487         CALL iom_put( "somint", rho0 * z2d )         ! Vertical integral of salinity 
    488488      ENDIF 
    489489 
     
    563563      clop = "x"         ! no use of the mask value (require less cpu time and otherwise the model crashes) 
    564564#if defined key_diainstant 
    565       zsto = nn_write * rdt 
     565      zsto = nn_write * rn_Dt 
    566566      clop = "inst("//TRIM(clop)//")" 
    567567#else 
    568       zsto=rdt 
     568      zsto=rn_Dt 
    569569      clop = "ave("//TRIM(clop)//")" 
    570570#endif 
    571       zout = nn_write * rdt 
    572       zmax = ( nitend - nit000 + 1 ) * rdt 
     571      zout = nn_write * rn_Dt 
     572      zmax = ( nitend - nit000 + 1 ) * rn_Dt 
    573573 
    574574      ! Define indices of the horizontal output zoom and vertical limit storage 
     
    590590 
    591591         ! Compute julian date from starting date of the run 
    592          CALL ymds2ju( nyear, nmonth, nday, rdt, zjulian ) 
     592         CALL ymds2ju( nyear, nmonth, nday, rn_Dt, zjulian ) 
    593593         zjulian = zjulian - adatrj   !   set calendar origin to the beginning of the experiment 
    594594         IF(lwp)WRITE(numout,*) 
     
    612612         CALL histbeg( clhstnam, jpi, glamt, jpj, gphit,           &  ! Horizontal grid: glamt and gphit 
    613613            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    614             &          nit000-1, zjulian, rdt, nh_T, nid_T, domain_id=nidom, snc4chunks=snc4set ) 
     614            &          nit000-1, zjulian, rn_Dt, nh_T, nid_T, domain_id=nidom, snc4chunks=snc4set ) 
    615615         CALL histvert( nid_T, "deptht", "Vertical T levels",      &  ! Vertical grid: gdept 
    616616            &           "m", ipk, gdept_1d, nz_T, "down" ) 
     
    648648         CALL histbeg( clhstnam, jpi, glamu, jpj, gphiu,           &  ! Horizontal grid: glamu and gphiu 
    649649            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    650             &          nit000-1, zjulian, rdt, nh_U, nid_U, domain_id=nidom, snc4chunks=snc4set ) 
     650            &          nit000-1, zjulian, rn_Dt, nh_U, nid_U, domain_id=nidom, snc4chunks=snc4set ) 
    651651         CALL histvert( nid_U, "depthu", "Vertical U levels",      &  ! Vertical grid: gdept 
    652652            &           "m", ipk, gdept_1d, nz_U, "down" ) 
     
    661661         CALL histbeg( clhstnam, jpi, glamv, jpj, gphiv,           &  ! Horizontal grid: glamv and gphiv 
    662662            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    663             &          nit000-1, zjulian, rdt, nh_V, nid_V, domain_id=nidom, snc4chunks=snc4set ) 
     663            &          nit000-1, zjulian, rn_Dt, nh_V, nid_V, domain_id=nidom, snc4chunks=snc4set ) 
    664664         CALL histvert( nid_V, "depthv", "Vertical V levels",      &  ! Vertical grid : gdept 
    665665            &          "m", ipk, gdept_1d, nz_V, "down" ) 
     
    674674         CALL histbeg( clhstnam, jpi, glamt, jpj, gphit,           &  ! Horizontal grid: glamt and gphit 
    675675            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    676             &          nit000-1, zjulian, rdt, nh_W, nid_W, domain_id=nidom, snc4chunks=snc4set ) 
     676            &          nit000-1, zjulian, rn_Dt, nh_W, nid_W, domain_id=nidom, snc4chunks=snc4set ) 
    677677         CALL histvert( nid_W, "depthw", "Vertical W levels",      &  ! Vertical grid: gdepw 
    678678            &          "m", ipk, gdepw_1d, nz_W, "down" ) 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/MY_SRC/domvvl.F90

    r12377 r12724  
    209209         IF( ln_vvl_ztilde_as_zstar ) THEN   ! z-star emulation using z-tile 
    210210            frq_rst_e3t(:,:) = 0._wp               !Ignore namelist settings 
    211             frq_rst_hdv(:,:) = 1._wp / rdt 
     211            frq_rst_hdv(:,:) = 1._wp / rn_Dt 
    212212         ENDIF 
    213213         IF ( ln_vvl_zstar_at_eqtor ) THEN   ! use z-star in vicinity of the Equator 
     
    222222                     ! values inside the equatorial band (ztilde as zstar) 
    223223                     frq_rst_e3t(ji,jj) =  0.0_wp 
    224                      frq_rst_hdv(ji,jj) =  1.0_wp / rdt 
     224                     frq_rst_hdv(ji,jj) =  1.0_wp / rn_Dt 
    225225                  ELSE                                      ! transition band (2.5 to 6 degrees N/S) 
    226226                     !                                      ! (linearly transition from z-tilde to z-star) 
     
    228228                        &            * (  1.0_wp - COS( rad*(ABS(gphit(ji,jj))-2.5_wp)  & 
    229229                        &                                          * 180._wp / 3.5_wp ) ) 
    230                      frq_rst_hdv(ji,jj) = (1.0_wp / rdt)                                & 
    231                         &            + (  frq_rst_hdv(ji,jj)-(1.e0_wp / rdt) )*0.5_wp   & 
     230                     frq_rst_hdv(ji,jj) = (1.0_wp / rn_Dt)                                & 
     231                        &            + (  frq_rst_hdv(ji,jj)-(1.e0_wp / rn_Dt) )*0.5_wp   & 
    232232                        &            * (  1._wp  - COS( rad*(ABS(gphit(ji,jj))-2.5_wp)  & 
    233233                        &                                          * 180._wp / 3.5_wp ) ) 
     
    240240                  ij0 = 128   ;   ij1 = 135   ;    
    241241                  frq_rst_e3t( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  0.0_wp 
    242                   frq_rst_hdv( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  1.e0_wp / rdt 
     242                  frq_rst_hdv( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  1.e0_wp / rn_Dt 
    243243               ENDIF 
    244244            ENDIF 
     
    295295      INTEGER                ::   ji, jj, jk            ! dummy loop indices 
    296296      INTEGER , DIMENSION(3) ::   ijk_max, ijk_min      ! temporary integers 
    297       REAL(wp)               ::   z2dt, z_tmin, z_tmax  ! local scalars 
     297      REAL(wp)               ::   z_tmin, z_tmax        ! local scalars 
    298298      LOGICAL                ::   ll_do_bclinic         ! local logical 
    299299      REAL(wp), DIMENSION(jpi,jpj)     ::   zht, z_scale, zwu, zwv, zhdiv 
     
    349349            IF( kt > nit000 ) THEN 
    350350               DO jk = 1, jpkm1 
    351                   hdiv_lf(:,:,jk) = hdiv_lf(:,:,jk) - rdt * frq_rst_hdv(:,:)   & 
     351                  hdiv_lf(:,:,jk) = hdiv_lf(:,:,jk) - rn_Dt * frq_rst_hdv(:,:)   & 
    352352                     &          * ( hdiv_lf(:,:,jk) - e3t(:,:,jk,Kmm) * ( hdiv(:,:,jk) - zhdiv(:,:) ) ) 
    353353               END DO 
     
    418418         ! Leapfrog time stepping 
    419419         ! ~~~~~~~~~~~~~~~~~~~~~~ 
    420          IF( neuler == 0 .AND. kt == nit000 ) THEN 
    421             z2dt =  rdt 
    422          ELSE 
    423             z2dt = 2.0_wp * rdt 
    424          ENDIF 
    425420         CALL lbc_lnk( 'domvvl', tilde_e3t_a(:,:,:), 'T', 1._wp ) 
    426          tilde_e3t_a(:,:,:) = tilde_e3t_b(:,:,:) + z2dt * tmask(:,:,:) * tilde_e3t_a(:,:,:) 
     421         tilde_e3t_a(:,:,:) = tilde_e3t_b(:,:,:) + rDt * tmask(:,:,:) * tilde_e3t_a(:,:,:) 
    427422 
    428423         ! Maximum deformation control 
     
    610605      ! - ML - e3(t/u/v)_b are allready computed in dynnxt. 
    611606      IF( ln_vvl_ztilde .OR. ln_vvl_layer ) THEN 
    612          IF( neuler == 0 .AND. kt == nit000 ) THEN 
     607         IF( l_1st_euler ) THEN 
    613608            tilde_e3t_b(:,:,:) = tilde_e3t_n(:,:,:) 
    614609         ELSE 
    615610            tilde_e3t_b(:,:,:) = tilde_e3t_n(:,:,:) &  
    616             &         + atfp * ( tilde_e3t_b(:,:,:) - 2.0_wp * tilde_e3t_n(:,:,:) + tilde_e3t_a(:,:,:) ) 
     611            &         + rn_atfp * ( tilde_e3t_b(:,:,:) - 2.0_wp * tilde_e3t_n(:,:,:) + tilde_e3t_a(:,:,:) ) 
    617612         ENDIF 
    618613         tilde_e3t_n(:,:,:) = tilde_e3t_a(:,:,:) 
     
    827822                  e3t(:,:,:,Kbb) = e3t_0(:,:,:) 
    828823               END WHERE 
    829                IF( neuler == 0 ) THEN 
     824               IF( l_1st_euler ) THEN 
    830825                  e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    831826               ENDIF 
     
    833828               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kmm) not found in restart files' 
    834829               IF(lwp) write(numout,*) 'e3t_n set equal to e3t_b.' 
    835                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     830               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    836831               CALL iom_get( numror, jpdom_autoglo, 'e3t_b', e3t(:,:,:,Kbb), ldxios = lrxios ) 
    837832               e3t(:,:,:,Kmm) = e3t(:,:,:,Kbb) 
    838                neuler = 0 
     833               l_1st_euler = .true. 
    839834            ELSE IF( id2 > 0 ) THEN 
    840835               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kbb) not found in restart files' 
    841836               IF(lwp) write(numout,*) 'e3t_b set equal to e3t_n.' 
    842                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     837               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    843838               CALL iom_get( numror, jpdom_autoglo, 'e3t_n', e3t(:,:,:,Kmm), ldxios = lrxios ) 
    844839               e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    845                neuler = 0 
     840               l_1st_euler = .true. 
    846841            ELSE 
    847842               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kmm) not found in restart file' 
    848843               IF(lwp) write(numout,*) 'Compute scale factor from sshn' 
    849                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     844               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    850845               DO jk = 1, jpk 
    851846                  e3t(:,:,jk,Kmm) =  e3t_0(:,:,jk) * ( ht_0(:,:) + ssh(:,:,Kmm) ) & 
     
    854849               END DO 
    855850               e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    856                neuler = 0 
     851               l_1st_euler = .true. 
    857852            ENDIF 
    858853            !                             ! ----------- ! 
     
    10151010            WRITE(numout,*) '                         rn_rst_e3t     = 0.e0' 
    10161011            WRITE(numout,*) '            hard-wired : z-tilde cutoff frequency of low-pass filter (days)' 
    1017             WRITE(numout,*) '                         rn_lf_cutoff   = 1.0/rdt' 
     1012            WRITE(numout,*) '                         rn_lf_cutoff   = 1.0/rn_Dt' 
    10181013         ELSE 
    10191014            WRITE(numout,*) '      z-tilde to zstar restoration timescale (days)        rn_rst_e3t   = ', rn_rst_e3t 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/MY_SRC/sbcmod.F90

    r12377 r12724  
    186186      ! 
    187187      IF( .NOT.ln_usr ) THEN     ! the model calendar needs some specificities (except in user defined case) 
    188          IF( MOD( rday , rdt ) /= 0. )   CALL ctl_stop( 'the time step must devide the number of second of in a day' ) 
    189          IF( MOD( rday , 2.  ) /= 0. )   CALL ctl_stop( 'the number of second of in a day must be an even number'    ) 
    190          IF( MOD( rdt  , 2.  ) /= 0. )   CALL ctl_stop( 'the time step (in second) must be an even number'           ) 
     188         IF( MOD( rday , rn_Dt ) /= 0. )   CALL ctl_stop( 'the time step must devide the number of second of in a day' ) 
     189         IF( MOD( rday , 2.    ) /= 0. )   CALL ctl_stop( 'the number of second of in a day must be an even number'    ) 
     190         IF( MOD( rn_Dt, 2.    ) /= 0. )   CALL ctl_stop( 'the time step (in second) must be an even number'           ) 
    191191      ENDIF 
    192192      !                       !**  check option consistency 
     
    298298      !     SAS time-step has to be declared in OASIS (mandatory) -> nn_fsbc has to be modified accordingly 
    299299      IF( nn_components /= jp_iam_nemo ) THEN 
    300          IF( nn_components == jp_iam_opa )   nn_fsbc = cpl_freq('O_SFLX') / NINT(rdt) 
    301          IF( nn_components == jp_iam_sas )   nn_fsbc = cpl_freq('I_SFLX') / NINT(rdt) 
     300         IF( nn_components == jp_iam_opa )   nn_fsbc = cpl_freq('O_SFLX') / NINT(rn_Dt) 
     301         IF( nn_components == jp_iam_sas )   nn_fsbc = cpl_freq('I_SFLX') / NINT(rn_Dt) 
    302302         ! 
    303303         IF(lwp)THEN 
     
    316316      ENDIF 
    317317      ! 
    318       IF( MOD( rday, REAL(nn_fsbc, wp) * rdt ) /= 0 )   & 
     318      IF( MOD( rday, REAL(nn_fsbc, wp) * rn_Dt ) /= 0 )   & 
    319319         &  CALL ctl_warn( 'sbc_init : nn_fsbc is NOT a multiple of the number of time steps in a day' ) 
    320320      ! 
    321       IF( ln_dm2dc .AND. NINT(rday) / ( nn_fsbc * NINT(rdt) ) < 8  )   & 
     321      IF( ln_dm2dc .AND. NINT(rday) / ( nn_fsbc * NINT(rn_Dt) ) < 8  )   & 
    322322         &   CALL ctl_warn( 'sbc_init : diurnal cycle for qsr: the sampling of the diurnal cycle is too small...' ) 
    323323      ! 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/MY_SRC/trazdf.F90

    r12377 r12724  
    6464      ENDIF 
    6565      ! 
    66       IF( neuler == 0 .AND. kt == nit000 ) THEN   ;   r2dt =      rdt   ! at nit000, =   rdt (restarting with Euler time stepping) 
    67       ELSEIF( kt <= nit000 + 1           ) THEN   ;   r2dt = 2. * rdt   ! otherwise, = 2 rdt (leapfrog) 
    68       ENDIF 
    69       ! 
    7066      IF( l_trdtra )   THEN                  !* Save ta and sa trends 
    7167         ALLOCATE( ztrdt(jpi,jpj,jpk) , ztrds(jpi,jpj,jpk) ) 
     
    7571      ! 
    7672      !                                      !* compute lateral mixing trend and add it to the general trend 
    77       CALL tra_zdf_imp( kt, nit000, 'TRA', r2dt, Kbb, Kmm, Krhs, pts, Kaa, jpts )  
     73      CALL tra_zdf_imp( kt, nit000, 'TRA', rDt, Kbb, Kmm, Krhs, pts, Kaa, jpts )  
    7874 
    7975!!gm WHY here !   and I don't like that ! 
     
    8783         DO jk = 1, jpkm1 
    8884            ztrdt(:,:,jk) = ( ( pts(:,:,jk,jp_tem,Kaa)*e3t(:,:,jk,Kaa) - pts(:,:,jk,jp_tem,Kbb)*e3t(:,:,jk,Kbb) ) & 
    89                &          / (e3t(:,:,jk,Kmm)*r2dt) ) - ztrdt(:,:,jk) 
     85               &          / (e3t(:,:,jk,Kmm)*rDt) ) - ztrdt(:,:,jk) 
    9086            ztrds(:,:,jk) = ( ( pts(:,:,jk,jp_sal,Kaa)*e3t(:,:,jk,Kaa) - pts(:,:,jk,jp_sal,Kbb)*e3t(:,:,jk,Kbb) ) & 
    91               &           / (e3t(:,:,jk,Kmm)*r2dt) ) - ztrds(:,:,jk) 
     87              &           / (e3t(:,:,jk,Kmm)*rDt) ) - ztrds(:,:,jk) 
    9288         END DO 
    9389!!gm this should be moved in trdtra.F90 and done on all trends 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/CANAL/MY_SRC/usrdef_istate.F90

    r10425 r12724  
    218218         ! 
    219219         zr_lambda2 = 1._wp / zlambda**2 
    220          zP0 = rau0 * zf0 * zumax * zlambda * SQRT(EXP(1._wp)/2._wp) 
     220         zP0 = rho0 * zf0 * zumax * zlambda * SQRT(EXP(1._wp)/2._wp) 
    221221         ! 
    222222         DO jj=1, jpj 
     
    225225               zy = gphit(ji,jj) * 1.e3 
    226226               ! Surface pressure: P(x,y,z) = F(z) * Psurf(x,y) 
    227                zpsurf = zP0 * EXP(-(zx**2+zy**2)*zr_lambda2) - rau0 * ff_t(ji,jj) * rn_uzonal * zy 
     227               zpsurf = zP0 * EXP(-(zx**2+zy**2)*zr_lambda2) - rho0 * ff_t(ji,jj) * rn_uzonal * zy 
    228228               ! Sea level: 
    229229               pssh(ji,jj) = 0. 
     
    231231                  zdt = pssh(ji,jj) 
    232232                  zdzF = (1._wp - EXP(zdt-zH)) / (zH - 1._wp + EXP(-zH))   ! F'(z) 
    233                   zrho1 = rau0 * (1._wp + zn2*zdt/grav) - zdzF * zpsurf / grav    ! -1/g Dz(P) = -1/g * F'(z) * Psurf(x,y) 
     233                  zrho1 = rho0 * (1._wp + zn2*zdt/grav) - zdzF * zpsurf / grav    ! -1/g Dz(P) = -1/g * F'(z) * Psurf(x,y) 
    234234                  pssh(ji,jj) = zpsurf / (zrho1*grav) * ptmask(ji,jj,1)   ! ssh = Psurf / (Rho*g) 
    235235               END DO 
     
    237237               DO jk=1,jpk 
    238238                  zdt =  pdept(ji,jj,jk)  
    239                   zrho1 = rau0 * (1._wp + zn2*zdt/grav) 
     239                  zrho1 = rho0 * (1._wp + zn2*zdt/grav) 
    240240                  IF (zdt < zH) THEN 
    241241                     zdzF = (1._wp-EXP(zdt-zH)) / (zH-1._wp + EXP(-zH))   ! F'(z) 
    242242                     zrho1 = zrho1 - zdzF * zpsurf / grav    ! -1/g Dz(P) = -1/g * F'(z) * Psurf(x,y) 
    243243                  ENDIF 
    244                   !               pts(ji,jj,jk,jp_tem) = (20._wp + (rau0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
    245                   pts(ji,jj,jk,jp_tem) = (10._wp + (rau0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
     244                  !               pts(ji,jj,jk,jp_tem) = (20._wp + (rho0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
     245                  pts(ji,jj,jk,jp_tem) = (10._wp + (rho0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
    246246               END DO 
    247247            END DO 
     
    261261                  IF (zdu < zH) THEN 
    262262                     zf = (zH-1._wp-zdu+EXP(zdu-zH)) / (zH-1._wp+EXP(-zH)) 
    263                      zdyPs = - za * zy * EXP(-(zx**2+zy**2)*zr_lambda2) - rau0 * ff_t(ji,jj) * rn_uzonal 
    264                      pu(ji,jj,jk) = - zf / ( rau0 * ff_t(ji,jj) ) * zdyPs * ptmask(ji,jj,jk) * ptmask(ji+1,jj,jk) 
     263                     zdyPs = - za * zy * EXP(-(zx**2+zy**2)*zr_lambda2) - rho0 * ff_t(ji,jj) * rn_uzonal 
     264                     pu(ji,jj,jk) = - zf / ( rho0 * ff_t(ji,jj) ) * zdyPs * ptmask(ji,jj,jk) * ptmask(ji+1,jj,jk) 
    265265                  ELSE 
    266266                     pu(ji,jj,jk) = 0._wp 
     
    279279                     zf = (zH-1._wp-zdv+EXP(zdv-zH)) / (zH-1._wp+EXP(-zH)) 
    280280                     zdxPs = - za * zx * EXP(-(zx**2+zy**2)*zr_lambda2) 
    281                      pv(ji,jj,jk) = zf / ( rau0 * ff_f(ji,jj) ) * zdxPs * ptmask(ji,jj,jk) * ptmask(ji,jj+1,jk) 
     281                     pv(ji,jj,jk) = zf / ( rho0 * ff_f(ji,jj) ) * zdxPs * ptmask(ji,jj,jk) * ptmask(ji,jj+1,jk) 
    282282                  ELSE 
    283283                     pv(ji,jj,jk) = 0._wp 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_ADV1D/EXPREF/namelist_cfg

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_ADV1D/EXPREF/namelist_cfg_120pts

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_ADV1D/EXPREF/namelist_cfg_240pts

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_ADV1D/EXPREF/namelist_cfg_60pts

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      =   2.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_ADV2D/EXPREF/namelist_cfg

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      = 1200.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      = 1200.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_AGRIF/EXPREF/1_namelist_cfg

    r12377 r12724  
    3939   ln_linssh   = .true.   !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      = 400.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      = 400.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_AGRIF/EXPREF/namelist_cfg

    r12377 r12724  
    3939   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
    4040   ! 
    41    rn_rdt      = 1200.     !  time step for the dynamics (and tracer if nn_acc=0) 
     41   rn_Dt      = 1200.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4242   ! 
    4343   ln_meshmask = .true.   !  =T  create a mesh file 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_AGRIF/MY_SRC/usrdef_nam.F90

    r12377 r12724  
    8989         kpj = nbcellsy + 2 + 2*nbghostcells 
    9090      ENDIF 
    91       kpk = 1 
     91      kpk = 2 
    9292      ! 
    9393!!      zlx = (kpi-2)*rn_dx*1.e-3 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ICE_AGRIF/MY_SRC/usrdef_zgr.F90

    r12377 r12724  
    8989      !                       !==  z-coordinate  ==!   (step-like topography) 
    9090      !                                !* bottom ocean compute from the depth of grid-points 
    91       jpkm1 = jpk 
     91      jpkm1 = jpk-1 
    9292      k_bot(:,:) = 1    ! here use k_top as a land mask 
    9393      !                                !* horizontally uniform coordinate (reference z-co everywhere) 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ISOMIP+/EXPREF/namelist_cfg

    r12077 r12724  
    4444&namdom        !   time and space domain 
    4545!----------------------------------------------------------------------- 
    46 rn_rdt = 720. 
     46rn_Dt = 720. 
    4747/ 
    4848!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ISOMIP+/MY_SRC/eosbn2.F90

    r12353 r12724  
    191191      !!                   ***  ROUTINE eos_insitu  *** 
    192192      !! 
    193       !! ** Purpose :   Compute the in situ density (ratio rho/rau0) from 
     193      !! ** Purpose :   Compute the in situ density (ratio rho/rho0) from 
    194194      !!       potential temperature and salinity using an equation of state 
    195195      !!       selected in the nameos namelist 
    196196      !! 
    197       !! ** Method  :   prd(t,s,z) = ( rho(t,s,z) - rau0 ) / rau0 
     197      !! ** Method  :   prd(t,s,z) = ( rho(t,s,z) - rho0 ) / rho0 
    198198      !!         with   prd    in situ density anomaly      no units 
    199199      !!                t      TEOS10: CT or EOS80: PT      Celsius 
     
    201201      !!                z      depth                        meters 
    202202      !!                rho    in situ density              kg/m^3 
    203       !!                rau0   reference density            kg/m^3 
     203      !!                rho0   reference density            kg/m^3 
    204204      !! 
    205205      !!     ln_teos10 : polynomial TEOS-10 equation of state is used for rho(t,s,z). 
     
    210210      !! 
    211211      !!     ln_seos : simplified equation of state 
    212       !!              prd(t,s,z) = ( -a0*(1+lambda/2*(T-T0)+mu*z+nu*(S-S0))*(T-T0) + b0*(S-S0) ) / rau0 
     212      !!              prd(t,s,z) = ( -a0*(1+lambda/2*(T-T0)+mu*z+nu*(S-S0))*(T-T0) + b0*(S-S0) ) / rho0 
    213213      !!              linear case function of T only: rn_alpha<>0, other coefficients = 0 
    214214      !!              linear eos function of T and S: rn_alpha and rn_beta<>0, other coefficients=0 
     
    216216      !! 
    217217      !!     ln_leos : linear ISOMIP equation of state 
    218       !!              prd(t,s,z) = ( -a0*(T-T0) + b0*(S-S0) ) / rau0 
     218      !!              prd(t,s,z) = ( -a0*(T-T0) + b0*(S-S0) ) / rho0 
    219219      !!              setup for ISOMIP linear eos 
    220220      !! 
     
    273273                  zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    274274                  ! 
    275                   prd(ji,jj,jk) = (  zn * r1_rau0 - 1._wp  ) * ztm  ! density anomaly (masked) 
     275                  prd(ji,jj,jk) = (  zn * r1_rho0 - 1._wp  ) * ztm  ! density anomaly (masked) 
    276276                  ! 
    277277               END DO 
     
    293293                     &  - rn_nu * zt * zs 
    294294                     !                                  
    295                   prd(ji,jj,jk) = zn * r1_rau0 * ztm                ! density anomaly (masked) 
     295                  prd(ji,jj,jk) = zn * r1_rho0 * ztm                ! density anomaly (masked) 
    296296               END DO 
    297297            END DO 
     
    308308                  ztm = tmask(ji,jj,jk) 
    309309                  ! 
    310                   zn =  rau0 * ( - rn_a0 * zt + rn_b0 * zs ) 
     310                  zn =  rho0 * ( - rn_a0 * zt + rn_b0 * zs ) 
    311311                  !                                  
    312                   prd(ji,jj,jk) = zn * r1_rau0 * ztm                ! density anomaly (masked) 
     312                  prd(ji,jj,jk) = zn * r1_rho0 * ztm                ! density anomaly (masked) 
    313313               END DO 
    314314            END DO 
     
    328328      !!                  ***  ROUTINE eos_insitu_pot  *** 
    329329      !! 
    330       !! ** Purpose :   Compute the in situ density (ratio rho/rau0) and the 
     330      !! ** Purpose :   Compute the in situ density (ratio rho/rho0) and the 
    331331      !!      potential volumic mass (Kg/m3) from potential temperature and 
    332332      !!      salinity fields using an equation of state selected in the 
     
    410410                        prhop(ji,jj,jk) = prhop(ji,jj,jk) + zn0_sto(jsmp)                      ! potential density referenced at the surface 
    411411                        ! 
    412                         prd(ji,jj,jk) = prd(ji,jj,jk) + (  zn_sto(jsmp) * r1_rau0 - 1._wp  )   ! density anomaly (masked) 
     412                        prd(ji,jj,jk) = prd(ji,jj,jk) + (  zn_sto(jsmp) * r1_rho0 - 1._wp  )   ! density anomaly (masked) 
    413413                     END DO 
    414414                     prhop(ji,jj,jk) = 0.5_wp * prhop(ji,jj,jk) * ztm / nn_sto_eos 
     
    454454                     prhop(ji,jj,jk) = zn0 * ztm                           ! potential density referenced at the surface 
    455455                     ! 
    456                      prd(ji,jj,jk) = (  zn * r1_rau0 - 1._wp  ) * ztm      ! density anomaly (masked) 
     456                     prd(ji,jj,jk) = (  zn * r1_rho0 - 1._wp  ) * ztm      ! density anomaly (masked) 
    457457                  END DO 
    458458               END DO 
     
    473473                     &  + rn_b0 * ( 1._wp - 0.5_wp*rn_lambda2*zs ) * zs   & 
    474474                     &  - rn_nu * zt * zs 
    475                   prhop(ji,jj,jk) = ( rau0 + zn ) * ztm 
     475                  prhop(ji,jj,jk) = ( rho0 + zn ) * ztm 
    476476                  !                                                     ! density anomaly (masked) 
    477477                  zn = zn - ( rn_a0 * rn_mu1 * zt + rn_b0 * rn_mu2 * zs ) * zh 
    478                   prd(ji,jj,jk) = zn * r1_rau0 * ztm 
     478                  prd(ji,jj,jk) = zn * r1_rho0 * ztm 
    479479                  ! 
    480480               END DO 
     
    492492                  ztm = tmask(ji,jj,jk) 
    493493                  !                                                     ! potential density referenced at the surface 
    494                   zn =  rau0 * ( - rn_a0 * zt + rn_b0 * zs ) 
    495                   prhop(ji,jj,jk) = ( rau0 + zn ) * ztm 
     494                  zn =  rho0 * ( - rn_a0 * zt + rn_b0 * zs ) 
     495                  prhop(ji,jj,jk) = ( rho0 + zn ) * ztm 
    496496                  !                                                     ! density anomaly (masked) 
    497                   prd(ji,jj,jk) = zn * r1_rau0 * ztm 
     497                  prd(ji,jj,jk) = zn * r1_rho0 * ztm 
    498498                  ! 
    499499               END DO 
     
    514514      !!                  ***  ROUTINE eos_insitu_2d  *** 
    515515      !! 
    516       !! ** Purpose :   Compute the in situ density (ratio rho/rau0) from 
     516      !! ** Purpose :   Compute the in situ density (ratio rho/rho0) from 
    517517      !!      potential temperature and salinity using an equation of state 
    518518      !!      selected in the nameos namelist. * 2D field case 
     
    569569               zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    570570               ! 
    571                prd(ji,jj) = zn * r1_rau0 - 1._wp               ! unmasked in situ density anomaly 
     571               prd(ji,jj) = zn * r1_rho0 - 1._wp               ! unmasked in situ density anomaly 
    572572               ! 
    573573            END DO 
     
    589589                  &  - rn_nu * zt * zs 
    590590                  ! 
    591                prd(ji,jj) = zn * r1_rau0               ! unmasked in situ density anomaly 
     591               prd(ji,jj) = zn * r1_rho0               ! unmasked in situ density anomaly 
    592592               ! 
    593593            END DO 
     
    605605               zh    = pdep (ji,jj)                         ! depth at the partial step level 
    606606               ! 
    607                zn =  rau0 * ( - rn_a0 * zt + rn_b0 * zs ) 
    608                   ! 
    609                prd(ji,jj) = zn * r1_rau0               ! unmasked in situ density anomaly 
     607               zn =  rho0 * ( - rn_a0 * zt + rn_b0 * zs ) 
     608                  ! 
     609               prd(ji,jj) = zn * r1_rho0               ! unmasked in situ density anomaly 
    610610               ! 
    611611            END DO 
     
    676676                  zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    677677                  ! 
    678                   pab(ji,jj,jk,jp_tem) = zn * r1_rau0 * ztm 
     678                  pab(ji,jj,jk,jp_tem) = zn * r1_rho0 * ztm 
    679679                  ! 
    680680                  ! beta 
     
    697697                  zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    698698                  ! 
    699                   pab(ji,jj,jk,jp_sal) = zn / zs * r1_rau0 * ztm 
     699                  pab(ji,jj,jk,jp_sal) = zn / zs * r1_rho0 * ztm 
    700700                  ! 
    701701               END DO 
     
    714714                  ! 
    715715                  zn  = rn_a0 * ( 1._wp + rn_lambda1*zt + rn_mu1*zh ) + rn_nu*zs 
    716                   pab(ji,jj,jk,jp_tem) = zn * r1_rau0 * ztm   ! alpha 
     716                  pab(ji,jj,jk,jp_tem) = zn * r1_rho0 * ztm   ! alpha 
    717717                  ! 
    718718                  zn  = rn_b0 * ( 1._wp - rn_lambda2*zs - rn_mu2*zh ) - rn_nu*zt 
    719                   pab(ji,jj,jk,jp_sal) = zn * r1_rau0 * ztm   ! beta 
     719                  pab(ji,jj,jk,jp_sal) = zn * r1_rho0 * ztm   ! beta 
    720720                  ! 
    721721               END DO 
     
    733733                  ztm = tmask(ji,jj,jk)                   ! land/sea bottom mask = surf. mask 
    734734                  ! 
    735                   zn  = rn_a0 * rau0 
    736                   pab(ji,jj,jk,jp_tem) = zn * r1_rau0 * ztm   ! alpha 
    737                   ! 
    738                   zn  = rn_b0 * rau0 
    739                   pab(ji,jj,jk,jp_sal) = zn * r1_rau0 * ztm   ! beta 
     735                  zn  = rn_a0 * rho0 
     736                  pab(ji,jj,jk,jp_tem) = zn * r1_rho0 * ztm   ! alpha 
     737                  ! 
     738                  zn  = rn_b0 * rho0 
     739                  pab(ji,jj,jk,jp_sal) = zn * r1_rho0 * ztm   ! beta 
    740740                  ! 
    741741               END DO 
     
    809809               zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    810810               ! 
    811                pab(ji,jj,jp_tem) = zn * r1_rau0 
     811               pab(ji,jj,jp_tem) = zn * r1_rho0 
    812812               ! 
    813813               ! beta 
     
    830830               zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    831831               ! 
    832                pab(ji,jj,jp_sal) = zn / zs * r1_rau0 
     832               pab(ji,jj,jp_sal) = zn / zs * r1_rho0 
    833833               ! 
    834834               ! 
     
    848848               ! 
    849849               zn  = rn_a0 * ( 1._wp + rn_lambda1*zt + rn_mu1*zh ) + rn_nu*zs 
    850                pab(ji,jj,jp_tem) = zn * r1_rau0   ! alpha 
     850               pab(ji,jj,jp_tem) = zn * r1_rho0   ! alpha 
    851851               ! 
    852852               zn  = rn_b0 * ( 1._wp - rn_lambda2*zs - rn_mu2*zh ) - rn_nu*zt 
    853                pab(ji,jj,jp_sal) = zn * r1_rau0   ! beta 
     853               pab(ji,jj,jp_sal) = zn * r1_rho0   ! beta 
    854854               ! 
    855855            END DO 
     
    867867               zh    = pdep (ji,jj)                   ! depth at the partial step level 
    868868               ! 
    869                zn  = rn_a0 * rau0 
    870                pab(ji,jj,jp_tem) = zn * r1_rau0   ! alpha 
    871                ! 
    872                zn  = rn_b0 * rau0 
    873                pab(ji,jj,jp_sal) = zn * r1_rau0   ! beta 
     869               zn  = rn_a0 * rho0 
     870               pab(ji,jj,jp_tem) = zn * r1_rho0   ! alpha 
     871               ! 
     872               zn  = rn_b0 * rho0 
     873               pab(ji,jj,jp_sal) = zn * r1_rho0   ! beta 
    874874               ! 
    875875            END DO 
     
    941941         zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    942942         ! 
    943          pab(jp_tem) = zn * r1_rau0 
     943         pab(jp_tem) = zn * r1_rho0 
    944944         ! 
    945945         ! beta 
     
    962962         zn  = ( ( zn3 * zh + zn2 ) * zh + zn1 ) * zh + zn0 
    963963         ! 
    964          pab(jp_sal) = zn / zs * r1_rau0 
     964         pab(jp_sal) = zn / zs * r1_rho0 
    965965         ! 
    966966         ! 
     
    973973         ! 
    974974         zn  = rn_a0 * ( 1._wp + rn_lambda1*zt + rn_mu1*zh ) + rn_nu*zs 
    975          pab(jp_tem) = zn * r1_rau0   ! alpha 
     975         pab(jp_tem) = zn * r1_rho0   ! alpha 
    976976         ! 
    977977         zn  = rn_b0 * ( 1._wp - rn_lambda2*zs - rn_mu2*zh ) - rn_nu*zt 
    978          pab(jp_sal) = zn * r1_rau0   ! beta 
     978         pab(jp_sal) = zn * r1_rho0   ! beta 
    979979         ! 
    980980      CASE( np_leos )                  !==  linear ISOMIP EOS  ==! 
     
    984984         zh    = pdep                    ! depth at the partial step level 
    985985         ! 
    986          zn  = rn_a0 * rau0 
    987          pab(jp_tem) = zn * r1_rau0   ! alpha 
    988          ! 
    989          zn  = rn_b0 * rau0 
    990          pab(jp_sal) = zn * r1_rau0   ! beta 
     986         zn  = rn_a0 * rho0 
     987         pab(jp_tem) = zn * r1_rho0   ! alpha 
     988         ! 
     989         zn  = rn_b0 * rho0 
     990         pab(jp_sal) = zn * r1_rho0   ! beta 
    991991         ! 
    992992      CASE DEFAULT 
     
    12141214      !! ** Method  :   PE is defined analytically as the vertical  
    12151215      !!                   primitive of EOS times -g integrated between 0 and z>0. 
    1216       !!                pen is the nonlinear bsq-PE anomaly: pen = ( PE - rau0 gz ) / rau0 gz - rd 
     1216      !!                pen is the nonlinear bsq-PE anomaly: pen = ( PE - rho0 gz ) / rho0 gz - rd 
    12171217      !!                                                      = 1/z * /int_0^z rd dz - rd  
    12181218      !!                                where rd is the density anomaly (see eos_rhd function) 
    12191219      !!                ab_pe are partial derivatives of PE anomaly with respect to T and S: 
    1220       !!                    ab_pe(1) = - 1/(rau0 gz) * dPE/dT + drd/dT = - d(pen)/dT 
    1221       !!                    ab_pe(2) =   1/(rau0 gz) * dPE/dS + drd/dS =   d(pen)/dS 
     1220      !!                    ab_pe(1) = - 1/(rho0 gz) * dPE/dT + drd/dT = - d(pen)/dT 
     1221      !!                    ab_pe(2) =   1/(rho0 gz) * dPE/dS + drd/dS =   d(pen)/dS 
    12221222      !! 
    12231223      !! ** Action  : - pen         : PE anomaly given at T-points 
     
    12671267                  zn  = ( zn2 * zh + zn1 ) * zh + zn0 
    12681268                  ! 
    1269                   ppen(ji,jj,jk)  = zn * zh * r1_rau0 * ztm 
     1269                  ppen(ji,jj,jk)  = zn * zh * r1_rho0 * ztm 
    12701270                  ! 
    12711271                  ! alphaPE non-linear anomaly 
     
    12821282                  zn  = ( zn2 * zh + zn1 ) * zh + zn0 
    12831283                  !                               
    1284                   pab_pe(ji,jj,jk,jp_tem) = zn * zh * r1_rau0 * ztm 
     1284                  pab_pe(ji,jj,jk,jp_tem) = zn * zh * r1_rho0 * ztm 
    12851285                  ! 
    12861286                  ! betaPE non-linear anomaly 
     
    12971297                  zn  = ( zn2 * zh + zn1 ) * zh + zn0 
    12981298                  !                               
    1299                   pab_pe(ji,jj,jk,jp_sal) = zn / zs * zh * r1_rau0 * ztm 
     1299                  pab_pe(ji,jj,jk,jp_sal) = zn / zs * zh * r1_rho0 * ztm 
    13001300                  ! 
    13011301               END DO 
     
    13121312                  zh  = gdept(ji,jj,jk,Kmm)              ! depth in meters  at t-point 
    13131313                  ztm = tmask(ji,jj,jk)                ! tmask 
    1314                   zn  = 0.5_wp * zh * r1_rau0 * ztm 
     1314                  zn  = 0.5_wp * zh * r1_rho0 * ztm 
    13151315                  !                                    ! Potential Energy 
    13161316                  ppen(ji,jj,jk) = ( rn_a0 * rn_mu1 * zt + rn_b0 * rn_mu2 * zs ) * zn 
     
    13321332                  zh  = gdept(ji,jj,jk,Kmm)                ! depth in meters  at t-point 
    13331333                  ztm = tmask(ji,jj,jk)                  ! tmask 
    1334                   zn  = 0.5_wp * zh * r1_rau0 * ztm 
     1334                  zn  = 0.5_wp * zh * r1_rho0 * ztm 
    13351335                  !                                    ! Potential Energy 
    13361336                  ppen(ji,jj,jk) = 0. 
     
    13791379      IF(lwm) WRITE( numond, nameos ) 
    13801380      ! 
    1381       rau0        = 1027.51_wp     !: volumic mass of reference     [kg/m3] 
     1381      rho0        = 1027.51_wp     !: volumic mass of reference     [kg/m3] 
    13821382      rcp         = 3974.00_wp     !: heat capacity     [J/K] 
    13831383      ! 
     
    17931793            WRITE(numout,*) '   ==>>>   use of simplified eos:    ' 
    17941794            WRITE(numout,*) '              rhd(dT=T-10,dS=S-35,Z) = [-a0*(1+lambda1/2*dT+mu1*Z)*dT ' 
    1795             WRITE(numout,*) '                                       + b0*(1+lambda2/2*dT+mu2*Z)*dS - nu*dT*dS] / rau0' 
     1795            WRITE(numout,*) '                                       + b0*(1+lambda2/2*dT+mu2*Z)*dS - nu*dT*dS] / rho0' 
    17961796            WRITE(numout,*) '              with the following coefficients :' 
    17971797            WRITE(numout,*) '                 thermal exp. coef.    rn_a0      = ', rn_a0 
     
    18101810            WRITE(numout,*) 
    18111811            WRITE(numout,*) '          use of linear ISOMIP eos:    rhd(dT=T-(-1),dS=S-(34.2),Z) = ' 
    1812             WRITE(numout,*) '             [ -a0*dT + b0*dS ]/rau0' 
     1812            WRITE(numout,*) '             [ -a0*dT + b0*dS ]/rho0' 
    18131813            WRITE(numout,*) 
    18141814            WRITE(numout,*) '             thermal exp. coef.    rn_a0      = ', rn_a0 
     
    18221822      END SELECT 
    18231823      ! 
    1824       rau0_rcp    = rau0 * rcp  
    1825       r1_rau0     = 1._wp / rau0 
     1824      rho0_rcp    = rho0 * rcp  
     1825      r1_rho0     = 1._wp / rho0 
    18261826      r1_rcp      = 1._wp / rcp 
    1827       r1_rau0_rcp = 1._wp / rau0_rcp  
     1827      r1_rho0_rcp = 1._wp / rho0_rcp  
    18281828      ! 
    18291829      IF(lwp) THEN 
     
    18401840      IF(lwp) WRITE(numout,*) 
    18411841      IF(lwp) WRITE(numout,*) '   Associated physical constant' 
    1842       IF(lwp) WRITE(numout,*) '      volumic mass of reference           rau0  = ', rau0   , ' kg/m^3' 
    1843       IF(lwp) WRITE(numout,*) '      1. / rau0                        r1_rau0  = ', r1_rau0, ' m^3/kg' 
     1842      IF(lwp) WRITE(numout,*) '      volumic mass of reference           rho0  = ', rho0   , ' kg/m^3' 
     1843      IF(lwp) WRITE(numout,*) '      1. / rho0                        r1_rho0  = ', r1_rho0, ' m^3/kg' 
    18441844      IF(lwp) WRITE(numout,*) '      ocean specific heat                 rcp   = ', rcp    , ' J/Kelvin' 
    1845       IF(lwp) WRITE(numout,*) '      rau0 * rcp                       rau0_rcp = ', rau0_rcp 
    1846       IF(lwp) WRITE(numout,*) '      1. / ( rau0 * rcp )           r1_rau0_rcp = ', r1_rau0_rcp 
     1845      IF(lwp) WRITE(numout,*) '      rho0 * rcp                       rho0_rcp = ', rho0_rcp 
     1846      IF(lwp) WRITE(numout,*) '      1. / ( rho0 * rcp )           r1_rho0_rcp = ', r1_rho0_rcp 
    18471847      ! 
    18481848   END SUBROUTINE eos_init 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ISOMIP+/MY_SRC/sbcfwb.F90

    r12353 r12724  
    122122            ! avoid the model to blow up for large ssh drop (isomip OCEAN3 with melt switch off and uniform T/S) 
    123123            IF (ln_isfcpl .AND. ln_isfcpl_cons) THEN 
    124                z_fwf = z_fwf + glob_sum( 'sbcfwb',  e1e2t(:,:) * risfcpl_cons_ssh(:,:) * rau0 ) 
     124               z_fwf = z_fwf + glob_sum( 'sbcfwb',  e1e2t(:,:) * risfcpl_cons_ssh(:,:) * rho0 ) 
    125125            END IF 
    126126            ! 
     
    151151         ENDIF    
    152152         !                                         ! Update fwfold if new year start 
    153          ikty = 365 * 86400 / rdt                  !!bug  use of 365 days leap year or 360d year !!!!!!! 
     153         ikty = 365 * 86400 / rn_Dt               !!bug  use of 365 days leap year or 360d year !!!!!!! 
    154154         IF( MOD( kt, ikty ) == 0 ) THEN 
    155155            a_fwb_b = a_fwb                           ! mean sea level taking into account the ice+snow 
    156156                                                      ! sum over the global domain 
    157             a_fwb   = glob_sum( 'sbcfwb', e1e2t(:,:) * ( ssh(:,:,Kmm) + snwice_mass(:,:) * r1_rau0 ) ) 
     157            a_fwb   = glob_sum( 'sbcfwb', e1e2t(:,:) * ( ssh(:,:,Kmm) + snwice_mass(:,:) * r1_rho0 ) ) 
    158158            a_fwb   = a_fwb * 1.e+3 / ( area * rday * 365. )     ! convert in Kg/m3/s = mm/s 
    159159!!gm        !                                                      !!bug 365d year  
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/ISOMIP/EXPREF/namelist_cfg

    r12377 r12724  
    4444!----------------------------------------------------------------------- 
    4545   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    46    rn_rdt      = 1800.     !  time step for the dynamics (and tracer if nn_acc=0) 
     46   rn_Dt      = 1800.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4747/ 
    4848!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_flux_cen2_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_flux_ubs_cfg

    r12377 r12724  
    4747   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    4848   ! 
    49    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     49   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    5050   rn_atfp     =    0.1    !  asselin time filter parameter 
    5151   ! 
     
    216216      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    217217         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    218          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    219          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     218         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     219         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    220220      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    221          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     221         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    222222/ 
    223223!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_vect_eenH_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_vect_een_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_vect_ene_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT2_vect_ens_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_flux_cen2_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_flux_ubs_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_vect_eenH_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_vect_een_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_vect_ene_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/EXPREF/namelist_FCT4_vect_ens_cfg

    r12377 r12724  
    3333   ln_linssh   = .false.   !  =T  linear free surface  ==>>  model level are fixed in time 
    3434   ! 
    35    rn_rdt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =    1.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737   ! 
     
    144144      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    145145         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    146          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    147          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     146         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     147         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    148148      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    149          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     149         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    150150/ 
    151151!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/LOCK_EXCHANGE/MY_SRC/usrdef_istate.F90

    r10074 r12724  
    6060      ! 
    6161      !  rn_a0 =  0.2   !  thermal expension coefficient (nn_eos= 1) 
    62       !  rho = rau0 - rn_a0 * (T-10)  
     62      !  rho = rho0 - rn_a0 * (T-10)  
    6363      !  delta_T = 25 degrees  ==>>  delta_rho = 25 * rn_a0 = 5 kg/m3 
    6464      ! 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_sco_FCT2_flux_cen-ahm1000_cfg

    r11848 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_sco_FCT2_flux_ubs_cfg

    r11848 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_sco_FCT4_flux_cen-ahm1000_cfg

    r10075 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_sco_FCT4_flux_ubs_cfg

    r11848 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_zps_FCT2_flux_ubs_cfg

    r11848 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_zps_FCT4_flux_ubs_cfg

    r12377 r12724  
    4646&namdom        !   time and space domain 
    4747!----------------------------------------------------------------------- 
    48    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     48   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    4949   rn_atfp     =    0.1    !  asselin time filter parameter 
    5050/ 
     
    216216      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    217217         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    218          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    219          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     218         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     219         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    220220      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    221          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     221         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    222222/ 
    223223!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/EXPREF/namelist_zps_FCT4_vect_een_cfg

    r11848 r12724  
    3333&namdom        !   space and time domain (bathymetry, mesh, timestep) 
    3434!----------------------------------------------------------------------- 
    35    rn_rdt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
     35   rn_Dt      =   10.     !  time step for the dynamics (and tracer if nn_acc=0) 
    3636   rn_atfp     =    0.1    !  asselin time filter parameter 
    3737/ 
     
    155155      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    156156         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    157          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    158          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     157         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     158         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    159159      ln_bt_auto    = .true.     ! Number of sub-step defined from: 
    160          nn_baro      =  1         ! =F : the number of sub-step in rn_rdt seconds 
     160         nn_e      =  1         ! =F : the number of sub-step in rn_Dt seconds 
    161161/ 
    162162!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/OVERFLOW/MY_SRC/usrdef_istate.F90

    r10074 r12724  
    6060      ! 
    6161      !  rn_a0 =  0.2   !  thermal expension coefficient (nn_eos= 1) 
    62       !  rho = rau0 - rn_a0 * (T-10)  
     62      !  rho = rho0 - rn_a0 * (T-10)  
    6363      !  delta_T = 10 degrees  ==>>  delta_rho = 10 * rn_a0 = 2 kg/m3 
    6464      ! 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/launch_sasf.sh

    r11996 r12724  
    22 
    33# NEMO directory where to fetch compiled STATION_ASF nemo.exe + setup: 
    4 NEMO_DIR="${HOME}/NEMO/NEMOvdev_r11085_ASINTER-05_Brodeau_Advanced_Bulk" 
     4NEMO_DIR=`pwd | sed -e "s|/tests/STATION_ASF/EXPREF||g"` 
     5 
     6echo "Using NEMO_DIR=${NEMO_DIR}" 
     7 
     8# what directory inside "tests" actually contains the compiled test-case? 
     9TC_DIR="STATION_ASF2" 
     10 
     11# => so the executable to use is: 
     12NEMO_EXE="${NEMO_DIR}/tests/${TC_DIR}/BLD/bin/nemo.exe" 
    513 
    614# Directory where to run the simulation: 
     
    2432mkdir -p ${WORK_DIR} 
    2533 
    26 NEMO_EXE="${NEMO_DIR}/tests/STATION_ASF/BLD/bin/nemo.exe" 
     34 
    2735if [ ! -f ${NEMO_EXE} ]; then echo " Mhhh, no compiled nemo.exe found into ${NEMO_DIR}/tests/STATION_ASF/BLD/bin !"; exit; fi 
    2836 
     
    4048rsync -avP ${FORC_DIR}/Station_PAPA_50N-145W*.nc ${WORK_DIR}/ 
    4149 
    42 for CASE in "ECMWF-noskin" "COARE3p6-noskin" "ECMWF" "COARE3p6" "NCAR"; do 
     50for CASE in "ECMWF" "COARE3p6" "NCAR" "ECMWF-noskin" "COARE3p6-noskin"; do 
    4351 
    4452    echo ; echo 
     
    5664    echo 
    5765    echo "Launching NEMO !" 
    58     ./nemo.exe 1> out_nemo.out 2>err_nemo.err 
     66    ./nemo.exe 1>out_nemo.out 2>err_nemo.err 
    5967    echo "Done!" 
    6068    echo 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/namelist_coare3p6-noskin_cfg

    r12249 r12724  
    3333   nn_time0    =       0   !  initial time of day in hhmm 
    3434   nn_leapy    =       0   !  Leap year calendar (1) or not (0) 
    35    ln_rstart   =  .false.   !  start from rest (F) or from a restart file (T) 
    36       nn_euler    =    1      !  = 0 : start with forward time step if ln_rstart=T 
     35   ln_rstart   = .false.   !  start from rest (F) or from a restart file (T) 
     36      ln_1st_euler = .false.  !  =T force a start with forward time step (ln_rstart=T) 
    3737      nn_rstctl   = 2      !  restart control ==> activated only if ln_rstart=T 
    3838      !                          !    = 0 nn_date0 read in namelist ; nn_it000 : read in namelist 
     
    5757&namdom        !   time and space domain / STATION_ASF 
    5858!----------------------------------------------------------------------- 
    59    rn_rdt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
     59   rn_Dt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
    6060   ln_meshmask = .false. 
    6161   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/namelist_coare3p6_cfg

    r12249 r12724  
    3333   nn_time0    =       0   !  initial time of day in hhmm 
    3434   nn_leapy    =       0   !  Leap year calendar (1) or not (0) 
    35    ln_rstart   =  .false.   !  start from rest (F) or from a restart file (T) 
    36       nn_euler    =    1      !  = 0 : start with forward time step if ln_rstart=T 
     35   ln_rstart   = .false.   !  start from rest (F) or from a restart file (T) 
     36      ln_1st_euler = .false.  !  =T force a start with forward time step (ln_rstart=T) 
    3737      nn_rstctl   = 2      !  restart control ==> activated only if ln_rstart=T 
    3838      !                          !    = 0 nn_date0 read in namelist ; nn_it000 : read in namelist 
     
    5757&namdom        !   time and space domain / STATION_ASF 
    5858!----------------------------------------------------------------------- 
    59    rn_rdt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
     59   rn_Dt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
    6060   ln_meshmask = .false. 
    6161   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/namelist_ecmwf-noskin_cfg

    r12249 r12724  
    3333   nn_time0    =       0   !  initial time of day in hhmm 
    3434   nn_leapy    =       0   !  Leap year calendar (1) or not (0) 
    35    ln_rstart   =  .false.   !  start from rest (F) or from a restart file (T) 
    36       nn_euler    =    1      !  = 0 : start with forward time step if ln_rstart=T 
     35   ln_rstart   = .false.   !  start from rest (F) or from a restart file (T) 
     36      ln_1st_euler = .false.  !  =T force a start with forward time step (ln_rstart=T) 
    3737      nn_rstctl   = 2      !  restart control ==> activated only if ln_rstart=T 
    3838      !                          !    = 0 nn_date0 read in namelist ; nn_it000 : read in namelist 
     
    5757&namdom        !   time and space domain / STATION_ASF 
    5858!----------------------------------------------------------------------- 
    59    rn_rdt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
     59   rn_Dt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
    6060   ln_meshmask = .false. 
    6161   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/namelist_ecmwf_cfg

    r12249 r12724  
    3333   nn_time0    =       0   !  initial time of day in hhmm 
    3434   nn_leapy    =       0   !  Leap year calendar (1) or not (0) 
    35    ln_rstart   =  .false.   !  start from rest (F) or from a restart file (T) 
    36       nn_euler    =    1      !  = 0 : start with forward time step if ln_rstart=T 
     35   ln_rstart   = .false.   !  start from rest (F) or from a restart file (T) 
     36      ln_1st_euler = .false.  !  =T force a start with forward time step (ln_rstart=T) 
    3737      nn_rstctl   = 2      !  restart control ==> activated only if ln_rstart=T 
    3838      !                          !    = 0 nn_date0 read in namelist ; nn_it000 : read in namelist 
     
    5757&namdom        !   time and space domain / STATION_ASF 
    5858!----------------------------------------------------------------------- 
    59    rn_rdt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
     59   rn_Dt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
    6060   ln_meshmask = .false. 
    6161   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/namelist_ncar_cfg

    r12249 r12724  
    3333   nn_time0    =       0   !  initial time of day in hhmm 
    3434   nn_leapy    =       0   !  Leap year calendar (1) or not (0) 
    35    ln_rstart   =  .false.   !  start from rest (F) or from a restart file (T) 
    36       nn_euler    =    1      !  = 0 : start with forward time step if ln_rstart=T 
     35   ln_rstart   = .false.   !  start from rest (F) or from a restart file (T) 
     36      ln_1st_euler = .false.  !  =T force a start with forward time step (ln_rstart=T) 
    3737      nn_rstctl   = 2      !  restart control ==> activated only if ln_rstart=T 
    3838      !                          !    = 0 nn_date0 read in namelist ; nn_it000 : read in namelist 
     
    5757&namdom        !   time and space domain / STATION_ASF 
    5858!----------------------------------------------------------------------- 
    59    rn_rdt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
     59   rn_Dt      =  3600.    !  time step for the dynamics and tracer => frequency of atmospheric forcing 
    6060   ln_meshmask = .false. 
    6161   ln_linssh   = .true.    !  =T  linear free surface  ==>>  model level are fixed in time 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/EXPREF/plot_station_asf.py

    r12031 r12724  
    5353L_VARL  = [ r'$Q_{lat}$', r'$Q_{sens}$' , r'$Q_{net}$' , r'$Q_{lw}$' , r'$|\tau|$' , r'$\Delta T_{skin}$' ] ; # name of variable in latex mode 
    5454L_VUNT  = [ r'$W/m^2$'  , r'$W/m^2$'    , r'$W/m^2$'   , r'$W/m^2$'  , r'$N/m^2$'  ,      'K'             ] 
    55 L_VMAX  = [     75.     ,     75.       ,    800.      ,     25.     ,    1.2      ,      -0.7            ] 
    56 L_VMIN  = [   -250.     ,   -125.       ,   -400.      ,   -150.     ,    0.       ,       0.7            ] 
     55L_VMAX  = [     75.     ,     75.       ,    800.      ,     25.     ,    1.2      ,       0.7            ] 
     56L_VMIN  = [   -250.     ,   -125.       ,   -400.      ,   -150.     ,    0.       ,      -0.7            ] 
    5757L_ANOM  = [   True      ,    True       ,    True      ,    True     ,   True      ,      False           ] 
    5858 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/diawri.F90

    r12353 r12724  
    3535   USE iom            ! 
    3636   USE ioipsl         ! 
     37 
    3738#if defined key_si3 
    3839   USE ice 
     
    5657 
    5758   !!---------------------------------------------------------------------- 
    58    !! NEMO/SAS 4.0 , NEMO Consortium (2018) 
    59    !! $Id: diawri.F90 10425 2018-12-19 21:54:16Z smasson $ 
     59   !! NEMO/OCE 4.0 , NEMO Consortium (2018) 
     60   !! $Id: diawri.F90 12493 2020-03-02 07:56:31Z smasson $ 
    6061   !! Software governed by the CeCILL license (see ./LICENSE) 
    6162   !!---------------------------------------------------------------------- 
     
    114115      INTEGER, DIMENSION(2) :: ierr 
    115116      !!---------------------------------------------------------------------- 
    116       ierr = 0 
    117       ALLOCATE( ndex_hT(jpi*jpj) , ndex_T(jpi*jpj*jpk) ,     & 
    118          &      ndex_hU(jpi*jpj) , ndex_U(jpi*jpj*jpk) ,     & 
    119          &      ndex_hV(jpi*jpj) , ndex_V(jpi*jpj*jpk) , STAT=ierr(1) ) 
    120       ! 
    121       dia_wri_alloc = MAXVAL(ierr) 
    122       CALL mpp_sum( 'diawri', dia_wri_alloc ) 
     117      IF( nn_write == -1 ) THEN 
     118         dia_wri_alloc = 0 
     119      ELSE 
     120         ierr = 0 
     121         ALLOCATE( ndex_hT(jpi*jpj) , ndex_T(jpi*jpj*jpk) ,     & 
     122            &      ndex_hU(jpi*jpj) , ndex_U(jpi*jpj*jpk) ,     & 
     123            &      ndex_hV(jpi*jpj) , ndex_V(jpi*jpj*jpk) , STAT=ierr(1) ) 
     124         ! 
     125         dia_wri_alloc = MAXVAL(ierr) 
     126         CALL mpp_sum( 'diawri', dia_wri_alloc ) 
     127         ! 
     128      ENDIF 
    123129      ! 
    124130   END FUNCTION dia_wri_alloc 
     
    168174      clop = "x"         ! no use of the mask value (require less cpu time and otherwise the model crashes) 
    169175#if defined key_diainstant 
    170       zsto = nn_write * rdt 
     176      zsto = nn_write * rn_Dt 
    171177      clop = "inst("//TRIM(clop)//")" 
    172178#else 
    173       zsto=rdt 
     179      zsto=rn_Dt 
    174180      clop = "ave("//TRIM(clop)//")" 
    175181#endif 
    176       zout = nn_write * rdt 
    177       zmax = ( nitend - nit000 + 1 ) * rdt 
     182      zout = nn_write * rn_Dt 
     183      zmax = ( nitend - nit000 + 1 ) * rn_Dt 
    178184 
    179185      ! Define indices of the horizontal output zoom and vertical limit storage 
     
    195201 
    196202         ! Compute julian date from starting date of the run 
    197          CALL ymds2ju( nyear, nmonth, nday, rdt, zjulian ) 
     203         CALL ymds2ju( nyear, nmonth, nday, rn_Dt, zjulian ) 
    198204         zjulian = zjulian - adatrj   !   set calendar origin to the beginning of the experiment 
    199205         IF(lwp)WRITE(numout,*) 
     
    217223         CALL histbeg( clhstnam, jpi, glamt, jpj, gphit,           &  ! Horizontal grid: glamt and gphit 
    218224            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    219             &          nit000-1, zjulian, rdt, nh_T, nid_T, domain_id=nidom, snc4chunks=snc4set ) 
     225            &          nit000-1, zjulian, rn_Dt, nh_T, nid_T, domain_id=nidom, snc4chunks=snc4set ) 
    220226         CALL histvert( nid_T, "deptht", "Vertical T levels",      &  ! Vertical grid: gdept 
    221227            &           "m", ipk, gdept_1d, nz_T, "down" ) 
     
    229235         CALL histbeg( clhstnam, jpi, glamu, jpj, gphiu,           &  ! Horizontal grid: glamu and gphiu 
    230236            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    231             &          nit000-1, zjulian, rdt, nh_U, nid_U, domain_id=nidom, snc4chunks=snc4set ) 
     237            &          nit000-1, zjulian, rn_Dt, nh_U, nid_U, domain_id=nidom, snc4chunks=snc4set ) 
    232238         CALL histvert( nid_U, "depthu", "Vertical U levels",      &  ! Vertical grid: gdept 
    233239            &           "m", ipk, gdept_1d, nz_U, "down" ) 
     
    241247         CALL histbeg( clhstnam, jpi, glamv, jpj, gphiv,           &  ! Horizontal grid: glamv and gphiv 
    242248            &          iimi, iima-iimi+1, ijmi, ijma-ijmi+1,       & 
    243             &          nit000-1, zjulian, rdt, nh_V, nid_V, domain_id=nidom, snc4chunks=snc4set ) 
     249            &          nit000-1, zjulian, rn_Dt, nh_V, nid_V, domain_id=nidom, snc4chunks=snc4set ) 
    244250         CALL histvert( nid_V, "depthv", "Vertical V levels",      &  ! Vertical grid : gdept 
    245251            &          "m", ipk, gdept_1d, nz_V, "down" ) 
     
    374380      CALL iom_rstput( 0, 0, inum, 'vozocrtx', uu(:,:,:,Kmm)                )    ! now i-velocity 
    375381      CALL iom_rstput( 0, 0, inum, 'vomecrty', vv(:,:,:,Kmm)                )    ! now j-velocity 
    376          CALL iom_rstput( 0, 0, inum, 'vovecrtz', ww             )    ! now k-velocity 
     382      CALL iom_rstput( 0, 0, inum, 'vovecrtz', ww             )    ! now k-velocity 
    377383      CALL iom_rstput( 0, 0, inum, 'sowaflup', emp - rnf         )    ! freshwater budget 
    378384      CALL iom_rstput( 0, 0, inum, 'sohefldo', qsr + qns         )    ! total heat flux 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/nemogcm.F90

    r12254 r12724  
    22   !!====================================================================== 
    33   !!                       ***  MODULE nemogcm   *** 
    4    !! StandAlone Surface module : surface fluxes 
     4   !!                      STATION_ASF (SAS meets C1D) 
    55   !!====================================================================== 
    66   !! History :  3.6  ! 2011-11  (S. Alderson, G. Madec) original code 
     
    1919   !!---------------------------------------------------------------------- 
    2020   USE step_oce       ! module used in the ocean time stepping module (step.F90) 
    21    USE sbc_oce        ! surface boundary condition: ocean #LB: rm? 
    2221   USE phycst         ! physical constant                  (par_cst routine) 
    2322   USE domain         ! domain initialization   (dom_init & dom_cfg routines) 
    2423   USE closea         ! treatment of closed seas (for ln_closea) 
    2524   USE usrdef_nam     ! user defined configuration 
     25   USE istate         ! initial state setting          (istate_init routine) 
    2626   USE step, ONLY : Nbb, Nnn, Naa, Nrhs ! time level indices 
    2727   USE daymod         ! calendar 
    2828   USE restart        ! open  restart file 
    29    !LB:USE step           ! NEMO time-stepping                 (stp     routine) 
    3029   USE c1d            ! 1D configuration 
    3130   USE step_c1d       ! Time stepping loop for the 1D configuration 
    32    USE sbcssm         ! 
    3331   ! 
     32   USE in_out_manager ! I/O manager 
    3433   USE lib_mpp        ! distributed memory computing 
    3534   USE mppini         ! shared/distributed memory setting (mpp_init routine) 
     
    4948   !!---------------------------------------------------------------------- 
    5049   !! NEMO/OCE 4.0 , NEMO Consortium (2018) 
    51    !! $Id: nemogcm.F90 11536 2019-09-11 13:54:18Z smasson $ 
     50   !! $Id: nemogcm.F90 12489 2020-02-28 15:55:11Z davestorkey $ 
    5251   !! Software governed by the CeCILL license (see ./LICENSE) 
    5352   !!---------------------------------------------------------------------- 
     
    8483      !                            !==   time stepping   ==! 
    8584      !                            !-----------------------! 
     85      ! 
     86      !                                               !== set the model time-step  ==! 
     87      ! 
    8688      istp = nit000 
    8789      ! 
     
    106108      ! 
    107109#if defined key_iomput 
    108       CALL xios_finalize  ! end mpp communications with xios 
     110                                    CALL xios_finalize  ! end mpp communications with xios 
    109111#else 
    110       IF( lk_mpp   ) THEN   ;   CALL mppstop      ! end mpp communications 
    111       ENDIF 
     112      IF( lk_mpp )                  CALL mppstop      ! end mpp communications 
    112113#endif 
    113114      ! 
     
    161162      IF( lwm )   CALL ctl_opn(     numout,        'ocean.output', 'REPLACE', 'FORMATTED', 'SEQUENTIAL', -1, -1, .FALSE. ) 
    162163      ! open reference and configuration namelist files 
    163       CALL load_nml( numnam_ref,        'namelist_ref',                                           -1, lwm ) 
    164       CALL load_nml( numnam_cfg,        'namelist_cfg',                                           -1, lwm ) 
     164                  CALL load_nml( numnam_ref,        'namelist_ref',                                           -1, lwm ) 
     165                  CALL load_nml( numnam_cfg,        'namelist_cfg',                                           -1, lwm ) 
    165166      IF( lwm )   CALL ctl_opn(     numond, 'output.namelist.dyn', 'REPLACE', 'FORMATTED', 'SEQUENTIAL', -1, -1, .FALSE. ) 
    166167      ! open /dev/null file to be able to supress output write easily 
    167       CALL ctl_opn(     numnul,           '/dev/null', 'REPLACE', 'FORMATTED', 'SEQUENTIAL', -1, -1, .FALSE. ) 
     168      IF( Agrif_Root() ) THEN 
     169                  CALL ctl_opn(     numnul,           '/dev/null', 'REPLACE', 'FORMATTED', 'SEQUENTIAL', -1, -1, .FALSE. ) 
     170#ifdef key_agrif 
     171      ELSE 
     172                  numnul = Agrif_Parent(numnul)    
     173#endif 
     174      ENDIF 
    168175      ! 
    169176      !                             !--------------------! 
     
    235242903   IF( ios /= 0 )   CALL ctl_nam ( ios , 'namcfg in reference namelist' ) 
    236243      READ  ( numnam_cfg, namcfg, IOSTAT = ios, ERR = 904 ) 
    237 904   IF( ios >  0 )   CALL ctl_nam ( ios , 'namcfg in configuration namelist' ) 
     244904   IF( ios >  0 )   CALL ctl_nam ( ios , 'namcfg in configuration namelist' )    
    238245      ! 
    239246      IF( ln_read_cfg ) THEN            ! Read sizes in domain configuration file 
     
    266273      IF( ln_timing    )   CALL timing_start( 'nemo_init') 
    267274      ! 
    268       CALL     phy_cst         ! Physical constants 
    269       CALL     eos_init        ! Equation of state 
     275                           CALL     phy_cst         ! Physical constants 
     276                           CALL     eos_init        ! Equation of state 
    270277      IF( lk_c1d       )   CALL     c1d_init        ! 1D column configuration 
    271       CALL     dom_init( Nbb, Nnn, Naa, "OPA") ! Domain 
     278                           CALL     dom_init( Nbb, Nnn, Naa, "OPA") ! Domain 
    272279      IF( sn_cfctl%l_prtctl )   & 
    273280         &                 CALL prt_ctl_init        ! Print control 
    274  
    275       IF( ln_rstart ) THEN                    ! Restart from a file                                                                                  
    276          !                                    ! -------------------                                                                                  
    277          CALL rst_read( Nbb, Nnn )            ! Read the restart file                                                                                
    278          CALL day_init                        ! model calendar (using both namelist and restart infos)                                               
    279          !                                                                                                                                           
    280       ELSE                                    ! Start from rest                                                                                      
    281          !                                    ! ---------------                                                                                      
    282          numror = 0                           ! define numror = 0 -> no restart file to read                                                         
    283          neuler = 0                           ! Set time-step indicator at nit000 (euler forward)                                                    
    284          CALL day_init                        ! model calendar (using both namelist and restart infos)                                               
    285       ENDIF 
    286       ! 
    287  
    288       !                                      ! external forcing 
    289       CALL     sbc_init( Nbb, Nnn, Naa )    ! surface boundary conditions (including sea-ice) 
     281      ! 
     282       
     283                           CALL  istate_init( Nbb, Nnn, Naa )    ! ocean initial state (Dynamics and tracers) 
     284 
     285      !                                      ! external forcing  
     286                           CALL     sbc_init( Nbb, Nnn, Naa )    ! surface boundary conditions (including sea-ice) 
    290287 
    291288      ! 
     
    321318         WRITE(numout,*) '                              sn_cfctl%l_prttrc  = ', sn_cfctl%l_prttrc 
    322319         WRITE(numout,*) '                              sn_cfctl%l_oasout  = ', sn_cfctl%l_oasout 
    323          WRITE(numout,*) '                              sn_cfctl%procmin   = ', sn_cfctl%procmin 
    324          WRITE(numout,*) '                              sn_cfctl%procmax   = ', sn_cfctl%procmax 
    325          WRITE(numout,*) '                              sn_cfctl%procincr  = ', sn_cfctl%procincr 
    326          WRITE(numout,*) '                              sn_cfctl%ptimincr  = ', sn_cfctl%ptimincr 
     320         WRITE(numout,*) '                              sn_cfctl%procmin   = ', sn_cfctl%procmin   
     321         WRITE(numout,*) '                              sn_cfctl%procmax   = ', sn_cfctl%procmax   
     322         WRITE(numout,*) '                              sn_cfctl%procincr  = ', sn_cfctl%procincr  
     323         WRITE(numout,*) '                              sn_cfctl%ptimincr  = ', sn_cfctl%ptimincr  
    327324         WRITE(numout,*) '      level of print                  nn_print   = ', nn_print 
    328325         WRITE(numout,*) '      Start i indice for SUM control  nn_ictls   = ', nn_ictls 
     
    439436      !!---------------------------------------------------------------------- 
    440437      ! 
    441       ierr =        oce_alloc    ()    ! ocean 
     438      ierr =        oce_alloc    ()    ! ocean  
    442439      ierr = ierr + dia_wri_alloc() 
    443440      ierr = ierr + dom_oce_alloc()    ! ocean domain 
     
    448445   END SUBROUTINE nemo_alloc 
    449446 
    450  
     447    
    451448   SUBROUTINE nemo_set_cfctl(sn_cfctl, setto, for_all ) 
    452449      !!---------------------------------------------------------------------- 
     
    479476   !!====================================================================== 
    480477END MODULE nemogcm 
     478 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/sbcssm.F90

    r12249 r12724  
    5454   !!---------------------------------------------------------------------- 
    5555   !! NEMO/SAS 4.0 , NEMO Consortium (2018) 
    56    !! $Id: sbcssm.F90 10068 2018-08-28 14:09:04Z nicolasmartin $ 
     56   !! $Id: sbcssm.F90 12615 2020-03-26 15:18:49Z laurent $ 
    5757   !! Software governed by the CeCILL license (see ./LICENSE) 
    5858   !!---------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/usrdef_hgr.F90

    r11930 r12724  
    1414   !!   usr_def_hgr   : initialize the horizontal mesh  
    1515   !!---------------------------------------------------------------------- 
    16    USE dom_oce  , ONLY: nimpp, njmpp        ! ocean space and time domain 
     16   USE dom_oce  , ONLY: nimpp, njmpp       ! ocean space and time domain 
    1717   USE c1d      ,  ONLY: rn_lon1d, rn_lat1d ! ocean lon/lat define by namelist 
    1818   USE par_oce        ! ocean space and time domain 
     
    3030   !!---------------------------------------------------------------------- 
    3131   !! NEMO/OCE 4.0 , NEMO Consortium (2018) 
    32    !! $Id: usrdef_hgr.F90 10072 2018-08-28 15:21:50Z nicolasmartin $ 
     32   !! $Id: usrdef_hgr.F90 12489 2020-02-28 15:55:11Z davestorkey $  
    3333   !! Software governed by the CeCILL license (see ./LICENSE) 
    3434   !!---------------------------------------------------------------------- 
     
    5454      !! 
    5555      !! ** Action  : - define longitude & latitude of t-, u-, v- and f-points (in degrees)  
    56       !!              - define coriolis parameter at f-point if the domain in not on the sphere 
     56      !!              - define coriolis parameter at f-point if the domain in not on the sphere (on beta-plane) 
    5757      !!              - define i- & j-scale factors at t-, u-, v- and f-points (in meters) 
    5858      !!              - define u- & v-surfaces (if gridsize reduction is used in some straits) (in m2) 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/usrdef_nam.F90

    r12249 r12724  
    88   !!====================================================================== 
    99   !! History :  4.0  ! 2016-03  (S. Flavoni, G. Madec)  Original code 
    10    !! History :  4.x  ! 2019-10  (L. Brodeau) for STATION_ASF (C1D meets SAS) 
     10   !!            4.x  ! 2019-10  (L. Brodeau) for STATION_ASF (C1D meets SAS) 
    1111   !!---------------------------------------------------------------------- 
    1212 
     
    1515   !!   usr_def_hgr   : initialize the horizontal mesh  
    1616   !!---------------------------------------------------------------------- 
    17    USE dom_oce  , ONLY: nimpp, njmpp             ! ocean space and time domain 
    18    USE dom_oce  , ONLY: ln_zco, ln_zps, ln_sco   ! flag of type of coordinate 
     17   USE dom_oce  , ONLY: nimpp, njmpp       ! ocean space and time domain 
     18!!!   USE dom_oce  , ONLY: ln_zco, ln_zps, ln_sco   ! flag of type of coordinate 
    1919   USE par_oce        ! ocean space and time domain 
    2020   USE phycst         ! physical constants 
     
    3333   !!---------------------------------------------------------------------- 
    3434   !! NEMO/OCE 4.0 , NEMO Consortium (2018) 
    35    !! $Id: usrdef_nam.F90 11536 2019-09-11 13:54:18Z smasson $  
     35   !! $Id: usrdef_nam.F90 12377 2020-02-12 14:39:06Z acc $  
    3636   !! Software governed by the CeCILL license (see ./LICENSE) 
    3737   !!---------------------------------------------------------------------- 
     
    6868      kk_cfg = 0 
    6969 
    70       ! Global Domain size: STATION_ASF domain is 3 x 3 grid-points x 75 or vertical levels 
     70      ! Global Domain size: STATION_ASF domain is 3 x 3 grid-points x 2 or vertical levels 
    7171      kpi = 3 
    7272      kpj = 3 
    73       kpk = 1 
     73      kpk = 2    ! 2, rather than 1, because 1 would cause some issues... like overflow in array boundary indexes, etc... 
    7474      ! 
    7575      !                             ! Set the lateral boundary condition of the global domain 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/STATION_ASF/MY_SRC/usrdef_zgr.F90

    r12038 r12724  
    11MODULE usrdef_zgr 
    22   !!====================================================================== 
    3    !!                     ***  MODULE usrdef_zgr  *** 
     3   !!                       ***  MODULE usrdef_zgr  *** 
    44   !! 
    55   !!                       ===  STATION_ASF case  === 
    66   !! 
    7    !! user defined : vertical coordinate system of a user configuration 
     7   !! User defined : vertical coordinate system of a user configuration 
    88   !!====================================================================== 
    9    !! History :  4.0  ! 2019-10  (L. Brodeau)  Original code 
     9   !! History :  4.0  ! 2016-06  (G. Madec)  Original code 
     10   !!            4.x  ! 2019-10  (L. Brodeau) Station ASF 
    1011   !!---------------------------------------------------------------------- 
    1112 
    1213   !!---------------------------------------------------------------------- 
    13    !!   usr_def_zgr   : user defined vertical coordinate system (required) 
     14   !!   usr_def_zgr   : user defined vertical coordinate system 
     15   !!      zgr_z      : reference 1D z-coordinate  
     16   !!      zgr_top_bot: ocean top and bottom level indices 
     17   !!      zgr_zco    : 3D verticl coordinate in pure z-coordinate case 
    1418   !!--------------------------------------------------------------------- 
    1519   USE oce            ! ocean variables 
    16    !USE dom_oce        ! ocean domain 
    17    !USE depth_e3       ! depth <=> e3 
    1820   USE usrdef_nam     ! User defined : namelist variables 
    1921   ! 
     
    2123   USE lbclnk         ! ocean lateral boundary conditions (or mpp link) 
    2224   USE lib_mpp        ! distributed memory computing library 
    23    USE timing         ! Timing 
    2425 
    2526   IMPLICIT NONE 
    2627   PRIVATE 
    2728 
    28    PUBLIC   usr_def_zgr   ! called by domzgr.F90 
     29   PUBLIC   usr_def_zgr        ! called by domzgr.F90 
    2930 
    3031   !!---------------------------------------------------------------------- 
    3132   !! NEMO/OCE 4.0 , NEMO Consortium (2018) 
    32    !! $Id: usrdef_zgr.F90 10072 2018-08-28 15:21:50Z nicolasmartin $ 
     33   !! $Id: usrdef_zgr.F90 12377 2020-02-12 14:39:06Z acc $ 
    3334   !! Software governed by the CeCILL license (see ./LICENSE) 
    3435   !!---------------------------------------------------------------------- 
     
    4748      !! 
    4849      !!---------------------------------------------------------------------- 
    49       LOGICAL                   , INTENT(  out) ::   ld_zco, ld_zps, ld_sco      ! vertical coordinate flags ( read in namusr_def ) 
    50       LOGICAL                   , INTENT(  out) ::   ld_isfcav                   ! under iceshelf cavity flag 
    51       REAL(wp), DIMENSION(:)    , INTENT(  out) ::   pdept_1d, pdepw_1d          ! 1D grid-point depth     [m] 
    52       REAL(wp), DIMENSION(:)    , INTENT(  out) ::   pe3t_1d , pe3w_1d           ! 1D grid-point depth     [m] 
    53       REAL(wp), DIMENSION(:,:,:), INTENT(  out) ::   pdept, pdepw                ! grid-point depth        [m] 
    54       REAL(wp), DIMENSION(:,:,:), INTENT(  out) ::   pe3t , pe3u , pe3v , pe3f   ! vertical scale factors  [m] 
    55       REAL(wp), DIMENSION(:,:,:), INTENT(  out) ::   pe3w , pe3uw, pe3vw         ! i-scale factors 
    56       INTEGER , DIMENSION(:,:)  , INTENT(  out) ::   k_top, k_bot                ! first & last ocean level 
     50      LOGICAL                   , INTENT(out) ::   ld_zco, ld_zps, ld_sco      ! vertical coordinate flags 
     51      LOGICAL                   , INTENT(out) ::   ld_isfcav                   ! under iceshelf cavity flag 
     52      REAL(wp), DIMENSION(:)    , INTENT(out) ::   pdept_1d, pdepw_1d          ! 1D grid-point depth     [m] 
     53      REAL(wp), DIMENSION(:)    , INTENT(out) ::   pe3t_1d , pe3w_1d           ! 1D grid-point depth     [m] 
     54      REAL(wp), DIMENSION(:,:,:), INTENT(out) ::   pdept, pdepw                ! grid-point depth        [m] 
     55      REAL(wp), DIMENSION(:,:,:), INTENT(out) ::   pe3t , pe3u , pe3v , pe3f   ! vertical scale factors  [m] 
     56      REAL(wp), DIMENSION(:,:,:), INTENT(out) ::   pe3w , pe3uw, pe3vw         ! i-scale factors  
     57      INTEGER , DIMENSION(:,:)  , INTENT(out) ::   k_top, k_bot                ! first & last ocean level 
    5758      !!---------------------------------------------------------------------- 
    5859      ! 
     
    6162      IF(lwp) WRITE(numout,*) '~~~~~~~~~~~' 
    6263      ! 
    63  
     64      ! 
     65      ! type of vertical coordinate 
     66      ! --------------------------- 
    6467      ld_zco    = .TRUE.         ! z-coordinate without ocean cavities 
    6568      ld_zps    = .FALSE. 
    6669      ld_sco    = .FALSE. 
    6770      ld_isfcav = .FALSE. 
    68        
     71 
     72      !! 1st level (the only one that matters) 
    6973      pdept_1d(1) = rn_dept1 ! depth (m) at which the SST is taken/measured == depth of first T point! 
    7074      pdepw_1d(1) = 0._wp 
     
    7276      pe3w_1d(1)  = rn_dept1 ! LB??? 
    7377 
    74       pdept(:,:,:) = rn_dept1 
    75       pdepw(:,:,:) = 0._wp 
    76       pe3t(:,:,:) = 2._wp*rn_dept1 
    77       pe3u(:,:,:) = 2._wp*rn_dept1 
    78       pe3v(:,:,:) = 2._wp*rn_dept1 
    79       pe3f(:,:,:) = 2._wp*rn_dept1 
    80       pe3w(:,:,:)  = rn_dept1  ! LB??? 
    81       pe3uw(:,:,:) = rn_dept1  ! LB??? 
    82       pe3vw(:,:,:) = rn_dept1  ! LB??? 
     78      pdept(:,:,1) = rn_dept1 
     79      pdepw(:,:,1) = 0._wp 
     80      pe3t(:,:,1) = 2._wp*rn_dept1 
     81      pe3u(:,:,1) = 2._wp*rn_dept1 
     82      pe3v(:,:,1) = 2._wp*rn_dept1 
     83      pe3f(:,:,1) = 2._wp*rn_dept1 
     84      pe3w(:,:,1)  = rn_dept1  ! LB??? 
     85      pe3uw(:,:,1) = rn_dept1  ! LB??? 
     86      pe3vw(:,:,1) = rn_dept1  ! LB??? 
     87       
     88      !! 2nd level, technically useless (only for the sake of code stability) 
     89      pdept_1d(2) = 3._wp*rn_dept1 
     90      pdepw_1d(2) = 2._wp*rn_dept1 
     91      pe3t_1d(2)  = 2._wp*rn_dept1 
     92      pe3w_1d(2)  = 2._wp*rn_dept1 
     93 
     94      pdept(:,:,2) = 3._wp*rn_dept1 
     95      pdepw(:,:,2) = 2._wp*rn_dept1 
     96      pe3t(:,:,2) = 2._wp*rn_dept1 
     97      pe3u(:,:,2) = 2._wp*rn_dept1 
     98      pe3v(:,:,2) = 2._wp*rn_dept1 
     99      pe3f(:,:,2) = 2._wp*rn_dept1 
     100      pe3w(:,:,2)  = 2._wp*rn_dept1 
     101      pe3uw(:,:,2) = 2._wp*rn_dept1 
     102      pe3vw(:,:,2) = 2._wp*rn_dept1 
     103 
    83104      k_top = 1 
    84105      k_bot = 1 
    85       ! 
     106 
    86107   END SUBROUTINE usr_def_zgr 
    87108   !!====================================================================== 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/VORTEX/EXPREF/1_namelist_cfg

    r12377 r12724  
    4040!----------------------------------------------------------------------- 
    4141   ln_linssh   =  .false.  !  =T  linear free surface  ==>>  model level are fixed in time 
    42    rn_rdt      =    480.   !  time step for the dynamics (and tracer if nn_acc=0) 
     42   rn_Dt      =    480.   !  time step for the dynamics (and tracer if nn_acc=0) 
    4343   rn_atfp     =   0.05    !  asselin time filter parameter 
    4444/ 
     
    213213      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    214214         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    215          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    216          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     215         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     216         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    217217      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    218          nn_baro      =  24         ! =F : the number of sub-step in rn_rdt seconds 
     218         nn_e      =  24         ! =F : the number of sub-step in rn_Dt seconds 
    219219/ 
    220220!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/VORTEX/EXPREF/namelist_cfg

    r12377 r12724  
    4040!----------------------------------------------------------------------- 
    4141   ln_linssh   =  .false.  !  =T  linear free surface  ==>>  model level are fixed in time 
    42    rn_rdt      =   1440.   !  time step for the dynamics (and tracer if nn_acc=0) 
     42   rn_Dt      =   1440.   !  time step for the dynamics (and tracer if nn_acc=0) 
    4343   rn_atfp     =   0.05    !  asselin time filter parameter 
    4444/ 
     
    204204      ln_bt_av      = .true.     ! Time filtering of barotropic variables 
    205205         nn_bt_flt     = 1          ! Time filter choice  = 0 None 
    206          !                          !                     = 1 Boxcar over   nn_baro sub-steps 
    207          !                          !                     = 2 Boxcar over 2*nn_baro  "    " 
     206         !                          !                     = 1 Boxcar over   nn_e sub-steps 
     207         !                          !                     = 2 Boxcar over 2*nn_e  "    " 
    208208      ln_bt_auto    = .false.    ! Number of sub-step defined from: 
    209          nn_baro      =  24         ! =F : the number of sub-step in rn_rdt seconds 
     209         nn_e      =  24         ! =F : the number of sub-step in rn_Dt seconds 
    210210/ 
    211211!----------------------------------------------------------------------- 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/VORTEX/MY_SRC/domvvl.F90

    r12377 r12724  
    237237         IF( ln_vvl_ztilde_as_zstar ) THEN   ! z-star emulation using z-tile 
    238238            frq_rst_e3t(:,:) = 0._wp               !Ignore namelist settings 
    239             frq_rst_hdv(:,:) = 1._wp / rdt 
     239            frq_rst_hdv(:,:) = 1._wp / rn_Dt 
    240240         ENDIF 
    241241         IF ( ln_vvl_zstar_at_eqtor ) THEN   ! use z-star in vicinity of the Equator 
     
    250250                     ! values inside the equatorial band (ztilde as zstar) 
    251251                     frq_rst_e3t(ji,jj) =  0.0_wp 
    252                      frq_rst_hdv(ji,jj) =  1.0_wp / rdt 
     252                     frq_rst_hdv(ji,jj) =  1.0_wp / rn_Dt 
    253253                  ELSE                                      ! transition band (2.5 to 6 degrees N/S) 
    254254                     !                                      ! (linearly transition from z-tilde to z-star) 
     
    256256                        &            * (  1.0_wp - COS( rad*(ABS(gphit(ji,jj))-2.5_wp)  & 
    257257                        &                                          * 180._wp / 3.5_wp ) ) 
    258                      frq_rst_hdv(ji,jj) = (1.0_wp / rdt)                                & 
    259                         &            + (  frq_rst_hdv(ji,jj)-(1.e0_wp / rdt) )*0.5_wp   & 
     258                     frq_rst_hdv(ji,jj) = (1.0_wp / rn_Dt)                                & 
     259                        &            + (  frq_rst_hdv(ji,jj)-(1.e0_wp / rn_Dt) )*0.5_wp   & 
    260260                        &            * (  1._wp  - COS( rad*(ABS(gphit(ji,jj))-2.5_wp)  & 
    261261                        &                                          * 180._wp / 3.5_wp ) ) 
     
    268268                  ij0 = 128   ;   ij1 = 135   ;    
    269269                  frq_rst_e3t( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  0.0_wp 
    270                   frq_rst_hdv( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  1.e0_wp / rdt 
     270                  frq_rst_hdv( mi0(ii0):mi1(ii1) , mj0(ij0):mj1(ij1) ) =  1.e0_wp / rn_Dt 
    271271               ENDIF 
    272272            ENDIF 
     
    323323      INTEGER                ::   ji, jj, jk            ! dummy loop indices 
    324324      INTEGER , DIMENSION(3) ::   ijk_max, ijk_min      ! temporary integers 
    325       REAL(wp)               ::   z2dt, z_tmin, z_tmax  ! local scalars 
     325      REAL(wp)               ::   z_tmin, z_tmax        ! local scalars 
    326326      LOGICAL                ::   ll_do_bclinic         ! local logical 
    327327      REAL(wp), DIMENSION(jpi,jpj)     ::   zht, z_scale, zwu, zwv, zhdiv 
     
    377377            IF( kt > nit000 ) THEN 
    378378               DO jk = 1, jpkm1 
    379                   hdiv_lf(:,:,jk) = hdiv_lf(:,:,jk) - rdt * frq_rst_hdv(:,:)   & 
     379                  hdiv_lf(:,:,jk) = hdiv_lf(:,:,jk) - rn_Dt * frq_rst_hdv(:,:)   & 
    380380                     &          * ( hdiv_lf(:,:,jk) - e3t(:,:,jk,Kmm) * ( hdiv(:,:,jk) - zhdiv(:,:) ) ) 
    381381               END DO 
     
    446446         ! Leapfrog time stepping 
    447447         ! ~~~~~~~~~~~~~~~~~~~~~~ 
    448          IF( neuler == 0 .AND. kt == nit000 ) THEN 
    449             z2dt =  rdt 
    450          ELSE 
    451             z2dt = 2.0_wp * rdt 
    452          ENDIF 
    453448         CALL lbc_lnk( 'domvvl', tilde_e3t_a(:,:,:), 'T', 1._wp ) 
    454          tilde_e3t_a(:,:,:) = tilde_e3t_b(:,:,:) + z2dt * tmask(:,:,:) * tilde_e3t_a(:,:,:) 
     449         tilde_e3t_a(:,:,:) = tilde_e3t_b(:,:,:) + rDt * tmask(:,:,:) * tilde_e3t_a(:,:,:) 
    455450 
    456451         ! Maximum deformation control 
     
    638633      ! - ML - e3(t/u/v)_b are allready computed in dynnxt. 
    639634      IF( ln_vvl_ztilde .OR. ln_vvl_layer ) THEN 
    640          IF( neuler == 0 .AND. kt == nit000 ) THEN 
     635         IF( l_1st_euler ) THEN 
    641636            tilde_e3t_b(:,:,:) = tilde_e3t_n(:,:,:) 
    642637         ELSE 
    643638            tilde_e3t_b(:,:,:) = tilde_e3t_n(:,:,:) &  
    644             &         + atfp * ( tilde_e3t_b(:,:,:) - 2.0_wp * tilde_e3t_n(:,:,:) + tilde_e3t_a(:,:,:) ) 
     639            &         + rn_atfp * ( tilde_e3t_b(:,:,:) - 2.0_wp * tilde_e3t_n(:,:,:) + tilde_e3t_a(:,:,:) ) 
    645640         ENDIF 
    646641         tilde_e3t_n(:,:,:) = tilde_e3t_a(:,:,:) 
     
    849844                  e3t(:,:,:,Kbb) = e3t_0(:,:,:) 
    850845               END WHERE 
    851                IF( neuler == 0 ) THEN 
     846               IF( l_1st_euler ) THEN 
    852847                  e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    853848               ENDIF 
     
    855850               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kmm) not found in restart files' 
    856851               IF(lwp) write(numout,*) 'e3t_n set equal to e3t_b.' 
    857                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     852               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    858853               CALL iom_get( numror, jpdom_autoglo, 'e3t_b', e3t(:,:,:,Kbb), ldxios = lrxios ) 
    859854               e3t(:,:,:,Kmm) = e3t(:,:,:,Kbb) 
    860                neuler = 0 
     855               l_1st_euler = .true. 
    861856            ELSE IF( id2 > 0 ) THEN 
    862857               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kbb) not found in restart files' 
    863858               IF(lwp) write(numout,*) 'e3t_b set equal to e3t_n.' 
    864                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     859               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    865860               CALL iom_get( numror, jpdom_autoglo, 'e3t_n', e3t(:,:,:,Kmm), ldxios = lrxios ) 
    866861               e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    867                neuler = 0 
     862               l_1st_euler = .true. 
    868863            ELSE 
    869864               IF(lwp) write(numout,*) 'dom_vvl_rst WARNING : e3t(:,:,:,Kmm) not found in restart file' 
    870865               IF(lwp) write(numout,*) 'Compute scale factor from sshn' 
    871                IF(lwp) write(numout,*) 'neuler is forced to 0' 
     866               IF(lwp) write(numout,*) 'l_1st_euler is forced to .true.' 
    872867               DO jk = 1, jpk 
    873868                  e3t(:,:,jk,Kmm) =  e3t_0(:,:,jk) * ( ht_0(:,:) + ssh(:,:,Kmm) ) & 
     
    876871               END DO 
    877872               e3t(:,:,:,Kbb) = e3t(:,:,:,Kmm) 
    878                neuler = 0 
     873               l_1st_euler = .true. 
    879874            ENDIF 
    880875            !                             ! ----------- ! 
     
    10391034            WRITE(numout,*) '                         rn_rst_e3t     = 0.e0' 
    10401035            WRITE(numout,*) '            hard-wired : z-tilde cutoff frequency of low-pass filter (days)' 
    1041             WRITE(numout,*) '                         rn_lf_cutoff   = 1.0/rdt' 
     1036            WRITE(numout,*) '                         rn_lf_cutoff   = 1.0/rn_Dt' 
    10421037         ELSE 
    10431038            WRITE(numout,*) '      z-tilde to zstar restoration timescale (days)        rn_rst_e3t   = ', rn_rst_e3t 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/VORTEX/MY_SRC/usrdef_istate.F90

    r10425 r12724  
    6969      zH = 0.5_wp * 5000._wp 
    7070      ! 
    71       zP0 = rau0 * zf0 * zumax * zlambda * SQRT(EXP(1._wp)/2._wp) 
     71      zP0 = rho0 * zf0 * zumax * zlambda * SQRT(EXP(1._wp)/2._wp) 
    7272      ! 
    7373      ! Sea level: 
     
    7777            zx = glamt(ji,jj) * 1.e3 
    7878            zy = gphit(ji,jj) * 1.e3 
    79             zrho1 = rau0 + za * EXP(-(zx**2+zy**2)/zlambda**2) 
     79            zrho1 = rho0 + za * EXP(-(zx**2+zy**2)/zlambda**2) 
    8080            pssh(ji,jj) = zP0 * EXP(-(zx**2+zy**2)/zlambda**2)/(zrho1*grav) * ptmask(ji,jj,1) 
    8181         END DO 
     
    8989            DO jk=1,jpk 
    9090               zdt =  pdept(ji,jj,jk)  
    91                zrho1 = rau0 * (1._wp + zn2*zdt/grav) 
     91               zrho1 = rho0 * (1._wp + zn2*zdt/grav) 
    9292               IF (zdt < zH) THEN 
    9393                  zrho1 = zrho1 - zP0 * (1._wp-EXP(zdt-zH)) & 
    9494                          & * EXP(-(zx**2+zy**2)/zlambda**2) / (grav*(zH -1._wp + exp(-zH))); 
    9595               ENDIF 
    96                pts(ji,jj,jk,jp_tem) = (20._wp + (rau0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
     96               pts(ji,jj,jk,jp_tem) = (20._wp + (rho0-zrho1) / 0.28_wp) * ptmask(ji,jj,jk) 
    9797            END DO 
    9898         END DO 
     
    103103      ! 
    104104      ! velocities: 
    105       za = 2._wp * zP0 / (zf0 * rau0 * zlambda**2) 
     105      za = 2._wp * zP0 / (zf0 * rho0 * zlambda**2) 
    106106      DO ji=1, jpim1 
    107107         DO jj=1, jpj 
  • NEMO/branches/2020/dev_r12377_KERNEL-06_techene_e3/tests/WAD/EXPREF/namelist_cfg

    r12377 r12724  
    4343   ! 
    4444   ln_meshmask = .true.    !  create (>0) a mesh file or not (=0) 
    45    rn_rdt      =    18.    !  time step for the dynamics  
     45   rn_Dt      =    18.    !  time step for the dynamics  
    4646/ 
    4747!----------------------------------------------------------------------- 
     
    344344   ln_dynspg_ts  = .true.  !  split-explicit free surface 
    345345   ln_bt_auto    = .false. ! Number of sub-step defined from: 
    346    nn_baro       =  12     ! =F : the number of sub-step in rn_rdt seconds 
     346   nn_e       =  12     ! =F : the number of sub-step in rn_Dt seconds 
    347347/ 
    348348!----------------------------------------------------------------------- 
Note: See TracChangeset for help on using the changeset viewer.