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 13467 – NEMO

Changeset 13467


Ignore:
Timestamp:
2020-09-15T09:28:26+02:00 (4 years ago)
Author:
smasson
Message:

r4_trunk: merge r4 13331:13348 13412,13444,13445,13449 see #2523

Location:
NEMO/branches/2020/temporary_r4_trunk
Files:
15 edited

Legend:

Unmodified
Added
Removed
  • NEMO/branches/2020/temporary_r4_trunk/cfgs/SHARED/field_def_nemo-oce.xml

    r13466 r13467  
    9191        <field id="alpha"        long_name="thermal expansion"                                                         unit="degC-1" grid_ref="grid_T_3D" /> 
    9292        <field id="beta"         long_name="haline contraction"                                                        unit="1e3"    grid_ref="grid_T_3D" /> 
    93         <field id="bn2"          long_name="squared Brunt-Vaisala frequency"                                           unit="s-1"    grid_ref="grid_T_3D" /> 
    9493        <field id="rhop"         long_name="potential density (sigma0)"        standard_name="sea_water_sigma_theta"   unit="kg/m3"  grid_ref="grid_T_3D" /> 
    9594 
     
    543542        <field id="w_masstr2"    long_name="square of vertical mass transport"              standard_name="square_of_upward_ocean_mass_transport"   unit="kg2/s2" /> 
    544543 
     544        <!-- EOS --> 
     545        <field id="bn2"          long_name="squared Brunt-Vaisala frequency"                unit="s-2" /> 
     546 
    545547      </field_group> 
    546548       
     
    598600 
    599601       
    600       <!-- variables available with key_float --> 
     602      <!-- variables available with ln_floats --> 
    601603 
    602604      <field_group id="floatvar" grid_ref="grid_T_nfloat"  operation="instant" > 
  • NEMO/branches/2020/temporary_r4_trunk/cfgs/SHARED/namelist_ice_ref

    r13466 r13467  
    9595      rn_creepl     =   2.0e-9        !     creep limit [1/s] 
    9696      rn_ecc        =   2.0           !     eccentricity of the elliptical yield curve           
    97       nn_nevp       = 120             !     number of EVP subcycles                              
     97      nn_nevp       = 100             !     number of EVP subcycles                              
    9898      rn_relast     =   0.333         !     ratio of elastic timescale to ice time step: Telast = dt_ice * rn_relast  
    99                                       !        advised value: 1/3 (rn_nevp=120) or 1/9 (rn_nevp=300) 
    100    ln_rhg_chkcvg    = .false.         !  check convergence of rheology (outputs: file ice_cvg.nc & variable uice_cvg) 
     99                                      !        advised value: 1/3 (nn_nevp=100) or 1/9 (nn_nevp=300) 
     100   nn_rhg_chkcvg    =   0             !  check convergence of rheology 
     101                                      !     = 0  no check 
     102                                      !     = 1  check at the main time step (output xml: uice_cvg) 
     103                                      !     = 2  check at both main and rheology time steps (additional output: ice_cvg.nc) 
     104                                      !          this option 2 asks a lot of communications between cpu 
    101105/ 
    102106!------------------------------------------------------------------------------ 
     
    111115!------------------------------------------------------------------------------ 
    112116   rn_cio           =   5.0e-03       !  ice-ocean drag coefficient (-) 
    113    nn_snwfra        =   0             !  calculate the fraction of ice covered by snow (for zdf and albedo) 
     117   nn_snwfra        =   2             !  calculate the fraction of ice covered by snow (for zdf and albedo) 
    114118                                      !     = 0  fraction = 1 (if snow) or 0 (if no snow) 
    115119                                      !     = 1  fraction = 1-exp(-0.2*rhos*hsnw) [MetO formulation] 
     
    124128   ln_cndflx        = .false.         !  Use conduction flux as surface boundary conditions (i.e. for Jules coupling) 
    125129      ln_cndemulate = .false.         !     emulate conduction flux (if not provided in the inputs) 
    126    nn_qtrice        =              !  Solar flux transmitted thru the surface scattering layer: 
     130   nn_qtrice        =   1             !  Solar flux transmitted thru the surface scattering layer: 
    127131                                      !     = 0  Grenfell and Maykut 1977 (depends on cloudiness and is 0 when there is snow)  
    128132                                      !     = 1  Lebrun 2019 (equals 0.3 anytime with different melting/dry snw conductivities) 
     
    190194&namthd_pnd     !   Melt ponds 
    191195!------------------------------------------------------------------------------ 
    192    ln_pnd            = .false.        !  activate melt ponds or not 
    193       ln_pnd_LEV     = .false.        !  level ice melt ponds (from Flocco et al 2007,2010 & Holland et al 2012) 
     196   ln_pnd            = .true.         !  activate melt ponds or not 
     197      ln_pnd_LEV     = .true.         !  level ice melt ponds (from Flocco et al 2007,2010 & Holland et al 2012) 
    194198         rn_apnd_min =   0.15         !     minimum ice fraction that contributes to melt pond. range: 0.0 -- 0.15 ?? 
    195199         rn_apnd_max =   0.85         !     maximum ice fraction that contributes to melt pond. range: 0.7 -- 0.85 ?? 
  • NEMO/branches/2020/temporary_r4_trunk/cfgs/SHARED/namelist_ref

    r13466 r13467  
    10541054   rn_bshear   =   1.e-20  ! background shear (>0) currently a numerical threshold (do not change it) 
    10551055   nn_pdl      =   1       !  Prandtl number function of richarson number (=1, avt=pdl(Ri)*avm) or not (=0, avt=avm) 
    1056    nn_mxl      =   2       !  mixing length: = 0 bounded by the distance to surface and bottom 
     1056   nn_mxl      =   3       !  mixing length: = 0 bounded by the distance to surface and bottom 
    10571057   !                       !                 = 1 bounded by the local vertical scale factor 
    10581058   !                       !                 = 2 first vertical derivative of mixing length bounded by 1 
    10591059   !                       !                 = 3 as =2 with distinct dissipative an mixing length scale 
    10601060   ln_mxl0     = .true.    !  surface mixing length scale = F(wind stress) (T) or not (F) 
    1061       nn_mxlice    = 0        ! type of scaling under sea-ice 
     1061      nn_mxlice    = 2        ! type of scaling under sea-ice 
    10621062                              !    = 0 no scaling under sea-ice 
    10631063                              !    = 1 scaling with constant sea-ice thickness 
  • NEMO/branches/2020/temporary_r4_trunk/cfgs/SPITZ12/EXPREF/namelist_cfg

    r13466 r13467  
    345345!----------------------------------------------------------------------- 
    346346   ln_mxl0     = .true.    !  surface mixing length scale = F(wind stress) (T) or not (F) 
    347       nn_mxlice    = 2        ! type of scaling under sea-ice 
     347      nn_mxlice    = 0        ! type of scaling under sea-ice 
    348348                              !    = 0 no scaling under sea-ice 
    349349                              !    = 1 scaling with constant sea-ice thickness 
    350350                              !    = 2 scaling with mean sea-ice thickness ( only with SI3 sea-ice model ) 
    351351                              !    = 3 scaling with maximum sea-ice thickness 
    352    nn_eice     =   1       !  attenutaion of langmuir & surface wave breaking under ice 
     352   nn_eice     =   0       !  attenutaion of langmuir & surface wave breaking under ice 
    353353   !                       !           = 0 no impact of ice cover on langmuir & surface wave breaking 
    354354   !                       !           = 1 weigthed by 1-TANH(10*fr_i) 
  • NEMO/branches/2020/temporary_r4_trunk/cfgs/SPITZ12/EXPREF/namelist_ice_cfg

    r13466 r13467  
    5555&namsbc         !   Ice surface boundary conditions 
    5656!------------------------------------------------------------------------------ 
     57   nn_snwfra        =   0             !  calculate the fraction of ice covered by snow (for zdf and albedo) 
     58                                      !     = 0  fraction = 1 (if snow) or 0 (if no snow) 
     59                                      !     = 1  fraction = 1-exp(-0.2*rhos*hsnw) [MetO formulation] 
     60                                      !     = 2  fraction = hsnw / (hsnw+0.02)    [CICE formulation] 
     61   nn_qtrice        =   0             !  Solar flux transmitted thru the surface scattering layer: 
     62                                      !     = 0  Grenfell and Maykut 1977 (depends on cloudiness and is 0 when there is snow) 
     63                                      !     = 1  Lebrun 2019 (equals 0.3 anytime with different melting/dry snw conductivities) 
    5764/ 
    5865!------------------------------------------------------------------------------ 
     
    8188&namthd_pnd     !   Melt ponds 
    8289!------------------------------------------------------------------------------ 
    83    ln_pnd           = .true.          !  activate melt ponds or not 
    84      ln_pnd_LEV     = .true.          !  activate level ice melt ponds 
     90   ln_pnd           = .false.          !  activate melt ponds or not 
     91     ln_pnd_LEV     = .false.          !  activate level ice melt ponds 
    8592/ 
    8693 
  • NEMO/branches/2020/temporary_r4_trunk/src/ICE/ice.F90

    r13466 r13467  
    155155   INTEGER , PUBLIC ::   nn_nevp          !: number of iterations for subcycling 
    156156   REAL(wp), PUBLIC ::   rn_relast        !: ratio => telast/rdt_ice (1/3 or 1/9 depending on nb of subcycling nevp)  
    157    LOGICAL , PUBLIC ::   ln_rhg_chkcvg    !: check ice rheology convergence  
     157   INTEGER , PUBLIC ::   nn_rhg_chkcvg    !: check ice rheology convergence  
    158158   ! 
    159159   !                                     !!** ice-advection namelist (namdyn_adv) ** 
     
    412412   ! 
    413413   !!---------------------------------------------------------------------- 
    414    !! * Only for atmospheric coupling 
    415    !!---------------------------------------------------------------------- 
    416    REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   a_i_last_couple !: Ice fractional area at last coupling time 
    417    ! 
    418    !!---------------------------------------------------------------------- 
    419414   !! NEMO/ICE 4.0 , NEMO Consortium (2018) 
    420415   !! $Id$ 
     
    429424      INTEGER :: ice_alloc 
    430425      ! 
    431       INTEGER :: ierr(17), ii 
     426      INTEGER :: ierr(16), ii 
    432427      !!----------------------------------------------------------------- 
    433428      ierr(:) = 0 
     
    511506      ALLOCATE( t_si(jpi,jpj,jpl) , tm_si(jpi,jpj) , qcn_ice_bot(jpi,jpj,jpl) , qcn_ice_top(jpi,jpj,jpl) , STAT = ierr(ii) ) 
    512507 
    513       ! * For atmospheric coupling 
    514       ii = ii + 1 
    515       ALLOCATE( a_i_last_couple(jpi,jpj,jpl) , STAT=ierr(ii) ) 
    516  
    517508      ice_alloc = MAXVAL( ierr(:) ) 
    518509      IF( ice_alloc /= 0 )   CALL ctl_stop( 'STOP', 'ice_alloc: failed to allocate arrays.' ) 
  • NEMO/branches/2020/temporary_r4_trunk/src/ICE/icedyn_rhg.F90

    r13466 r13467  
    110110      INTEGER ::   ios, ioptio   ! Local integer output status for namelist read 
    111111      !! 
    112       NAMELIST/namdyn_rhg/  ln_rhg_EVP, ln_aEVP, rn_creepl, rn_ecc , nn_nevp, rn_relast, ln_rhg_chkcvg 
     112      NAMELIST/namdyn_rhg/  ln_rhg_EVP, ln_aEVP, rn_creepl, rn_ecc , nn_nevp, rn_relast, nn_rhg_chkcvg 
    113113      !!------------------------------------------------------------------- 
    114114      ! 
     
    132132         WRITE(numout,*) '         number of iterations for subcycling               nn_nevp       = ', nn_nevp 
    133133         WRITE(numout,*) '         ratio of elastic timescale over ice time step     rn_relast     = ', rn_relast 
    134          WRITE(numout,*) '      check convergence of rheology                        ln_rhg_chkcvg = ', ln_rhg_chkcvg 
     134         WRITE(numout,*) '      check convergence of rheology                        nn_rhg_chkcvg = ', nn_rhg_chkcvg 
     135         IF    ( nn_rhg_chkcvg == 0 ) THEN   ;   WRITE(numout,*) '         no check' 
     136         ELSEIF( nn_rhg_chkcvg == 1 ) THEN   ;   WRITE(numout,*) '         check cvg at the main time step' 
     137         ELSEIF( nn_rhg_chkcvg == 2 ) THEN   ;   WRITE(numout,*) '         check cvg at both main and rheology time steps' 
     138         ENDIF 
    135139      ENDIF 
    136140      ! 
  • NEMO/branches/2020/temporary_r4_trunk/src/ICE/icedyn_rhg_evp.F90

    r13466 r13467  
    362362         ! 
    363363         ! convergence test 
    364          IF( ln_rhg_chkcvg ) THEN 
     364         IF( nn_rhg_chkcvg == 1 .OR. nn_rhg_chkcvg == 2 ) THEN 
    365365            DO jj = 1, jpj 
    366366               DO ji = 1, jpi 
     
    715715 
    716716         ! convergence test 
    717          IF( ln_rhg_chkcvg )   CALL rhg_cvg( kt, jter, nn_nevp, u_ice, v_ice, zu_ice, zv_ice ) 
     717         IF( nn_rhg_chkcvg == 2 )   CALL rhg_cvg( kt, jter, nn_nevp, u_ice, v_ice, zu_ice, zv_ice ) 
    718718         ! 
    719719         !                                                ! ==================== ! 
     
    890890      ! 
    891891      ! --- convergence tests --- ! 
    892       IF( ln_rhg_chkcvg ) THEN 
     892      IF( nn_rhg_chkcvg == 1 .OR. nn_rhg_chkcvg == 2 ) THEN 
    893893         IF( iom_use('uice_cvg') ) THEN 
    894894            IF( ln_aEVP ) THEN   ! output: beta * ( u(t=nn_nevp) - u(t=nn_nevp-1) ) 
  • NEMO/branches/2020/temporary_r4_trunk/src/ICE/icerst.F90

    r13466 r13467  
    1818   USE phycst  , ONLY : rt0 
    1919   USE sbc_oce , ONLY : nn_fsbc, ln_cpl 
     20   USE sbc_oce , ONLY : nn_components, jp_iam_sas   ! SAS ss[st]_m init 
     21   USE sbc_oce , ONLY : sst_m, sss_m                ! SAS ss[st]_m init 
     22   USE oce     , ONLY : tsn                         ! SAS ss[st]_m init 
     23   USE eosbn2  , ONLY : l_useCT, eos_pt_from_ct     ! SAS ss[st]_m init 
    2024   USE iceistate      ! sea-ice: initial state 
    2125   USE icectl         ! sea-ice: control 
     
    278282      ELSE                 ! == case of a simplified restart == ! 
    279283         !                 ! ---------------------------------- ! 
    280          CALL ctl_warn('ice_rst_read: you are using a simplified ice restart') 
     284         CALL ctl_warn('ice_rst_read: you are attempting to use an unsuitable ice restart') 
    281285         ! 
    282          CALL ice_istate_init 
     286         IF( .NOT. ln_iceini .OR. nn_iceini_file == 2 ) THEN 
     287            CALL ctl_stop('STOP', 'ice_rst_read: you need ln_ice_ini=T and nn_iceini_file=0 or 1') 
     288         ELSE 
     289            CALL ctl_warn('ice_rst_read: using ice_istate to set initial conditions instead') 
     290         ENDIF 
     291         ! 
     292         IF( nn_components == jp_iam_sas ) THEN   ! SAS case: ss[st]_m were not initialized by sbc_ssm_init 
     293            ! 
     294            IF(lwp) WRITE(numout,*) '  SAS: default initialisation of ss[st]_m arrays used in ice_istate' 
     295            IF( l_useCT )  THEN    ;   sst_m(:,:) = eos_pt_from_ct( tsn(:,:,1,jp_tem), tsn(:,:,1,jp_sal) ) 
     296            ELSE                   ;   sst_m(:,:) = tsn(:,:,1,jp_tem) 
     297            ENDIF 
     298            sss_m(:,:) = tsn(:,:,1,jp_sal) 
     299         ENDIF 
     300         ! 
    283301         CALL ice_istate( nit000 ) 
    284302         ! 
    285          IF( .NOT.ln_iceini .OR. nn_iceini_file == 0 ) & 
    286             &   CALL ctl_stop('STOP', 'ice_rst_read: you need ln_ice_ini=T and nn_iceini_file=0') 
    287          ! 
    288303      ENDIF 
    289304 
  • NEMO/branches/2020/temporary_r4_trunk/src/ICE/icestp.F90

    r13466 r13467  
    257257      ! 
    258258      !                                ! Initial sea-ice state 
     259      CALL ice_istate_init 
    259260      IF ( ln_rstart .OR. nn_iceini_file == 2 ) THEN 
    260261         CALL ice_rst_read                      ! start from a restart file 
    261262      ELSE 
    262          CALL ice_istate_init 
    263263         CALL ice_istate( nit000 )              ! start from rest or read a file 
    264264      ENDIF 
  • NEMO/branches/2020/temporary_r4_trunk/src/OCE/IOM/prtctl.F90

    r10068 r13467  
    3613619000     FORMAT(a41,i4.4,a14) 
    3623629001     FORMAT(a59) 
    363 9002     FORMAT(a20,i4.4,a36,i3.3) 
     3639002     FORMAT(a20,i4.4,a36,i4.4) 
    3643649003     FORMAT(a20,i4.4,a17,i4.4) 
    3653659004     FORMAT(a11,i4.4,a26,i4.4,a14) 
  • NEMO/branches/2020/temporary_r4_trunk/src/OCE/SBC/sbc_ice.F90

    r13466 r13467  
    9595   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::  a_i 
    9696   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::  h_i, h_s 
    97    REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::  a_i_last_couple   !: Sea ice fraction on categories at the last coupling point 
    9897 
    9998   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:)   ::   tatm_ice       !: air temperature [K] 
  • NEMO/branches/2020/temporary_r4_trunk/src/OCE/SBC/sbcblk.F90

    r13466 r13467  
    270270         WRITE(numout,*) '      "NCAR"      algorithm   (Large and Yeager 2008)     ln_NCAR      = ', ln_NCAR 
    271271         WRITE(numout,*) '      "COARE 3.0" algorithm   (Fairall et al. 2003)       ln_COARE_3p0 = ', ln_COARE_3p0 
    272          WRITE(numout,*) '      "COARE 3.5" algorithm   (Edson et al. 2013)         ln_COARE_3p5 = ', ln_COARE_3p0 
     272         WRITE(numout,*) '      "COARE 3.5" algorithm   (Edson et al. 2013)         ln_COARE_3p5 = ', ln_COARE_3p5 
    273273         WRITE(numout,*) '      "ECMWF"     algorithm   (IFS cycle 31)              ln_ECMWF     = ', ln_ECMWF 
    274274         WRITE(numout,*) '      add High freq.contribution to the stress module     ln_taudif    = ', ln_taudif 
  • NEMO/branches/2020/temporary_r4_trunk/src/OCE/SBC/sbccpl.F90

    r13466 r13467  
    205205 
    206206   REAL(wp), ALLOCATABLE, SAVE, DIMENSION(:,:) ::   alb_oce_mix    ! ocean albedo sent to atmosphere (mix clear/overcast sky) 
     207#if defined key_si3 || defined key_cice 
     208   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   a_i_last_couple !: Ice fractional area at last coupling time 
     209#endif 
    207210 
    208211   REAL(wp) ::   rpref = 101000._wp   ! reference atmospheric pressure[N/m2]  
     
    224227      !!             ***  FUNCTION sbc_cpl_alloc  *** 
    225228      !!---------------------------------------------------------------------- 
    226       INTEGER :: ierr(4) 
     229      INTEGER :: ierr(5) 
    227230      !!---------------------------------------------------------------------- 
    228231      ierr(:) = 0 
     
    234237#endif 
    235238      ALLOCATE( xcplmask(jpi,jpj,0:nn_cplmodel) , STAT=ierr(3) ) 
    236       ! 
    237       IF( .NOT. ln_apr_dyn ) ALLOCATE( ssh_ib(jpi,jpj), ssh_ibb(jpi,jpj), apr(jpi, jpj), STAT=ierr(4) )  
     239#if defined key_si3 || defined key_cice 
     240      ALLOCATE( a_i_last_couple(jpi,jpj,jpl) , STAT=ierr(4) ) 
     241#endif 
     242      ! 
     243      IF( .NOT. ln_apr_dyn ) ALLOCATE( ssh_ib(jpi,jpj), ssh_ibb(jpi,jpj), apr(jpi, jpj), STAT=ierr(5) ) 
    238244 
    239245      sbc_cpl_alloc = MAXVAL( ierr ) 
     
    21832189      ! 
    21842190      isec = ( kt - nit000 ) * NINT( rdt )        ! date of exchanges 
     2191      info = OASIS_idle 
    21852192 
    21862193      zfr_l(:,:) = 1.- fr_i(:,:) 
  • NEMO/branches/2020/temporary_r4_trunk/src/TOP/PISCES/P4Z/p4zsms.F90

    r13029 r13467  
    6565      REAL(wp), ALLOCATABLE, DIMENSION(:,:    ) :: zw2d 
    6666      REAL(wp), ALLOCATABLE, DIMENSION(:,:,:  ) :: zw3d 
    67       REAL(wp), ALLOCATABLE, DIMENSION(:,:,:,:) ::   ztrdt   ! 4D workspace 
     67      REAL(wp), DIMENSION(jpi,jpj,jpk,jp_pisces) :: ztrbbio 
    6868 
    6969      !!--------------------------------------------------------------------- 
     
    8989      rfact = r2dttrc 
    9090      ! 
    91       ! trends computation initialisation 
    92       IF( l_trdtrc )  THEN 
    93          ALLOCATE( ztrdt(jpi,jpj,jpk,jp_pisces) )  !* store now fields before applying the Asselin filter 
    94          ztrdt(:,:,:,:)  = trn(:,:,:,:) 
    95       ENDIF 
    96       ! 
    97  
    9891      IF( ( ln_top_euler .AND. kt == nittrc000 )  .OR. ( .NOT.ln_top_euler .AND. kt <= nittrc000 + nn_dttrc ) ) THEN 
    9992         rfactr  = 1. / rfact 
     
    113106         END DO 
    114107      ENDIF 
     108 
     109      DO jn = jp_pcs0, jp_pcs1              !   Store the tracer concentrations before entering PISCES 
     110         ztrbbio(:,:,:,jn) = trb(:,:,:,jn) 
     111      END DO 
     112 
    115113      ! 
    116114      IF( ll_sbc ) CALL p4z_sbc( kt )   ! external sources of nutrients  
     
    145143           trb(:,:,:,jn) = trb(:,:,:,jn) + xnegtr(:,:,:) * tra(:,:,:,jn) 
    146144         END DO 
     145         
    147146        ! 
    148147        IF(  iom_use( 'INTdtAlk' ) .OR. iom_use( 'INTdtDIC' ) .OR. iom_use( 'INTdtFer' ) .OR.  & 
     
    194193        ENDIF 
    195194        ! 
    196          DO jn = jp_pcs0, jp_pcs1 
    197             tra(:,:,:,jn) = 0._wp 
    198          END DO 
    199          ! 
    200          IF( ln_top_euler ) THEN 
    201             DO jn = jp_pcs0, jp_pcs1 
    202                trn(:,:,:,jn) = trb(:,:,:,jn) 
    203             END DO 
    204          ENDIF 
     195        DO jn = jp_pcs0, jp_pcs1 
     196           tra(:,:,:,jn) = 0._wp 
     197        END DO 
     198        ! 
     199      END DO 
     200      ! 
     201#endif 
     202      ! 
     203      IF( ln_sediment ) THEN  
     204         ! 
     205         CALL sed_model( kt )     !  Main program of Sediment model 
     206         ! 
     207      ENDIF 
     208      ! 
     209      DO jn = jp_pcs0, jp_pcs1 
     210         tra(:,:,:,jn) = ( trb(:,:,:,jn) - ztrbbio(:,:,:,jn) ) * rfactr 
     211         trb(:,:,:,jn) = ztrbbio(:,:,:,jn) 
     212         ztrbbio(:,:,:,jn) = 0._wp 
    205213      END DO 
    206214      ! 
    207215      IF( l_trdtrc ) THEN 
    208216         DO jn = jp_pcs0, jp_pcs1 
    209            ztrdt(:,:,:,jn) = ( trb(:,:,:,jn) - ztrdt(:,:,:,jn) ) * rfactr  
    210            CALL trd_trc( ztrdt(:,:,:,jn), jn, jptra_sms, kt )   ! save trends 
     217           CALL trd_trc( tra(:,:,:,jn), jn, jptra_sms, kt )   ! save trends 
    211218         END DO 
    212          DEALLOCATE( ztrdt )  
    213219      END IF 
    214 #endif 
    215       ! 
    216       IF( ln_sediment ) THEN  
    217          ! 
    218          CALL sed_model( kt )     !  Main program of Sediment model 
    219          ! 
    220          IF( ln_top_euler ) THEN 
    221             DO jn = jp_pcs0, jp_pcs1 
    222                trn(:,:,:,jn) = trb(:,:,:,jn) 
    223             END DO 
    224          ENDIF 
    225          ! 
    226       ENDIF 
    227       ! 
     220      !   
    228221      IF( lrst_trc )  CALL p4z_rst( kt, 'WRITE' )  !* Write PISCES informations in restart file  
    229222      ! 
Note: See TracChangeset for help on using the changeset viewer.