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 8003 for branches/CNRS/dev_r6270_PISCES_QUOTA/NEMOGCM/NEMO/TOP_SRC/PISCES/P5Z/p5zsink.F90 – NEMO

Ignore:
Timestamp:
2017-05-09T12:14:45+02:00 (7 years ago)
Author:
aumont
Message:

modification in the code to remove unnecessary parts such as kriest and non iomput options

File:
1 edited

Legend:

Unmodified
Added
Removed
  • branches/CNRS/dev_r6270_PISCES_QUOTA/NEMOGCM/NEMO/TOP_SRC/PISCES/P5Z/p5zsink.F90

    r6841 r8003  
    4040   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   sinkcal, sinksil   !: CaCO3 and BSi sinking fluxes 
    4141   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   sinkfer            !: Small BFe sinking fluxes 
    42 #if ! defined key_kriest 
    4342   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   sinkfer2           !: Big iron sinking fluxes 
    44 #endif 
    4543#if defined key_ligand 
    4644   REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:,:,:) ::   sinkfep      !: Fep sinking fluxes 
     
    4947 
    5048   INTEGER  :: ik100 
    51  
    52 #if  defined key_kriest 
    53    REAL(wp) ::  xkr_sfact    !: Sinking factor 
    54    REAL(wp) ::  xkr_stick    !: Stickiness 
    55    REAL(wp) ::  xkr_nnano    !: Nbr of cell in nano size class 
    56    REAL(wp) ::  xkr_ndiat    !: Nbr of cell in diatoms size class 
    57    REAL(wp) ::  xkr_nmicro   !: Nbr of cell in microzoo size class 
    58    REAL(wp) ::  xkr_nmeso    !: Nbr of cell in mesozoo  size class 
    59    REAL(wp) ::  xkr_naggr    !: Nbr of cell in aggregates  size class 
    60  
    61    REAL(wp) ::  xkr_frac  
    62  
    63    REAL(wp), PUBLIC ::  xkr_dnano       !: Size of particles in nano pool 
    64    REAL(wp), PUBLIC ::  xkr_ddiat       !: Size of particles in diatoms pool 
    65    REAL(wp), PUBLIC ::  xkr_dmicro      !: Size of particles in microzoo pool 
    66    REAL(wp), PUBLIC ::  xkr_dmeso       !: Size of particles in mesozoo pool 
    67    REAL(wp), PUBLIC ::  xkr_daggr       !: Size of particles in aggregates pool 
    68    REAL(wp), PUBLIC ::  xkr_wsbio_min   !: min vertical particle speed 
    69    REAL(wp), PUBLIC ::  xkr_wsbio_max   !: max vertical particle speed 
    70  
    71    REAL(wp), PUBLIC, ALLOCATABLE, SAVE, DIMENSION(:) ::   xnumm   !:  maximum number of particles in aggregates 
    72 #endif 
    7349 
    7450   !!* Substitution 
     
    8157CONTAINS 
    8258 
    83 #if ! defined key_kriest 
    8459   !!---------------------------------------------------------------------- 
    8560   !!   'standard sinking parameterisation'                  ??? 
     
    308283   END SUBROUTINE p5z_sink_init 
    309284 
    310 #else 
    311    !!---------------------------------------------------------------------- 
    312    !!   'Kriest sinking parameterisation'        key_kriest          ??? 
    313    !!---------------------------------------------------------------------- 
    314  
    315    SUBROUTINE p5z_sink ( kt, knt ) 
    316       !!--------------------------------------------------------------------- 
    317       !!                ***  ROUTINE p5z_sink  *** 
    318       !! 
    319       !! ** Purpose :   Compute vertical flux of particulate matter due to 
    320       !!              gravitational sinking - Kriest parameterization 
    321       !! 
    322       !! ** Method  : - ??? 
    323       !!--------------------------------------------------------------------- 
    324       ! 
    325       INTEGER, INTENT(in) :: kt, knt 
    326       ! 
    327       INTEGER  :: ji, jj, jk, jit, niter1, niter2 
    328       REAL(wp) :: znum , zeps, zfm, zgm, zsm, zfactn, zfactp 
    329       REAL(wp) :: zdiv , zdiv1, zdiv2, zdiv3, zdiv4, zdiv5 
    330       REAL(wp) :: zval1, zval2, zval3, zval4 
    331       CHARACTER (len=25) :: charout 
    332       REAL(wp), POINTER, DIMENSION(:,:,:) :: znum3d  
    333       REAL(wp), POINTER, DIMENSION(:,:,:) :: zw3d 
    334       REAL(wp), POINTER, DIMENSION(:,:  ) :: zw2d 
    335       !!--------------------------------------------------------------------- 
    336       ! 
    337       IF( nn_timing == 1 )  CALL timing_start('p5z_sink') 
    338       ! 
    339       CALL wrk_alloc( jpi, jpj, jpk, znum3d ) 
    340       ! 
    341       !     Initialisation of variables used to compute Sinking Speed 
    342       !     --------------------------------------------------------- 
    343  
    344       znum3d(:,:,:) = 0.e0 
    345       zval1 = 1. + xkr_zeta 
    346       zval2 = 1. + xkr_zeta + xkr_eta 
    347       zval3 = 1. + xkr_eta 
    348  
    349       !     Computation of the vertical sinking speed : Kriest et Evans, 2000 
    350       !     ----------------------------------------------------------------- 
    351  
    352       DO jk = 1, jpkm1 
    353          DO jj = 1, jpj 
    354             DO ji = 1, jpi 
    355                IF( tmask(ji,jj,jk) /= 0.e0 ) THEN 
    356                   znum = trb(ji,jj,jk,jppoc) / ( trb(ji,jj,jk,jpnum) + rtrn ) / xkr_massp 
    357                   ! -------------- To avoid sinking speed over 50 m/day ------- 
    358                   znum  = MIN( xnumm(jk), znum ) 
    359                   znum  = MAX( 1.1      , znum ) 
    360                   znum3d(ji,jj,jk) = znum 
    361                   !------------------------------------------------------------ 
    362                   zeps  = ( zval1 * znum - 1. )/ ( znum - 1. ) 
    363                   zfm   = xkr_frac**( 1. - zeps ) 
    364                   zgm   = xkr_frac**( zval1 - zeps ) 
    365                   zdiv  = MAX( 1.e-4, ABS( zeps - zval2 ) ) * SIGN( 1., ( zeps - zval2 ) ) 
    366                   zdiv1 = zeps - zval3 
    367                   wsbio3(ji,jj,jk) = xkr_wsbio_min * ( zeps - zval1 ) / zdiv    & 
    368                      &             - xkr_wsbio_max *   zgm * xkr_eta  / zdiv 
    369                   wsbio4(ji,jj,jk) = xkr_wsbio_min *   ( zeps-1. )    / zdiv1   & 
    370                      &             - xkr_wsbio_max *   zfm * xkr_eta  / zdiv1 
    371                   IF( znum == 1.1)   wsbio3(ji,jj,jk) = wsbio4(ji,jj,jk) 
    372                ENDIF 
    373             END DO 
    374          END DO 
    375       END DO 
    376  
    377       wscal(:,:,:) = MAX( wsbio3(:,:,:), 30._wp ) 
    378 #if defined key_ligand 
    379       wsfep (:,:,:) = wfep 
    380 #endif 
    381  
    382       !   INITIALIZE TO ZERO ALL THE SINKING ARRAYS 
    383       !   ----------------------------------------- 
    384  
    385       sinking (:,:,:) = 0.e0 
    386       sinkingn(:,:,:) = 0.e0 
    387       sinkingp(:,:,:) = 0.e0 
    388       sinking2(:,:,:) = 0.e0 
    389       sinkcal (:,:,:) = 0.e0 
    390       sinkfer (:,:,:) = 0.e0 
    391       sinksil (:,:,:) = 0.e0 
    392 #if defined key_ligand 
    393       sinkfep(:,:,:) = 0.e0 
    394 #endif 
    395  
    396      !   Compute the sedimentation term using p4zsink2 for all the sinking particles 
    397      !   ----------------------------------------------------- 
    398  
    399       niter1 = niter1max 
    400       niter2 = niter2max 
    401  
    402       DO jit = 1, niter1 
    403         CALL p4z_sink2( wsbio3, sinking , jppoc, niter1 ) 
    404         CALL p4z_sink2( wsbio3, sinkingn, jppon, niter1 ) 
    405         CALL p4z_sink2( wsbio3, sinkingp, jppop, niter1 ) 
    406         CALL p4z_sink2( wsbio3, sinkfer , jpsfe, niter1 ) 
    407         CALL p4z_sink2( wscal , sinksil , jpgsi, niter1 ) 
    408         CALL p4z_sink2( wscal , sinkcal , jpcal, niter1 ) 
    409 #if defined key_ligand 
    410         CALL p4z_sink2( wsfep , sinkfep , jpfep, niter1 ) 
    411 #endif 
    412       END DO 
    413  
    414       DO jit = 1, niter2 
    415         CALL p4z_sink2( wsbio4, sinking2, jpnum, niter2 ) 
    416       END DO 
    417  
    418      ! Total carbon export per year 
    419      IF( iom_use( "tcexp" ) .OR. ( ln_check_mass .AND. kt == nitend .AND. knt == nrdttrc )  )  & 
    420         &   t_oce_co2_exp = glob_sum( ( sinking(:,:,ik100) + sinking2(:,:,ik100) ) * e1e2t(:,:) * tmask(:,:,1) ) 
    421      ! 
    422      IF( lk_iomput ) THEN 
    423        IF( knt == nrdttrc ) THEN 
    424           CALL wrk_alloc( jpi, jpj,      zw2d ) 
    425           CALL wrk_alloc( jpi, jpj, jpk, zw3d ) 
    426           zfact = 1.e+3 * rfact2r  !  conversion from mol/l/kt to  mol/m3/s 
    427           ! 
    428           IF( iom_use( "EPC100" ) )  THEN 
    429               zw2d(:,:) = ( sinking(:,:,ik100) + sinking2(:,:,ik100) ) * zfact * tmask(:,:,1) ! Export of carbon at 100m 
    430               CALL iom_put( "EPC100"  , zw2d ) 
    431           ENDIF 
    432           IF( iom_use( "EPFE100" ) )  THEN 
    433               zw2d(:,:) = ( sinkfer(:,:,ik100) + sinkfer2(:,:,ik100) ) * zfact * tmask(:,:,1) ! Export of iron at 100m 
    434               CALL iom_put( "EPFE100"  , zw2d ) 
    435           ENDIF 
    436           IF( iom_use( "EPCAL100" ) )  THEN 
    437               zw2d(:,:) = sinkcal(:,:,ik100) * zfact * tmask(:,:,1) ! Export of calcite at 100m 
    438               CALL iom_put( "EPCAL100"  , zw2d ) 
    439           ENDIF 
    440           IF( iom_use( "EPSI100" ) )  THEN 
    441               zw2d(:,:) =  sinksil(:,:,ik100) * zfact * tmask(:,:,1) ! Export of bigenic silica at 100m 
    442               CALL iom_put( "EPSI100"  , zw2d ) 
    443           ENDIF 
    444           IF( iom_use( "EXPC" ) )  THEN 
    445               zw3d(:,:,:) = ( sinking(:,:,:) + sinking2(:,:,:) ) * zfact * tmask(:,:,:) ! Export of carbon in the water column 
    446               CALL iom_put( "EXPC"  , zw3d ) 
    447           ENDIF 
    448           IF( iom_use( "EXPFE" ) )  THEN 
    449               zw3d(:,:,:) = ( sinkfer(:,:,:) + sinkfer2(:,:,:) ) * zfact * tmask(:,:,:) ! Export of iron  
    450               CALL iom_put( "EXPFE"  , zw3d ) 
    451           ENDIF 
    452           IF( iom_use( "EXPCAL" ) )  THEN 
    453               zw3d(:,:,:) = sinkcal(:,:,:) * zfact * tmask(:,:,:) ! Export of calcite  
    454               CALL iom_put( "EXPCAL"  , zw3d ) 
    455           ENDIF 
    456           IF( iom_use( "EXPSI" ) )  THEN 
    457               zw3d(:,:,:) = sinksil(:,:,:) * zfact * tmask(:,:,:) ! Export of bigenic silica 
    458               CALL iom_put( "EXPSI"  , zw3d ) 
    459           ENDIF 
    460           IF( iom_use( "XNUM" ) )  THEN 
    461               zw3d(:,:,:) =  znum3d(:,:,:) * tmask(:,:,:) !  Number of particles on aggregats 
    462               CALL iom_put( "XNUM"  , zw3d ) 
    463           ENDIF 
    464           IF( iom_use( "WSC" ) )  THEN 
    465               zw3d(:,:,:) = wsbio3(:,:,:) * tmask(:,:,:) ! Sinking speed of carbon particles 
    466               CALL iom_put( "WSC"  , zw3d ) 
    467           ENDIF 
    468           IF( iom_use( "WSN" ) )  THEN 
    469               zw3d(:,:,:) = wsbio4(:,:,:) * tmask(:,:,:) ! Sinking speed of particles number 
    470               CALL iom_put( "WSN"  , zw3d ) 
    471           ENDIF 
    472           IF( iom_use( "tcexp" ) )  CALL iom_put( "tcexp" , t_oce_co2_exp * zfact )   ! molC/s 
    473           !  
    474           CALL wrk_dealloc( jpi, jpj,      zw2d ) 
    475           CALL wrk_dealloc( jpi, jpj, jpk, zw3d ) 
    476         ENDIF 
    477      ELSE 
    478         IF( ln_diatrc ) THEN 
    479             zfact = 1.e3 * rfact2r 
    480             trc2d(:,:,jp_pcs0_2d + 4) = sinking (:,:,ik100) * zfact * tmask(:,:,1) 
    481             trc2d(:,:,jp_pcs0_2d + 5) = sinking2(:,:,ik100) * zfact * tmask(:,:,1) 
    482             trc2d(:,:,jp_pcs0_2d + 6) = sinkfer (:,:,ik100) * zfact * tmask(:,:,1) 
    483             trc2d(:,:,jp_pcs0_2d + 7) = sinkfer2(:,:,ik100) * zfact * tmask(:,:,1) 
    484             trc2d(:,:,jp_pcs0_2d + 8) = sinksil (:,:,ik100) * zfact * tmask(:,:,1) 
    485             trc2d(:,:,jp_pcs0_2d + 9) = sinkcal (:,:,ik100) * zfact * tmask(:,:,1) 
    486         ENDIF 
    487      ENDIF 
    488      ! 
    489      IF(ln_ctl)   THEN  ! print mean trends (used for debugging) 
    490          WRITE(charout, FMT="('sink')") 
    491          CALL prt_ctl_trc_info(charout) 
    492          CALL prt_ctl_trc(tab4d=tra, mask=tmask, clinfo=ctrcnm) 
    493      ENDIF 
    494      ! 
    495      CALL wrk_dealloc( jpi, jpj, jpk, znum3d ) 
    496      ! 
    497      IF( nn_timing == 1 )  CALL timing_stop('p5z_sink') 
    498      ! 
    499    END SUBROUTINE p5z_sink 
    500  
    501  
    502    SUBROUTINE p5z_sink_init 
    503       !!---------------------------------------------------------------------- 
    504       !!                  ***  ROUTINE p5z_sink_init  *** 
    505       !! 
    506       !! ** Purpose :   Initialization of sinking parameters 
    507       !!                Kriest parameterization only 
    508       !! 
    509       !! ** Method  :   Read the nampiskrs namelist and check the parameters 
    510       !!      called at the first timestep  
    511       !! 
    512       !! ** input   :   Namelist nampiskrs 
    513       !!---------------------------------------------------------------------- 
    514       INTEGER  ::   jk, jn, kiter 
    515       INTEGER  ::   ios                 ! Local integer output status for namelist read 
    516       REAL(wp) ::   znum, zdiv 
    517       REAL(wp) ::   zws, zwr, zwl,wmax, znummax 
    518       REAL(wp) ::   zmin, zmax, zl, zr, xacc 
    519       ! 
    520       NAMELIST/nampiskrs/ xkr_sfact, xkr_stick ,  & 
    521          &                xkr_nnano, xkr_ndiat, xkr_nmicro, xkr_nmeso, xkr_naggr 
    522       !!---------------------------------------------------------------------- 
    523       ! 
    524       IF( nn_timing == 1 )  CALL timing_start('p5z_sink_init') 
    525       ! 
    526  
    527       REWIND( numnatp_ref )              ! Namelist nampiskrs in reference namelist : Pisces sinking Kriest 
    528       READ  ( numnatp_ref, nampiskrs, IOSTAT = ios, ERR = 901) 
    529 901   IF( ios /= 0 ) CALL ctl_nam ( ios , 'nampiskrs in reference namelist', lwp ) 
    530  
    531       REWIND( numnatp_cfg )              ! Namelist nampiskrs in configuration namelist : Pisces sinking Kriest 
    532       READ  ( numnatp_cfg, nampiskrs, IOSTAT = ios, ERR = 902 ) 
    533 902   IF( ios /= 0 ) CALL ctl_nam ( ios , 'nampiskrs in configuration namelist', lwp ) 
    534       IF(lwm) WRITE ( numonp, nampiskrs ) 
    535  
    536       IF(lwp) THEN 
    537          WRITE(numout,*) 
    538          WRITE(numout,*) ' Namelist : nampiskrs' 
    539          WRITE(numout,*) '    Sinking factor                           xkr_sfact    = ', xkr_sfact 
    540          WRITE(numout,*) '    Stickiness                               xkr_stick    = ', xkr_stick 
    541          WRITE(numout,*) '    Nbr of cell in nano size class           xkr_nnano    = ', xkr_nnano 
    542          WRITE(numout,*) '    Nbr of cell in diatoms size class        xkr_ndiat    = ', xkr_ndiat 
    543          WRITE(numout,*) '    Nbr of cell in microzoo size class       xkr_nmicro   = ', xkr_nmicro 
    544          WRITE(numout,*) '    Nbr of cell in mesozoo size class        xkr_nmeso    = ', xkr_nmeso 
    545          WRITE(numout,*) '    Nbr of cell in aggregates size class     xkr_naggr    = ', xkr_naggr 
    546       ENDIF 
    547  
    548  
    549       ! max and min vertical particle speed 
    550       xkr_wsbio_min = xkr_sfact * xkr_mass_min**xkr_eta 
    551       xkr_wsbio_max = xkr_sfact * xkr_mass_max**xkr_eta 
    552       IF (lwp) WRITE(numout,*) ' max and min vertical particle speed ', xkr_wsbio_min, xkr_wsbio_max 
    553  
    554       ! 
    555       !    effect of the sizes of the different living pools on particle numbers 
    556       !    nano = 2um-20um -> mean size=6.32 um -> ws=2.596 -> xnum=xnnano=2.337 
    557       !    diat and microzoo = 10um-200um -> 44.7 -> 8.732 -> xnum=xndiat=3.718 
    558       !    mesozoo = 200um-2mm -> 632.45 -> 45.14 -> xnum=xnmeso=7.147 
    559       !    aggregates = 200um-10mm -> 1414 -> 74.34 -> xnum=xnaggr=9.877 
    560       !    doc aggregates = 1um 
    561       ! ---------------------------------------------------------- 
    562  
    563       xkr_dnano = 1. / ( xkr_massp * xkr_nnano ) 
    564       xkr_ddiat = 1. / ( xkr_massp * xkr_ndiat ) 
    565       xkr_dmicro = 1. / ( xkr_massp * xkr_nmicro ) 
    566       xkr_dmeso = 1. / ( xkr_massp * xkr_nmeso ) 
    567       xkr_daggr = 1. / ( xkr_massp * xkr_naggr ) 
    568  
    569       !!--------------------------------------------------------------------- 
    570       !!    'key_kriest'                                                  ??? 
    571       !!--------------------------------------------------------------------- 
    572       !  COMPUTATION OF THE VERTICAL PROFILE OF MAXIMUM SINKING SPEED 
    573       !  Search of the maximum number of particles in aggregates for each k-level. 
    574       !  Bissection Method 
    575       !-------------------------------------------------------------------- 
    576       IF (lwp) THEN 
    577         WRITE(numout,*) 
    578         WRITE(numout,*)'    kriest : Compute maximum number of particles in aggregates' 
    579       ENDIF 
    580  
    581       xacc     =  0.001_wp 
    582       kiter    = 50 
    583       zmin     =  1.10_wp 
    584       zmax     = xkr_mass_max / xkr_mass_min 
    585       xkr_frac = zmax 
    586  
    587       DO jk = 1,jpk 
    588          zl = zmin 
    589          zr = zmax 
    590          wmax = 0.5 * fse3t(1,1,jk) * rday * float(niter1max) / rfact2 
    591          zdiv = xkr_zeta + xkr_eta - xkr_eta * zl 
    592          znum = zl - 1. 
    593          zwl =  xkr_wsbio_min * xkr_zeta / zdiv & 
    594             & - ( xkr_wsbio_max * xkr_eta * znum * & 
    595             &     xkr_frac**( -xkr_zeta / znum ) / zdiv ) & 
    596             & - wmax 
    597  
    598          zdiv = xkr_zeta + xkr_eta - xkr_eta * zr 
    599          znum = zr - 1. 
    600          zwr =  xkr_wsbio_min * xkr_zeta / zdiv & 
    601             & - ( xkr_wsbio_max * xkr_eta * znum * & 
    602             &     xkr_frac**( -xkr_zeta / znum ) / zdiv ) & 
    603             & - wmax 
    604 iflag:   DO jn = 1, kiter 
    605             IF    ( zwl == 0._wp ) THEN   ;   znummax = zl 
    606             ELSEIF( zwr == 0._wp ) THEN   ;   znummax = zr 
    607             ELSE 
    608                znummax = ( zr + zl ) / 2. 
    609                zdiv = xkr_zeta + xkr_eta - xkr_eta * znummax 
    610                znum = znummax - 1. 
    611                zws =  xkr_wsbio_min * xkr_zeta / zdiv & 
    612                   & - ( xkr_wsbio_max * xkr_eta * znum * & 
    613                   &     xkr_frac**( -xkr_zeta / znum ) / zdiv ) & 
    614                   & - wmax 
    615                IF( zws * zwl < 0. ) THEN   ;   zr = znummax 
    616                ELSE                        ;   zl = znummax 
    617                ENDIF 
    618                zdiv = xkr_zeta + xkr_eta - xkr_eta * zl 
    619                znum = zl - 1. 
    620                zwl =  xkr_wsbio_min * xkr_zeta / zdiv & 
    621                   & - ( xkr_wsbio_max * xkr_eta * znum * & 
    622                   &     xkr_frac**( -xkr_zeta / znum ) / zdiv ) & 
    623                   & - wmax 
    624  
    625                zdiv = xkr_zeta + xkr_eta - xkr_eta * zr 
    626                znum = zr - 1. 
    627                zwr =  xkr_wsbio_min * xkr_zeta / zdiv & 
    628                   & - ( xkr_wsbio_max * xkr_eta * znum * & 
    629                   &     xkr_frac**( -xkr_zeta / znum ) / zdiv ) & 
    630                   & - wmax 
    631                ! 
    632                IF ( ABS ( zws )  <= xacc ) EXIT iflag 
    633                ! 
    634             ENDIF 
    635             ! 
    636          END DO iflag 
    637  
    638          xnumm(jk) = znummax 
    639          IF (lwp) WRITE(numout,*) '       jk = ', jk, ' wmax = ', wmax,' xnum max = ', xnumm(jk) 
    640          ! 
    641       END DO 
    642       ! 
    643       ik100 = 10        !  last level where depth less than 100 m 
    644       DO jk = jpkm1, 1, -1 
    645          IF( gdept_1d(jk) > 100. )  ik100 = jk - 1 
    646       END DO 
    647       IF (lwp) WRITE(numout,*) 
    648       IF (lwp) WRITE(numout,*) ' Level corresponding to 100m depth ',  ik100 + 1 
    649       IF (lwp) WRITE(numout,*) 
    650       ! 
    651       t_oce_co2_exp = 0._wp 
    652       ! 
    653       IF( nn_timing == 1 )  CALL timing_stop('p5z_sink_init') 
    654       ! 
    655   END SUBROUTINE p5z_sink_init 
    656  
    657 #endif 
    658  
    659285   SUBROUTINE p4z_sink2( pwsink, psinkflx, jp_tra, kiter ) 
    660286      !!--------------------------------------------------------------------- 
     
    782408 
    783409         &      sinkcal(jpi,jpj,jpk) , sinksil (jpi,jpj,jpk)   ,     &     
    784 #if defined key_kriest 
    785          &      xnumm(jpk)                                                        ,     &                 
    786 #else 
    787410         &      sinkfer2(jpi,jpj,jpk)                                             ,     &                 
    788 #endif 
    789411#if defined key_ligand 
    790412         &      wsfep(jpi,jpj,jpk)  , sinkfep(jpi,jpj,jpk)     ,     & 
Note: See TracChangeset for help on using the changeset viewer.