Ignore:
Timestamp:
Jul 24, 2024, 1:17:08 PM (6 months ago)
Author:
abarral
Message:

Rename modules in misc from *_mod > lmdz_*
Put cbrt.f90, ch*.f90, pch*.f90 in new lmdz_libmath_pch.f90

Location:
LMDZ6/branches/Amaury_dev/libf/phylmd
Files:
89 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/bl_for_dms.f90

    r5104 r5113  
    3939  PARAMETER (vk = 0.35)
    4040  REAL :: beta  ! coefficient d'evaporation reelle (/evapotranspiration)
    41   ! ! entre 0 et 1, mais 1 au-dessus de la mer
     41  ! entre 0 et 1, mais 1 au-dessus de la mer
    4242  PARAMETER (beta = 1.)
    4343  INTEGER :: i, k
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/condsurfc_new.f90

    r5110 r5113  
    7272      CALL exit(1)
    7373    ENDIF
    74     ! !print *,'lmt_bcff = ',lmt_bcff
    75     ! !stop
     74    !print *,'lmt_bcff = ',lmt_bcff
     75    !stop
    7676
    7777    ! BC emissions from non fossil fuel combustion
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/dustemission_mod.F90

    r5112 r5113  
    13741374
    13751375SUBROUTINE def_copyncl(kfin)
    1376       implicit none
     1376      IMPLICIT NONE
    13771377
    13781378 integer i,n,kfin,ideb,ifin,istep,kfin2
     
    14271427!c---------------------------------------------------------------
    14281428
    1429       implicit none
     1429      IMPLICIT NONE
    14301430      integer i1,i2,nclass,iout,ismin,ismax,k2,ihalf,idiff
    14311431      real siz(nclass),ds
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/inscav_spl.f90

    r5105 r5113  
    123123        beta = MIN(MAX(0.0, -beta), 1.0)
    124124      ELSE                          !--reevaporation non totale pour aerosols
    125         ! !print *,'FRAC USED IN INSCAV_SPL'
     125        !print *,'FRAC USED IN INSCAV_SPL'
    126126        beta = MIN(MAX(0.0, -beta) * frac, 1.0)
    127127      ENDIF
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/read_newemissions.f90

    r5110 r5113  
    120120  !  REAL dayemintime ! time in hours of the other emissions input files resolution
    121121  REAL :: jH_init ! shift in the hour (count as days) respecto to
    122   ! ! realhour = (pdtphys*i)/3600/24 -days_elapsed
     122  ! realhour = (pdtphys*i)/3600/24 -days_elapsed
    123123  REAL :: jH_emi, jH_vent, jH_day
    124124  SAVE jH_init, jH_vent, jH_day
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/sediment_mod.f90

    r5105 r5113  
    153153        v_dep_ss(i, k) = v_sed
    154154        sed_flux(i, k) = tr_seri(i, k, id_coss) * v_sed !g/cm3*m/sec
    155         ! !sed_ss3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
    156         ! ! conc_sed_ss3D(i,k)=sed_flux(i,k)*1.e6      !g/m3*sec !!!!!!!
     155        !sed_ss3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
     156        ! conc_sed_ss3D(i,k)=sed_flux(i,k)*1.e6      !g/m3*sec !!!!!!!
    157157        !
    158158      ENDDO          !klon
     
    221221        v_dep_dust(i, k) = v_sed
    222222        sed_flux(i, k) = tr_seri(i, k, id_codu) * v_sed !g/cm3.m/sec
    223         ! !sed_dust3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
     223        !sed_dust3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
    224224        !
    225225      ENDDO          !klon
     
    288288        v_dep_dustsco(i, k) = v_sed
    289289        sed_flux(i, k) = tr_seri(i, k, id_scdu) * v_sed !g/cm3.m/sec
    290         ! !sed_dustsco3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
     290        !sed_dustsco3D(i,k)= -sed_flux(i,k)/zdz(i,k)      !g/cm3*sec !!!!!!!
    291291        !
    292292      ENDDO          !klon
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/bulk_flux_m.F90

    r5103 r5113  
    11module bulk_flux_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/config_ocean_skin_m.F90

    r5112 r5113  
    11module config_ocean_skin_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55  logical, protected:: jcool ! cool skin calculation
     
    3131#ifdef IN_LMDZ
    3232    use lmdz_ioipsl_getin_p, only: getin_p
    33     use assert_m, only: assert
     33    use lmdz_assert, only: assert
    3434#endif
    3535
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/const.F90

    r5103 r5113  
    11module const
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55  real, parameter :: beta = 0.756 / 1023.343
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/esat_m.F90

    r3834 r5113  
    11module esat_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/fv_m.F90

    r3834 r5113  
    11module fv_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/mom_flux_rain_m.F90

    r3834 r5113  
    11module mom_flux_rain_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/phiw_m.F90

    r3834 r5113  
    11module Phiw_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/sens_heat_rain_m.F90

    r4176 r5113  
    11module sens_heat_rain_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Ocean_skin/therm_expans_m.F90

    r3834 r5113  
    11module therm_expans_m
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55contains
  • LMDZ6/branches/Amaury_dev/libf/phylmd/StratAer/sulfate_aer_mod.F90

    r5105 r5113  
    773773!     and Noppel et al. (1990)
    774774
    775       implicit none
     775      IMPLICIT NONE
    776776      real, intent(in) :: T
    777777      real, parameter ::      &
     
    792792!     equilibrium H2SO4 number density over pure H2SO4 (molec/cm3)
    793793
    794       implicit none
     794      IMPLICIT NONE
    795795      real, intent(in) :: T
    796796      real :: presat
     
    811811!     equilibrium H2O pressure over pure liquid water (Pa)
    812812
    813       implicit none
     813      IMPLICIT NONE
    814814      real, intent(in) :: T
    815815
     
    841841!---->Vehkamaeki et al. (2002)
    842842
    843       implicit none
     843      IMPLICIT NONE
    844844      real, intent(in) :: T, so4mfrac
    845845      real, parameter :: &
     
    891891!---->Vehkamaeki et al. (2002)
    892892
    893       implicit none
     893      IMPLICIT NONE
    894894      real,intent(in) :: T, so4frac
    895895      real :: a,b,so4mfrac,so4m2,so4m3,so4m4,so4m5,so4sig
     
    941941!                     = h2so4 mass fraction*100.
    942942
    943       implicit none
     943      IMPLICIT NONE
    944944      real, intent(in) :: pph2o, T
    945945     
     
    10041004!     equilibrium h2so4 number density over H2SO4/H2O solution (molec/cm3)
    10051005
    1006       implicit none
     1006      IMPLICIT NONE
    10071007      real, intent(in) :: T, xa       ! T(K)  xa(H2SO4 mass fraction)
    10081008     
     
    10261026!     partial molar volume of h2so4 in h2so4/h2o solution (cm3/mole)
    10271027
    1028       implicit none
     1028      IMPLICIT NONE
    10291029      real, intent(in) :: T, ws
    10301030      real, dimension(22),parameter :: x=(/  &
     
    10491049!     molar volume of pure h2o (cm3/mole)
    10501050
    1051        implicit none
     1051       IMPLICIT NONE
    10521052       real, intent(in) :: T
    10531053       real, parameter :: x1=2.393284E-02,x2=-4.359335E-05,x3=7.961181E-08
  • LMDZ6/branches/Amaury_dev/libf/phylmd/acama_gwd_rando_m.F90

    r5112 r5113  
    44module ACAMA_GWD_rando_m
    55
    6   implicit none
     6  IMPLICIT NONE
    77
    88contains
     
    2222!  ONLINE:
    2323    use dimphy, only: klon, klev
    24     use assert_m, only: assert
     24    use lmdz_assert, only: assert
    2525    USE lmdz_ioipsl_getin_p, ONLY: getin_p
    2626    USE lmdz_vertical_layers, ONLY: presnivs
  • LMDZ6/branches/Amaury_dev/libf/phylmd/calbeta_clim.F90

    r5112 r5113  
    1515  USE lmdz_print_control, ONLY: prt_level
    1616
    17   implicit none
     17  IMPLICIT NONE
    1818  integer klon,nt,j,it
    1919  real logbeta(klon),pi
  • LMDZ6/branches/Amaury_dev/libf/phylmd/calltherm.F90

    r5112 r5113  
    4242#endif
    4343
    44       implicit none
     44      IMPLICIT NONE
    4545      include "clesphys.h"
    4646      include "thermcell_old.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/coare30_flux_cnrm_mod.F90

    r5111 r5113  
    66
    77module coare30_flux_cnrm_mod
    8   implicit none
    9   private
     8  IMPLICIT NONE
     9  PRIVATE
    1010  public COARE30_FLUX_CNRM
    1111
  • LMDZ6/branches/Amaury_dev/libf/phylmd/coare_cp_mod.F90

    r5103 r5113  
    11module coare_cp_mod
    2   implicit none
    3   private
     2  IMPLICIT NONE
     3  PRIVATE
    44  public psit_30, psiuo, coare_cp
    55
     
    77
    88  real function psit_30(zet)
    9     implicit none
     9    IMPLICIT NONE
    1010    real, intent(in) :: zet
    1111
     
    2727
    2828  real function psiuo(zet)
    29     implicit none
     29    IMPLICIT NONE
    3030    real, intent(in) :: zet
    3131
  • LMDZ6/branches/Amaury_dev/libf/phylmd/conccm.F90

    r5105 r5113  
    259259  REAL shprme ! intermediate specific humidity pert.
    260260  REAL qsattp ! saturation mixing ratio for
    261   ! ! thermally perturbed PBL parcels
     261  ! thermally perturbed PBL parcels
    262262  REAL dz ! local layer depth
    263263  REAL b1 ! bouyancy measure in detrainment lvl
  • LMDZ6/branches/Amaury_dev/libf/phylmd/convect3.F90

    r5105 r5113  
    234234
    235235  nopt = 0
    236   ! !      NOPT=1 ! sbl
     236  !      NOPT=1 ! sbl
    237237
    238238  ! ***            PERFORM DRY ADIABATIC ADJUSTMENT            ***
     
    303303      fv2(i) = (v(i)-v1(i))/delt ! sbl
    304304
    305       ! !            T1(I)=T(I)      ! commente sbl
    306       ! !            R1(I)=RR(I)     ! commente sbl
     305      !            T1(I)=T(I)      ! commente sbl
     306      !            R1(I)=RR(I)     ! commente sbl
    307307    END DO
    308308  END IF
     
    13131313  ! *** Diagnose the in-cloud mixing ratio   ***              ! cld
    13141314  ! ***           of condensed water         ***              ! cld
    1315   ! ! cld
     1315  ! cld
    13161316  DO i = 1, nd ! cld
    13171317    maa(i) = 0.0 ! cld
  • LMDZ6/branches/Amaury_dev/libf/phylmd/create_limit_unstruct_mod.F90

    r5111 r5113  
    179179 
    180180  SUBROUTINE time_interpolation(ndays,field_in,calendar,field_out)
    181   USE pchsp_95_m, only: pchsp_95
    182   USE pchfe_95_m, only: pchfe_95
    183   USE arth_m, only: arth
     181  USE lmdz_libmath_pch, only: pchsp_95, pchfe_95
     182  USE lmdz_arth, only: arth
    184183  USE dimphy, ONLY: klon
    185184  USE ioipsl,             ONLY: ioget_year_len
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cv30_routines.F90

    r5112 r5113  
    331331  icbmax = 2
    332332  DO i = 1, len
    333     ! !        icbmax=max(icbmax,icb(i))
     333    !        icbmax=max(icbmax,icb(i))
    334334    IF (iflag(i)<7) icbmax = max(icbmax, icb(i)) ! sb Jun7th02
    335335  END DO
     
    420420
    421421  ! Re-compute icbsmax (icbsmax2):        !convect3
    422   ! !convect3
     422  !convect3
    423423  icbsmax2 = 2 !convect3
    424424  DO i = 1, len !convect3
     
    12771277  END DO
    12781278
    1279   ! !      if(inb.lt.(nl-1))then
    1280   ! !         do 85 i=inb+1,nl-1
    1281   ! !            sig(i)=beta*sig(i)+2.*alpha*buoy(inb)*
    1282   ! !     1              abs(buoy(inb))
    1283   ! !            sig(i)=amax1(sig(i),0.0)
    1284   ! !            w0(i)=beta*w0(i)
    1285   ! !   85    continue
    1286   ! !      end if
    1287 
    1288   ! !      do 87 i=1,icb
    1289   ! !         sig(i)=beta*sig(i)-2.*alpha*buoy(icb)*buoy(icb)
    1290   ! !         sig(i)=amax1(sig(i),0.0)
    1291   ! !         w0(i)=beta*w0(i)
    1292   ! !   87 continue
     1279  !      if(inb.lt.(nl-1))then
     1280  !         do 85 i=inb+1,nl-1
     1281  !            sig(i)=beta*sig(i)+2.*alpha*buoy(inb)*
     1282  !     1              abs(buoy(inb))
     1283  !            sig(i)=amax1(sig(i),0.0)
     1284  !            w0(i)=beta*w0(i)
     1285  !   85    continue
     1286  !      end if
     1287
     1288  !      do 87 i=1,icb
     1289  !         sig(i)=beta*sig(i)-2.*alpha*buoy(icb)*buoy(icb)
     1290  !         sig(i)=amax1(sig(i),0.0)
     1291  !         w0(i)=beta*w0(i)
     1292  !   87 continue
    12931293
    12941294  ! -------------------------------------------------------------
     
    13731373
    13741374
    1375   ! !      cape=0.0
    1376   ! !      do 98 i=icb+1,inb
    1377   ! !         deltap = min(pbase,ph(i-1))-min(pbase,ph(i))
    1378   ! !         cape=cape+rrd*buoy(i-1)*deltap/p(i-1)
    1379   ! !         dcape=rrd*buoy(i-1)*deltap/p(i-1)
    1380   ! !         dlnp=deltap/p(i-1)
    1381   ! !         cape=amax1(0.0,cape)
    1382   ! !         sigold=sig(i)
    1383 
    1384   ! !         dtmin=100.0
    1385   ! !         do 97 j=icb,i-1
    1386   ! !            dtmin=amin1(dtmin,buoy(j))
    1387   ! !   97    continue
    1388 
    1389   ! !         sig(i)=beta*sig(i)+alpha*dtmin*abs(dtmin)
    1390   ! !         sig(i)=amax1(sig(i),0.0)
    1391   ! !         sig(i)=amin1(sig(i),0.01)
    1392   ! !         fac=amin1(((dtcrit-dtmin)/dtcrit),1.0)
    1393   ! !         w=(1.-beta)*fac*sqrt(cape)+beta*w0(i)
    1394   ! !         amu=0.5*(sig(i)+sigold)*w
    1395   ! !         m(i)=amu*0.007*p(i)*(ph(i)-ph(i+1))/tv(i)
    1396   ! !         w0(i)=w
    1397   ! !   98 continue
    1398   ! !      w0(icb)=0.5*w0(icb+1)
    1399   ! !      m(icb)=0.5*m(icb+1)*(ph(icb)-ph(icb+1))/(ph(icb+1)-ph(icb+2))
    1400   ! !      sig(icb)=sig(icb+1)
    1401   ! !      sig(icb-1)=sig(icb)
     1375  !      cape=0.0
     1376  !      do 98 i=icb+1,inb
     1377  !         deltap = min(pbase,ph(i-1))-min(pbase,ph(i))
     1378  !         cape=cape+rrd*buoy(i-1)*deltap/p(i-1)
     1379  !         dcape=rrd*buoy(i-1)*deltap/p(i-1)
     1380  !         dlnp=deltap/p(i-1)
     1381  !         cape=amax1(0.0,cape)
     1382  !         sigold=sig(i)
     1383
     1384  !         dtmin=100.0
     1385  !         do 97 j=icb,i-1
     1386  !            dtmin=amin1(dtmin,buoy(j))
     1387  !   97    continue
     1388
     1389  !         sig(i)=beta*sig(i)+alpha*dtmin*abs(dtmin)
     1390  !         sig(i)=amax1(sig(i),0.0)
     1391  !         sig(i)=amin1(sig(i),0.01)
     1392  !         fac=amin1(((dtcrit-dtmin)/dtcrit),1.0)
     1393  !         w=(1.-beta)*fac*sqrt(cape)+beta*w0(i)
     1394  !         amu=0.5*(sig(i)+sigold)*w
     1395  !         m(i)=amu*0.007*p(i)*(ph(i)-ph(i+1))/tv(i)
     1396  !         w0(i)=w
     1397  !   98 continue
     1398  !      w0(icb)=0.5*w0(icb+1)
     1399  !      m(icb)=0.5*m(icb+1)*(ph(icb)-ph(icb+1))/(ph(icb+1)-ph(icb+2))
     1400  !      sig(icb)=sig(icb+1)
     1401  !      sig(icb-1)=sig(icb)
    14021402
    14031403END SUBROUTINE cv30_closure
     
    18721872  ! enddo
    18731873  ! enddo
    1874   ! ! RomP >>>
     1874  ! RomP >>>
    18751875  DO i = 1, nd
    18761876    DO il = 1, ncum
     
    18791879    END DO
    18801880  END DO
    1881   ! ! RomP <<<
     1881  ! RomP <<<
    18821882
    18831883  ! ***  check whether ep(inb)=0, if so, skip precipitating    ***
     
    22892289  ! ***  NE PAS UTILISER POUR L'INSTANT ***
    22902290
    2291   ! !      do il=1,ncum
    2292   ! !        wd(il)=betad*abs(mp(il,icb(il)))*0.01*rrd*t(il,icb(il))
    2293   ! !     :                                  /(sigd*p(il,icb(il)))
    2294   ! !      enddo
     2291  !      do il=1,ncum
     2292  !        wd(il)=betad*abs(mp(il,icb(il)))*0.01*rrd*t(il,icb(il))
     2293  !     :                                  /(sigd*p(il,icb(il)))
     2294  !      enddo
    22952295
    22962296
     
    29432943  ! *** diagnose the in-cloud mixing ratio   ***            ! cld
    29442944  ! ***           of condensed water         ***            ! cld
    2945   ! ! cld
     2945  ! cld
    29462946
    29472947  DO i = 1, nd ! cld
     
    30043004END SUBROUTINE cv30_yield
    30053005
    3006 ! !RomP >>>
     3006!RomP >>>
    30073007SUBROUTINE cv30_tracer(nloc, len, ncum, nd, na, ment, sij, da, phi, phi2, &
    30083008        d1a, dam, ep, vprecip, elij, clw, epmlmmm, eplamm, icb, inb)
     
    30623062      DO i = 1, ncum
    30633063        IF (k>=icb(i) .AND. k<=inb(i) .AND. j<=inb(i)) THEN
    3064           ! !jyg             epm(i,j,k)=1.-(1.-ep(i,j))*clw(i,j)/elij(i,k,j)
     3064          !jyg             epm(i,j,k)=1.-(1.-ep(i,j))*clw(i,j)/elij(i,k,j)
    30653065          epm(i, j, k) = 1. - (1. - ep(i, j)) * clw(i, j) / max(elij(i, k, j), 1.E-16)
    3066           ! !
     3066          !
    30673067          epm(i, j, k) = max(epm(i, j, k), 0.0)
    30683068        END IF
     
    32483248        , epmax_diag)
    32493249  USE lmdz_abort_physic, ONLY: abort_physic
    3250   implicit none
     3250  IMPLICIT NONE
    32513251
    32523252  ! On fait varier epmax en fn de la cape
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cv3_routines.F90

    r5112 r5113  
    51315131                 , pbase, p, ph, tv, buoy, sig, w0,iflag &
    51325132                 , epmax_diag)
    5133         implicit none
     5133        IMPLICIT NONE
    51345134
    51355135        ! On fait varier epmax en fn de la cape
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cv_routines.F90

    r5112 r5113  
    16321632  ! *** diagnose the in-cloud mixing ratio   ***            ! cld
    16331633  ! ***           of condensed water         ***            ! cld
    1634   ! ! cld
     1634  ! cld
    16351635  DO ij = 1, ncum ! cld
    16361636    DO i = 1, nd ! cld
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/lmdz_1dutils.f90

    r5112 r5113  
    12461246    !   avec w=omega * dt
    12471247    !---------------------------------------------------------------
    1248     implicit none
     1248    IMPLICIT NONE
    12491249    ! arguments
    12501250    integer llm
     
    12821282    !   sans WTG rajouter une advection horizontale
    12831283    !----------------------------------------------------------------------
    1284     implicit none
     1284    IMPLICIT NONE
    12851285    include "YOMCST.h"
    12861286    !        argument
     
    13541354    !   sans WTG rajouter une advection horizontale
    13551355    !----------------------------------------------------------------------
    1356     implicit none
     1356    IMPLICIT NONE
    13571357    include "YOMCST.h"
    13581358    !        argument
     
    14291429    USE dimphy
    14301430
    1431     implicit none
     1431    IMPLICIT NONE
    14321432
    14331433    ! ========================================================
     
    14771477    USE dimphy
    14781478
    1479     implicit none
     1479    IMPLICIT NONE
    14801480
    14811481    ! ========================================================
     
    15101510    USE dimphy
    15111511
    1512     implicit none
     1512    IMPLICIT NONE
    15131513
    15141514    ! ========================================================
     
    15991599    USE dimphy
    16001600
    1601     implicit none
     1601    IMPLICIT NONE
    16021602
    16031603    ! ========================================================
     
    16641664          &, dth_mod_cas, hth_mod_cas, vth_mod_cas, mxcalc)
    16651665
    1666     implicit none
     1666    IMPLICIT NONE
    16671667
    16681668    include "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/lmdz_old_1dconv.f90

    r5104 r5113  
    88          &       Ts, imp_fcg, ts_fcg, Tp_fcg, Turb_fcg)
    99
    10     implicit none
     10    IMPLICIT NONE
    1111
    1212    !ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
     
    458458          &, d_t_adv, d_q_adv)
    459459    use dimphy
    460     implicit none
     460    IMPLICIT NONE
    461461
    462462    INCLUDE "dimensions.h"
     
    490490
    491491  SUBROUTINE copie(klevgcm, playgcm, psolgcm, file_forctl)
    492     implicit none
     492    IMPLICIT NONE
    493493
    494494    !cccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
     
    703703
    704704  SUBROUTINE corresbis(psol)
    705     implicit none
     705    IMPLICIT NONE
    706706
    707707    !cccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/mod_1D_amma_read.F90

    r5105 r5113  
    5757
    5858SUBROUTINE read_1D_cases
    59       implicit none
     59      IMPLICIT NONE
    6060
    6161      INTEGER nid,rid,ierr
     
    176176
    177177!program reading forcings of the AMMA case study
    178       implicit none
     178      IMPLICIT NONE
    179179
    180180      integer ntime,nlevel
     
    348348           ,vitw_amma,ht_amma,hq_amma,lat_amma,sens_amma               &
    349349           ,vitw_prof,ht_prof,hq_prof,lat_prof,sens_prof)
    350         implicit none
     350        IMPLICIT NONE
    351351
    352352!---------------------------------------------------------------------------------------
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/mod_1D_cases_read.F90

    r5105 r5113  
    819819
    820820
    821         implicit none
     821        IMPLICIT NONE
    822822
    823823!---------------------------------------------------------------------------------------
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/mod_1D_cases_read2.F90

    r5105 r5113  
    8080
    8181  SUBROUTINE read_1D_cas
    82     implicit none
     82    IMPLICIT NONE
    8383
    8484    INTEGER nid,rid,ierr
     
    189189  !**********************************************************************************************
    190190  SUBROUTINE read2_1D_cas
    191     implicit none
     191    IMPLICIT NONE
    192192
    193193    INTEGER nid,rid,ierr
     
    314314  !**********************************************************************************************
    315315  SUBROUTINE old_read_SCM_cas
    316     implicit none
     316    IMPLICIT NONE
    317317
    318318    INCLUDE "date_cas.h"
     
    535535
    536536  !program reading forcing of the case study
    537   implicit none
     537  IMPLICIT NONE
    538538
    539539  integer ntime,nlevel
     
    650650
    651651  !program reading forcing of the case study
    652   implicit none
     652  IMPLICIT NONE
    653653
    654654  integer ntime,nlevel
     
    819819
    820820  !program reading forcing of the case study
    821   implicit none
     821  IMPLICIT NONE
    822822
    823823  integer ntime,nlevel,k,t
     
    10381038
    10391039
    1040   implicit none
     1040  IMPLICIT NONE
    10411041
    10421042  !---------------------------------------------------------------------------------------
     
    12471247
    12481248
    1249   implicit none
     1249  IMPLICIT NONE
    12501250
    12511251  !---------------------------------------------------------------------------------------
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/mod_1D_cases_read_std.F90

    r5105 r5113  
    8989  !**********************************************************************************************
    9090  SUBROUTINE read_SCM_cas
    91     implicit none
     91    IMPLICIT NONE
    9292
    9393    INCLUDE "date_cas.h"
     
    329329
    330330    !program reading forcing of the case study
    331     implicit none
     331    IMPLICIT NONE
    332332    INCLUDE "compar1d.h"
    333333
     
    658658
    659659
    660     implicit none
     660    IMPLICIT NONE
    661661
    662662    !---------------------------------------------------------------------------------------
     
    930930       ,dth_mod_cas,hth_mod_cas,vth_mod_cas,mxcalc)
    931931
    932     implicit none
     932    IMPLICIT NONE
    933933
    934934    INCLUDE "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/old_1DUTILS_read_interp.h

    r5105 r5113  
    33     &             ,ts_toga,plev_toga,t_toga,q_toga,u_toga,v_toga,w_toga        &
    44     &             ,ht_toga,vt_toga,hq_toga,vq_toga)
    5       implicit none
     5      IMPLICIT NONE
    66
    77!-------------------------------------------------------------------------
     
    6565!-------------------------------------------------------------------------
    6666      SUBROUTINE read_sandu(fich_sandu,nlev_sandu,nt_sandu,ts_sandu)
    67       implicit none
     67      IMPLICIT NONE
    6868
    6969!-------------------------------------------------------------------------
     
    102102      SUBROUTINE read_astex(fich_astex,nlev_astex,nt_astex,div_astex,      &
    103103     & ts_astex,ug_astex,vg_astex,ufa_astex,vfa_astex)
    104       implicit none
     104      IMPLICIT NONE
    105105
    106106!-------------------------------------------------------------------------
     
    150150
    151151
    152       implicit none
     152      IMPLICIT NONE
    153153
    154154      integer ntime,nlevel
     
    495495            nf90_inq_dimid,nf90_inquire_dimension
    496496
    497          implicit none
     497         IMPLICIT NONE
    498498         integer nid,ttm,llm
    499499         real*8 time(ttm)
     
    543543     &         ,omega_mod,o3mmr_mod,mxcalc)
    544544
    545        implicit none
     545       IMPLICIT NONE
    546546
    547547      INCLUDE "dimensions.h"
     
    657657     &         ,tke_mod,o3mmr_mod,mxcalc)
    658658
    659        implicit none
     659       IMPLICIT NONE
    660660
    661661      INCLUDE "dimensions.h"
     
    776776     &             ,ts_rico,t_rico,q_rico,u_rico,v_rico,w_rico             &
    777777     &             ,dth_dyn,dqh_dyn)
    778       implicit none
     778      IMPLICIT NONE
    779779
    780780!-------------------------------------------------------------------------
     
    939939     &             ,year_ini_sandu,day_ini_sandu,nt_sandu,dt_sandu         &
    940940     &             ,nlev_sandu,ts_sandu,ts_prof)
    941         implicit none
     941        IMPLICIT NONE
    942942
    943943!---------------------------------------------------------------------------------------
     
    10141014      SUBROUTINE read_armcu(fich_armcu,nlev_armcu,nt_armcu,                &
    10151015     & sens,flat,adv_theta,rad_theta,adv_qt)
    1016       implicit none
     1016      IMPLICIT NONE
    10171017
    10181018!-------------------------------------------------------------------------
     
    10551055     &         ,ht_mod,vt_mod,hq_mod,vq_mod,mxcalc)
    10561056 
    1057        implicit none
     1057       IMPLICIT NONE
    10581058 
    10591059      INCLUDE "dimensions.h"
     
    11771177     &         ,dt_mod_cas,ht_mod_cas,vt_mod_cas,dtrad_mod_cas,dq_mod_cas,hq_mod_cas,vq_mod_cas,mxcalc)
    11781178 
    1179        implicit none
     1179       IMPLICIT NONE
    11801180 
    11811181       INCLUDE "dimensions.h"
     
    13361336     &         ,ht_mod,hq_mod,hu_mod,hv_mod,w_mod,omega_mod,mxcalc)
    13371337 
    1338        implicit none
     1338       IMPLICIT NONE
    13391339 
    13401340       INCLUDE "dimensions.h"
     
    14581458     &             ,ufa_astex,vfa_astex,div_prof,ts_prof,ug_prof,vg_prof   &
    14591459     &             ,ufa_prof,vfa_prof)
    1460         implicit none
     1460        IMPLICIT NONE
    14611461
    14621462!---------------------------------------------------------------------------------------
     
    15501550     &             ,ts_prof,plev_prof,t_prof,q_prof,u_prof,v_prof,w_prof   &
    15511551     &             ,ht_prof,vt_prof,hq_prof,vq_prof)
    1552         implicit none
     1552        IMPLICIT NONE
    15531553
    15541554!---------------------------------------------------------------------------------------
     
    16921692     &             ,ustar_prof,psurf_prof,ug_prof,vg_prof                 &
    16931693     &             ,ht_prof,hq_prof,hu_prof,hv_prof,w_prof,omega_prof)
    1694         implicit none
     1694        IMPLICIT NONE
    16951695
    16961696!---------------------------------------------------------------------------------------
     
    18051805     &             ,ug_gabls4,vg_gabls4,ht_gabls4,hq_gabls4,tg_gabls4                          &
    18061806     &             ,ug_prof,vg_prof,ht_prof,hq_prof,tg_prof)
    1807         implicit none
     1807        IMPLICIT NONE
    18081808
    18091809!---------------------------------------------------------------------------------------
     
    18921892     &             ,nlev_armcu,fs_armcu,fl_armcu,at_armcu,rt_armcu         &
    18931893     &             ,aqt_armcu,fs_prof,fl_prof,at_prof,rt_prof,aqt_prof)
    1894         implicit none
     1894        IMPLICIT NONE
    18951895
    18961896!---------------------------------------------------------------------------------------
     
    19721972     &           wfls,dqtdxls,dqtdyls,dqtdtls,                             &
    19731973     &           thlpcar,tracer,nt1,nt2)
    1974       implicit none
     1974      IMPLICIT NONE
    19751975
    19761976        integer nlev_max,kmax,kmax2,ntrac
     
    20452045     &       thlprof,qprof,uprof,vprof,wprof,omega,o3mmr)
    20462046!======================================================================
    2047       implicit none
     2047      IMPLICIT NONE
    20482048
    20492049        integer nlev_max,kmax
     
    20772077     &    thlprof,qvprof,qlprof,qtprof,uprof,vprof,wprof,tkeprof,o3mmr)
    20782078!======================================================================
    2079       implicit none
     2079      IMPLICIT NONE
    20802080
    20812081        integer nlev_max,kmax
     
    21112111     &       vprof,thetaprof,tprof,qvprof,rvprof,aprof,bprof)
    21122112!======================================================================
    2113       implicit none
     2113      IMPLICIT NONE
    21142114
    21152115        integer nlev_max,kmax
     
    21722172      use netcdf, ONLY: nf90_open,nf90_nowrite,nf90_noerr,nf90_strerror,nf90_inq_varid,nf90_get_var,&
    21732173            nf90_inq_dimid,nf90_inquire_dimension
    2174       implicit none
     2174      IMPLICIT NONE
    21752175
    21762176      integer ntime,nlevel
     
    23832383            nf90_inq_dimid,nf90_inquire_dimension
    23842384
    2385       implicit none
     2385      IMPLICIT NONE
    23862386
    23872387      INCLUDE "YOMCST.h"
     
    27172717            nf90_inq_dimid,nf90_inquire_dimension
    27182718
    2719       implicit none
     2719      IMPLICIT NONE
    27202720
    27212721      integer ntime,nlevel,nsol
  • LMDZ6/branches/Amaury_dev/libf/phylmd/dyn1d/replay1d.F90

    r5103 r5113  
    1010
    1111
    12       implicit none
     12      IMPLICIT NONE
    1313      INCLUDE "dimensions.h"
    1414
  • LMDZ6/branches/Amaury_dev/libf/phylmd/flott_gwd_rando_m.F90

    r5112 r5113  
    33module FLOTT_GWD_rando_m
    44
    5   implicit none
     5  IMPLICIT NONE
    66
    77contains
     
    1919    !ONLINE:
    2020    use dimphy, only: klon, klev
    21     use assert_m, only: assert
     21    use lmdz_assert, only: assert
    2222    USE lmdz_ioipsl_getin_p, ONLY: getin_p
    2323    USE lmdz_vertical_layers, ONLY: presnivs
  • LMDZ6/branches/Amaury_dev/libf/phylmd/fonte_neige_mod.F90

    r5111 r5113  
    1616! run_off_ter and run_off_lic are the runoff at the compressed grid knon for
    1717! land and land-ice respectively
    18 ! Note: run_off_lic is used in mod_landice and therfore not private
     18! Note: run_off_lic is used in mod_landice and therfore not PRIVATE
    1919  REAL, ALLOCATABLE, DIMENSION(:), PRIVATE    :: run_off_ter
    2020  !$OMP THREADPRIVATE(run_off_ter)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/global_mean.F90

    r5110 r5113  
    1010  use lmdz_phys_mpi_data, only: is_mpi_root
    1111  USE ioipsl
    12   implicit none
     12  IMPLICIT NONE
    1313
    1414  real,dimension(klon),intent(in) :: field
  • LMDZ6/branches/Amaury_dev/libf/phylmd/grid_index.F90

    r5112 r5113  
    77USE dimphy, ONLY: klon
    88USE lmdz_geometry, ONLY: latitude_deg, longitude_deg
    9 implicit none
     9IMPLICIT NONE
    1010real, intent(in) :: lon_deg,lat_deg
    1111integer :: grid_index
  • LMDZ6/branches/Amaury_dev/libf/phylmd/grid_noro_m.F90

    r5112 r5113  
    77
    88  USE lmdz_print_control, ONLY: lunout
    9   USE assert_eq_m,       ONLY: assert_eq
     9  USE lmdz_assert_eq,       ONLY: assert_eq
    1010  PRIVATE
    1111  PUBLIC :: grid_noro, grid_noro0, read_noro
  • LMDZ6/branches/Amaury_dev/libf/phylmd/ini_undefSTD.F90

    r5105 r5113  
    2323
    2424  ! nout=1 !var. journaliere "day" moyenne sur tous les pas de temps
    25   ! ! de la physique
     25  ! de la physique
    2626  ! nout=2 !var. mensuelle "mth" moyennee sur tous les pas de temps
    27   ! ! de la physique
     27  ! de la physique
    2828  ! nout=3 !var. mensuelle "NMC" moyennee toutes les 6heures
    2929
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/inlandsis.f90

    r5105 r5113  
    336336
    337337  data      Z0mBS0 /   0.5e-6/            ! MINimum Snow Roughness Length
    338                                           ! ! for Momentum if Blowing Snow
    339                                           ! ! Gallee et al. 2001 BLM 99 (19)
     338                                          ! for Momentum if Blowing Snow
     339                                          ! Gallee et al. 2001 BLM 99 (19)
    340340  data      Z0m_S0/    0.00005/           ! MINimum Snow Roughness Length
    341                                           ! ! MegaDunes    included
     341                                          ! MegaDunes    included
    342342  data      Z0m_S1/    0.030  /           ! MAXimum Snow Roughness Length
    343                                           ! !        (Sastrugis)
     343                                          !        (Sastrugis)
    344344  ! #GL data      Z0_GIM/    0.0013/            ! Ice Min Z0 = 0.0013 m (Broeke)
    345                                           ! ! Old Ice Z0 = 0.0500 m (Bruce)
    346                                           ! !              0.0500 m (Smeets)
    347                                           ! !              0.1200 m (Broeke)
     345                                          ! Old Ice Z0 = 0.0500 m (Bruce)
     346                                          !              0.0500 m (Smeets)
     347                                          !              0.1200 m (Broeke)
    348348  data      Z0_ICE/    0.0010/            ! Sea-Ice Z0 = 0.0010 m (Andreas)
    349                                           ! !    (Ice Station Weddel -- ISW)
     349                                          !    (Ice Station Weddel -- ISW)
    350350  ! for aerolian erosion
    351351  data      SblPom/ 1.27/   ! Lower Boundary Height Parameter
     
    436436
    437437    rCd10n =  1. / 26.5 ! Vt / u*t = 26.5
    438                  ! ! Budd et al. 1965, Antarct. Res. Series Fig.13
    439                  ! ! ratio developped during assumed neutral conditions
     438                 ! Budd et al. 1965, Antarct. Res. Series Fig.13
     439                 ! ratio developped during assumed neutral conditions
    440440
    441441
     
    554554        ! sss__G      =  0.27417     * gravit
    555555
    556   ! ! ______________               _____
    557   ! ! Newton-Raphson (! Iteration, BEGIN)
    558   ! ! ~~~~~~~~~~~~~~               ~~~~~
     556  ! ______________               _____
     557  ! Newton-Raphson (! Iteration, BEGIN)
     558  ! ~~~~~~~~~~~~~~               ~~~~~
    559559        ! DO iit=1,nit
    560560        ! sss__K      =  gravit      * r_Turb * A_Turb *za__SV(ikl)
     
    580580   !      us__SV(ikl)= max(us__SV(ikl),epsi  )
    581581   !      rCDmSV(ikl)=     us__SV(ikl)/VVa_OK
    582   ! ! #AE     sss__F     =     vonkar     /rCDmSV(ikl)
     582  ! #AE     sss__F     =     vonkar     /rCDmSV(ikl)
    583583   !      ENDDO
    584584
    585   ! ! ______________               ___
    586   ! ! Newton-Raphson (! Iteration, END  )
    587   ! ! ~~~~~~~~~~~~~~               ~~~
     585  ! ______________               ___
     586  ! Newton-Raphson (! Iteration, END  )
     587  ! ~~~~~~~~~~~~~~               ~~~
    588588
    589589   !      us_127      =  exp(    SblPom *log(us__SV(ikl)))
    590590   !      us_227      =  us_127         *    us__SV(ikl)
    591591
    592   ! ! Momentum            Turbulent Scale  u*: 0-Limit in case of no Blow. Snow
    593   ! ! ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
     592  ! Momentum            Turbulent Scale  u*: 0-Limit in case of no Blow. Snow
     593  ! ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
    594594   !      dusuth      =  us__SV(ikl) - usthSV(ikl)       ! u* - uth*
    595595   !      signus      =  max(sign(unun,dusuth),zero)     ! 1 <=> u* - uth* > 0
     
    664664        if (is_ok_density_kotlyakov) then
    665665            tt_tmp = TaT_SV(ikl)-TfSnow
    666             ! !vv_tmp = VV10SV(ikl)
     666            !vv_tmp = VV10SV(ikl)
    667667            vv_tmp=VV__SV(ikl) ! Etienne: use wind speed at first model level instead of 10m wind
    668668  ! + ...         [ A compromise between
     
    10041004
    10051005        e_pRad = 2.5   *  coszSV(ikl)       ! exponential argument,
    1006                                             ! ! V/nIR radiation partitioning,
    1007                                             ! ! DR97, 2, eqn (2.53) & (2.54)
     1006                                            ! V/nIR radiation partitioning,
     1007                                            ! DR97, 2, eqn (2.53) & (2.54)
    10081008        e1pRad = 1.-exp(-e_pRad)            ! exponential, V/nIR Rad. Part.
    10091009        exdRad= 1.
     
    11861186
    11871187      TBr_sv(ikl) =sqrt(sqrt(IRu_SV(ikl)/StefBo))      ! Brightness
    1188                                                        ! ! Temperature
     1188                                                       ! Temperature
    11891189      uts_SV(ikl) =     (HSv_sv(ikl) +HSs_sv(ikl)) & ! u*T*
    11901190            /(rhT_SV(ikl) *cp)          !
     
    13181318  ! +  ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
    13191319      A_Fact      =  1.0000        ! Andreas et al., 2004, p.4
    1320                                    ! ! ams.confex.com/ams/pdfpapers/68601.pdf
     1320                                   ! ams.confex.com/ams/pdfpapers/68601.pdf
    13211321
    13221322  ! Parameterization of z0 dependance on Temperature (C. Amory, 2017)
     
    13411341        Z0_obs = exp(coefa*TaT_SV(ikl) + coefb)
    13421342      else if (TaT_SV(ikl)>=ta2 .and. TaT_SV(ikl)<ta3) then
    1343         ! ! if st > 0, melting induce smooth surface
     1343        ! if st > 0, melting induce smooth surface
    13441344        Z0_obs = exp(coefc*TaT_SV(ikl) + coefd)
    13451345      else
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_bsn.f90

    r5105 r5113  
    5050  ! +  =======
    5151
    52   ! !DO isn = nsno,2,-1
     52  !DO isn = nsno,2,-1
    5353  DO ikl = 1,knonv
    5454
     
    7070          /max(epsi,ro__SV(ikl,isn))
    7171
    72     ! ! Densification of the uppermost snow layer if erosion:
     72    ! Densification of the uppermost snow layer if erosion:
    7373    if((dzweqo-dzweqn)>0                    .and. &
    7474          dzsnSV(ikl,isn)>0                    .and. &
    7575          ro__SV(ikl,max(1,isnoSV(ikl)))<roBdSV) then
    7676
    77     ! !characteristic time scale for drifting snow compaction set to 24h
    78     ! !linear densification rate [kg/m3/s] over 24h
     77    !characteristic time scale for drifting snow compaction set to 24h
     78    !linear densification rate [kg/m3/s] over 24h
    7979    densif         = (450. - frsno) / (3600*24)
    8080
    81     ! !Attenuation of compaction rate from 450 to 500 kg/m3
     81    !Attenuation of compaction rate from 450 to 500 kg/m3
    8282    Fac         = 1-((ro__SV(ikl,max(1,isnoSV(ikl))) &
    8383          -roBdSV)/(500.-roBdSV))
     
    103103
    104104  END DO
    105   ! !END DO
     105  !END DO
    106106
    107107
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_qsn.f90

    r5105 r5113  
    7373  ! #vm real     EqSn01(knonv)                 ! Snow Energy, after Phase Change
    7474  ! #vm real     EqSn02(knonv)                 ! Snow Energy, after Phase Change
    75                                          ! !              .AND. Last Melting
     75                                         !              .AND. Last Melting
    7676  ! #e1 real     EqSn_1(knonv)                 ! Snow Energy, after Phase Change
    77                                          ! !              .AND. Mass Redistr.
     77                                         !              .AND. Mass Redistr.
    7878  ! Snow/Ice (Mass) Budget
    7979  ! ~~~~~~~~~~~~~~~~~~~~~~
     
    160160  data      dz_Min/2.5e-3/                ! Minim. Snow Layer Thickness
    161161  data      SGDmax/0.003/                 ! Maxim. Snow Grain Diameter  [m]
    162                                           ! ! (Rowe et al. 1995, JGR p.16268)
     162                                          ! (Rowe et al. 1995, JGR p.16268)
    163163
    164164  ! +--Energy Budget (IN)
     
    206206    noSnow(ikl)   = 0                   ! Nb of Layers Updater
    207207    ispiSV(ikl)   = 0                   ! Pore Hole Close OFF Index
    208                                         ! ! (assumed to be the Top of
    209                                         ! ! the surimposed Ice Layer)
     208                                        ! (assumed to be the Top of
     209                                        ! the surimposed Ice Layer)
    210210    zn5_SV(ikl)   = 0.
    211211    rusnSV0(ikl)  = 0.
     
    493493
    494494      if(isnoSV(ikl)<=1 .OR. opt_runoff_ac) rusnew = 0.
    495       ! !if(ivgtSV(ikl)>=1) rusnew = 0.
     495      !if(ivgtSV(ikl)>=1) rusnew = 0.
    496496
    497497  ! #EU                        rusnew = 0.
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_sno_albedo.f90

    r5105 r5113  
    253253
    254254      dalbeW =(0.64 - csegal  )*0.0625  ! Warren 1982, RevGeo, fig.12b
    255                                         ! ! 0.0625 = 5% * 1/0.8,   p.81
    256                                         ! ! 0.64   = cos(50)
     255                                        ! 0.0625 = 5% * 1/0.8,   p.81
     256                                        ! 0.64   = cos(50)
    257257      dalbed =     dalbeW      *       min(1,isnoSV(ikl))
    258258  !-------------------------------------------------------------------------
     
    276276      albSn6(4:6)=albSn2
    277277
    278       ! !snow albedo corection if wetsnow
     278      !snow albedo corection if wetsnow
    279279  ! #GL     albSn1 =  albSn1*max(0.9,(1.-1.5*eta_SV(ikl,isn)))
    280280  ! #GL     albSn2 =  albSn2*max(0.9,(1.-1.5*eta_SV(ikl,isn)))
     
    410410  ! +--Integrated Snow/Ice/Soil Albedo: Clouds Correction! Greuell & all., 1994
    411411  ! +  --------------------------------------------------! Glob.&t Planet.Change
    412                                                    ! ! (9):91-114
     412                                                   ! (9):91-114
    413413        alb1sv(ikl) = alb1sv(ikl) + 0.05 *(cld_SV(ikl)-0.5)*SIcenH &
    414414              + dalbed      *    (1.-cld_SV(ikl))
     
    460460    !AO_CK 20/02/2020
    461461
    462     ! ! No check if coupling update since MAR and NEMO albedo are too different
     462    ! No check if coupling update since MAR and NEMO albedo are too different
    463463    ! and since MAR albedo is computed on properties that are not in NEMO
    464     ! ! prescription for each time step with NEMO values
     464    ! prescription for each time step with NEMO values
    465465
    466466  ! #AO      if (LSmask(ikl) .eq. 0 .and. coupling_ao .eq. .TRUE.) then
     
    511511      DO ikl=1,knonv
    512512        sEX_sv(ikl,isn) = 1.0
    513        ! !sEX_sv(ikl,isn) = 0.95 ! if MAR is too warm in summer
     513       !sEX_sv(ikl,isn) = 0.95 ! if MAR is too warm in summer
    514514      END DO
    515515    END DO
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_ts2.f90

    r5105 r5113  
    265265    IRs__D(ig) = dIRsdT(ig)* TsisSV(ig, isl) * 0.75                  !:
    266266  END DO
    267   ! !hj
     267  !hj
    268268  !!-----------------------------------------------------------------------
    269269  !! 3)
     
    370370      zx_qs = r2es * FOEEW(Tsf_SV(ig), zdelta) / ps__SV(ig)
    371371      zx_qs = MIN(0.5, zx_qs)
    372       ! !write(*,*)'zcor',retv*zx_qs
     372      !write(*,*)'zcor',retv*zx_qs
    373373      zcor = 1. / (1. - retv * zx_qs)
    374374      zx_qs = zx_qs * zcor
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_tso.f90

    r5105 r5113  
    372372  ! +  ^^^^^^^^^^^^^^^^^^^^^^^^^^^
    373373
    374     ! !EV!isl=  min(isnoSV(1)+1,nsno)
     374    !EV!isl=  min(isnoSV(1)+1,nsno)
    375375
    376376    DO ikl=1,knonv
     
    426426      !  sp = (pst_SV(ikl) + ptopSV) * 10.
    427427
    428       ! !sp=ps__SV(ikl)
    429       ! ! Etienne: in the formula herebelow sp should be in hPa, not
    430       ! ! in Pa so I divide by 100.
     428      !sp=ps__SV(ikl)
     429      ! Etienne: in the formula herebelow sp should be in hPa, not
     430      ! in Pa so I divide by 100.
    431431      sp=ps__SV(ikl)/100.
    432432      psat_ice = 6.1070 * exp(6150. *(1./273.16 - &
     
    476476  !                                                              ! by Atm.Conten
    477477  ! #??.        *max(0,sign(1.,qsatsg(ikl)-QaT_SV(ikl))))        ! NO Limitation
    478                                                            ! ! of Downw.Flux
     478                                                           ! of Downw.Flux
    479479        END DO                                             !
    480480      DO itEuBk=1,2                                        !
     
    522522      ist__w=     1-ist__s                                 ! 1 if    H2O
    523523      d__eta     =  eta_SV(ikl,isl)-etaNEW(ikl)            !
    524       ! ! latent heat flux computation
     524      ! latent heat flux computation
    525525      HL___D(ikl)=( ist__s *ro_Wat *dz_dSV(0) & ! Soil Contrib.
    526526            *(etaNEW(ikl)    -etaBAK(ikl)) / dt__SV & !
     
    623623  ! #EU      TsisSV(ikl,isl)  = max(TaT_SV(ikl)-15.,TsisSV(ikl,isl))
    624624
    625       ! !XF 18/11/2018 to avoid ST reaching 70°C!!
    626       ! !It is an error compensation but does not work over tundra
     625      !XF 18/11/2018 to avoid ST reaching 70°C!!
     626      !It is an error compensation but does not work over tundra
    627627
    628628      endif
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/sisvat_zsn.f90

    r5105 r5113  
    140140  DO ikl=1,knonv
    141141  DO   isn=1,isnoSV(ikl)-3 ! no agregation of 3 first snowlayers
    142                            ! ! XF 04/07/2019
     142                           ! XF 04/07/2019
    143143
    144144      isno_n    =             isnoSV(ikl)-isn+1     ! Snow Normal.Profile
     
    526526  DO ikl=1,knonv
    527527    DO isn=1,isnoSV(ikl)-3 ! no agregation of 3 first snowlayers
    528                            ! ! XF 04/07/2019
     528                           ! XF 04/07/2019
    529529
    530530      isno_n    =             isnoSV(ikl)-isn+1     ! Snow Normal.Profile
  • LMDZ6/branches/Amaury_dev/libf/phylmd/inlandsis/surf_inlandsis_mod.F90

    r5110 r5113  
    783783        min_period = 1800. ! en secondes
    784784        dalph_soil = 2.    ! rapport entre les epaisseurs de 2 couches succ.
    785         ! !$OMP MASTER
     785        !$OMP MASTER
    786786        !     IF (is_mpi_root) THEN
    787787        !        OPEN(99,file='soil.def',status='old',form='formatted',iostat=ierr)
     
    795795        !        END IF
    796796        !     ENDIF
    797         ! !$OMP END MASTER
     797        !$OMP END MASTER
    798798        !     CALL bcast(min_period)
    799799        !     CALL bcast(dalph_soil)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/iophy.F90

    r5112 r5113  
    44MODULE iophy
    55
    6 ! abd  REAL,private,allocatable,DIMENSION(:),save :: io_lat
    7 ! abd  REAL,private,allocatable,DIMENSION(:),save :: io_lon
     6! abd  REAL,PRIVATE,allocatable,DIMENSION(:),save :: io_lat
     7! abd  REAL,PRIVATE,allocatable,DIMENSION(:),save :: io_lon
    88  REAL,ALLOCATABLE,DIMENSION(:),SAVE :: io_lat
    99  REAL,ALLOCATABLE,DIMENSION(:),SAVE :: io_lon
  • LMDZ6/branches/Amaury_dev/libf/phylmd/iotd_ecrit.F90

    r5103 r5113  
    2424      USE netcdf, ONLY: nf90_put_var,nf90_inq_varid,nf90_enddef,nf90_redef,nf90_sync,nf90_noerr,&
    2525              nf90_float,nf90_def_var
    26       implicit none
     26      IMPLICIT NONE
    2727
    2828! Commons
  • LMDZ6/branches/Amaury_dev/libf/phylmd/isccp_cloud_types.F90

    r5105 r5113  
    3838
    3939  INTEGER seed(npoints) !  seed value for random number generator
    40   ! ! ( see Numerical Recipes Chapter 7)
    41   ! ! It is recommended that the seed is set
    42   ! ! to a different value for each model
    43   ! ! gridbox it is called on, as it is
    44   ! ! possible that the choice of the samec
    45   ! ! seed value every time may introduce some
    46   ! ! statistical bias in the results, particularly
    47   ! ! for low values of NCOL.
     40  ! ( see Numerical Recipes Chapter 7)
     41  ! It is recommended that the seed is set
     42  ! to a different value for each model
     43  ! gridbox it is called on, as it is
     44  ! possible that the choice of the samec
     45  ! seed value every time may introduce some
     46  ! statistical bias in the results, particularly
     47  ! for low values of NCOL.
    4848
    4949  REAL pfull(npoints, nlev) !  pressure of full model levels (Pascals)
    50   ! ! pfull(npoints,1)    is    top level of model
    51   ! ! pfull(npoints,nlev) is bottom level of model
     50  ! pfull(npoints,1)    is    top level of model
     51  ! pfull(npoints,nlev) is bottom level of model
    5252
    5353  REAL phalf(npoints, nlev+1) !  pressure of half model levels (Pascals)
    54   ! ! phalf(npoints,1)    is    top       of model
    55   ! ! phalf(npoints,nlev+1) is the surface pressure
     54  ! phalf(npoints,1)    is    top       of model
     55  ! phalf(npoints,nlev+1) is the surface pressure
    5656
    5757  REAL qv(npoints, nlev) !  water vapor specific humidity (kg vapor/ kg air)
    58   ! !         on full model levels
     58  !         on full model levels
    5959
    6060  REAL cc(npoints, nlev) !  input cloud cover in each model level (fraction)
    61   ! ! NOTE:  This is the HORIZONTAL area of each
    62   ! !         grid box covered by clouds
     61  ! NOTE:  This is the HORIZONTAL area of each
     62  !         grid box covered by clouds
    6363
    6464  REAL conv(npoints, nlev) !  input convective cloud cover in each model level (fraction)
    65   ! ! NOTE:  This is the HORIZONTAL area of each
    66   ! !         grid box covered by convective clouds
     65  ! NOTE:  This is the HORIZONTAL area of each
     66  !         grid box covered by convective clouds
    6767
    6868  REAL dtau_s(npoints, nlev) !  mean 0.67 micron optical depth of stratiform
    69   ! ! clouds in each model level
    70   ! ! NOTE:  this the cloud optical depth of only the
    71   ! !         cloudy part of the grid box, it is not weighted
    72   ! !         with the 0 cloud optical depth of the clear
    73   ! !         part of the grid box
     69  ! clouds in each model level
     70  ! NOTE:  this the cloud optical depth of only the
     71  !         cloudy part of the grid box, it is not weighted
     72  !         with the 0 cloud optical depth of the clear
     73  !         part of the grid box
    7474
    7575  REAL dtau_c(npoints, nlev) !  mean 0.67 micron optical depth of convective
    76   ! ! clouds in each
    77   ! ! model level.  Same note applies as in dtau_s.
     76  ! clouds in each
     77  ! model level.  Same note applies as in dtau_s.
    7878
    7979  INTEGER overlap !  overlap type
     
    8585
    8686  INTEGER top_height !  1 = adjust top height using both a computed
    87   ! ! infrared brightness temperature and the visible
    88   ! ! optical depth to adjust cloud top pressure. Note
    89   ! ! that this calculation is most appropriate to compare
    90   ! ! to ISCCP data during sunlit hours.
    91   ! ! 2 = do not adjust top height, that is cloud top
    92   ! ! pressure is the actual cloud top pressure
    93   ! ! in the model
    94   ! ! 3 = adjust top height using only the computed
    95   ! ! infrared brightness temperature. Note that this
    96   ! ! calculation is most appropriate to compare to ISCCP
    97   ! ! IR only algortihm (i.e. you can compare to nighttime
    98   ! ! ISCCP data with this option)
     87  ! infrared brightness temperature and the visible
     88  ! optical depth to adjust cloud top pressure. Note
     89  ! that this calculation is most appropriate to compare
     90  ! to ISCCP data during sunlit hours.
     91  ! 2 = do not adjust top height, that is cloud top
     92  ! pressure is the actual cloud top pressure
     93  ! in the model
     94  ! 3 = adjust top height using only the computed
     95  ! infrared brightness temperature. Note that this
     96  ! calculation is most appropriate to compare to ISCCP
     97  ! IR only algortihm (i.e. you can compare to nighttime
     98  ! ISCCP data with this option)
    9999
    100100  REAL tautab(0:255) !  ISCCP table for converting count value to
    101   ! ! optical thickness
     101  ! optical thickness
    102102
    103103  INTEGER invtau(-20:45000) !  ISCCP table for converting optical thickness
    104   ! ! to count value
     104  ! to count value
    105105
    106106  ! The following input variables are used only if top_height = 1 or
     
    111111  REAL at(npoints, nlev) !  temperature in each model level (K)
    112112  REAL dem_s(npoints, nlev) !  10.5 micron longwave emissivity of stratiform
    113   ! ! clouds in each
    114   ! ! model level.  Same note applies as in dtau_s.
     113  ! clouds in each
     114  ! model level.  Same note applies as in dtau_s.
    115115  REAL dem_c(npoints, nlev) !  10.5 micron longwave emissivity of convective
    116   ! ! clouds in each
    117   ! ! model level.  Same note applies as in dtau_s.
     116  ! clouds in each
     117  ! model level.  Same note applies as in dtau_s.
    118118  ! IM reg.dyn BEG
    119119  REAL t1, t2
     
    133133
    134134  REAL fq_isccp(npoints, 7, 7) !  the fraction of the model grid box covered by
    135   ! ! each of the 49 ISCCP D level cloud types
     135  ! each of the 49 ISCCP D level cloud types
    136136
    137137  REAL totalcldarea(npoints) !  the fraction of model grid box columns
    138   ! ! with cloud somewhere in them.  This should
    139   ! ! equal the sum over all entries of fq_isccp
    140 
    141 
    142   ! ! The following three means are averages over the cloudy areas only.  If
     138  ! with cloud somewhere in them.  This should
     139  ! equal the sum over all entries of fq_isccp
     140
     141
     142  ! The following three means are averages over the cloudy areas only.  If
    143143  ! no
    144   ! ! clouds are in grid box all three quantities should equal zero.
     144  ! clouds are in grid box all three quantities should equal zero.
    145145
    146146  REAL meanptop(npoints) !  mean cloud top pressure (mb) - linear averaging
    147   ! ! in cloud top pressure.
     147  ! in cloud top pressure.
    148148
    149149  REAL meantaucld(npoints) !  mean optical thickness
    150   ! ! linear averaging in albedo performed.
     150  ! linear averaging in albedo performed.
    151151
    152152  REAL boxtau(npoints, ncol) !  optical thickness in each column
     
    162162
    163163  REAL frac_out(npoints, ncol, nlev) ! boxes gridbox divided up into
    164   ! ! Equivalent of BOX in original version, but
    165   ! ! indexed by column then row, rather than
    166   ! ! by row then column
     164  ! Equivalent of BOX in original version, but
     165  ! indexed by column then row, rather than
     166  ! by row then column
    167167
    168168  REAL tca(npoints, 0:nlev) ! total cloud cover in each model level (fraction)
    169   ! ! with extra layer of zeroes on top
    170   ! ! in this version this just contains the values input
    171   ! ! from cc but with an extra level
     169  ! with extra layer of zeroes on top
     170  ! in this version this just contains the values input
     171  ! from cc but with an extra level
    172172  REAL cca(npoints, nlev) ! convective cloud cover in each model level (fraction)
    173   ! ! from conv
     173  ! from conv
    174174
    175175  REAL threshold(npoints, ncol) ! pointer to position in gridbox
     
    180180
    181181  REAL threshold_min(npoints, ncol) ! minimum value to define range in with new threshold
    182   ! ! is chosen
     182  ! is chosen
    183183
    184184  REAL dem(npoints, ncol), bb(npoints) !  working variables for 10.5 micron longwave
    185   ! ! emissivity in part of
    186   ! ! gridbox under consideration
     185  ! emissivity in part of
     186  ! gridbox under consideration
    187187
    188188  REAL ran(npoints) ! vector of random numbers
     
    203203  INTEGER levmatch(npoints, ncol)
    204204
    205   ! !variables needed for water vapor continuum absorption
     205  !variables needed for water vapor continuum absorption
    206206  REAL fluxtop_clrsky(npoints), trans_layers_above_clrsky(npoints)
    207207  REAL taumin(npoints)
     
    226226  REAL boxarea
    227227  INTEGER debug ! set to non-zero value to print out inputs
    228   ! ! with step debug
     228  ! with step debug
    229229  INTEGER debugcol ! set to non-zero value to print out column
    230   ! ! decomposition with step debugcol
     230  ! decomposition with step debugcol
    231231
    232232  INTEGER index1(npoints), num1, jj
     
    14101410          ! end if
    14111411
    1412           ! !determine cloud top pressure category
     1412          !determine cloud top pressure category
    14131413          ! if (    ptop(j,ibox) .gt. 0.
    14141414          ! &          .and.ptop(j,ibox) .lt. 180.) then
     
    14421442          ! iw(j) = int((w(j)-wmin)/pas_w) +1
    14431443          ! pctj(itau(j),ipres(j),iw(j))=.FALSE.
    1444           ! !update frequencies W500
     1444          !update frequencies W500
    14451445          ! if (pct_ocean(j)) then
    14461446          ! if (ipres(j) .gt. 0.and.itau(j) .gt. 0) then
     
    15371537  ! do j=1,npoints,debugcol
    15381538
    1539   ! !produce character output
     1539  !produce character output
    15401540  ! do ilev=1,nlev
    15411541  ! do ibox=1,ncol
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_atke_exchange_coeff.F90

    r5111 r5113  
    11module lmdz_atke_exchange_coeff
    22
    3 implicit none
     3IMPLICIT NONE
    44
    55contains
     
    5959!!-------------------------------------------------------------------------------------------------------------
    6060
    61 implicit none
     61IMPLICIT NONE
    6262
    6363
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_atke_turbulence_ini.F90

    r5112 r5113  
    11MODULE lmdz_atke_turbulence_ini
    22
    3   implicit none
     3  IMPLICIT NONE
    44
    55  ! declaration of constants and parameters
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_blowing_snow_ini.F90

    r5112 r5113  
    11module lmdz_blowing_snow_ini
    22
    3 implicit none
     3IMPLICIT NONE
    44
    55   real, save, protected :: RCPD, RV, RLSTT, RLVTT, RLMLT, RVTMP2, RTT,RD,RG, RPI
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_blowing_snow_sublim_sedim.F90

    r5105 r5113  
    1515USE lmdz_lscp_tools, ONLY: calc_qsat_ecmwf
    1616
    17 implicit none
     17IMPLICIT NONE
    1818
    1919
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_call_atke.F90

    r5103 r5113  
    33USE lmdz_atke_exchange_coeff, ONLY:  atke_compute_km_kh
    44
    5 implicit none
     5IMPLICIT NONE
    66
    77
     
    1818USE phys_local_var_mod, ONLY: tke_shear, tke_buoy, tke_trans
    1919
    20 implicit none
     20IMPLICIT NONE
    2121
    2222
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_call_blowing_snow.F90

    r5103 r5113  
    77
    88use lmdz_blowing_snow_sublim_sedim, ONLY: blowing_snow_sublim_sedim
    9 implicit none
     9IMPLICIT NONE
    1010
    1111!INPUT
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_cloud_optics_prop.F90

    r5105 r5113  
    509509  ! --calculation of cloud properties with cloud overlap
    510510  ! choix de l'hypothese de recouvrement nuageuse via radopt.h (IM, 19.07.2016)
    511   ! !novlp=1: max-random
    512   ! !novlp=2: maximum
    513   ! !novlp=3: random
     511  !novlp=1: max-random
     512  !novlp=2: maximum
     513  !novlp=3: random
    514514
    515515
     
    659659    ENDDO ! loop over i
    660660
    661     ! ! Convective and Stratiform Cloud Droplet Effective Radius (REFFCLWC
     661    ! Convective and Stratiform Cloud Droplet Effective Radius (REFFCLWC
    662662    ! REFFCLWS)
    663663    DO i = 1, klon
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_cloudth_ini.F90

    r5112 r5113  
    1313
    1414use lmdz_ioipsl_getin_p, ONLY: getin_p
    15 implicit none
     15IMPLICIT NONE
    1616integer, intent(in) :: iflag_cloudth_vert_in,iflag_ratqs_in
    1717
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_lscp_tools.F90

    r5112 r5113  
    499499           END IF ! Enough TKE
    500500
    501         END IF ! ! MPC temperature
     501        END IF ! MPC temperature
    502502
    503503     END IF ! cldfra
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_ratqs_main.F90

    r5105 r5113  
    1818USE lmdz_ratqs_multi,   ONLY: ratqs_inter, ratqs_oro, ratqs_hetero, ratqs_tke
    1919
    20 implicit none
     20IMPLICIT NONE
    2121
    2222!========================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_ratqs_multi.F90

    r5103 r5113  
    3434USE lmdz_thermcell_dq,  ONLY: thermcell_dq
    3535
    36 implicit none
     36IMPLICIT NONE
    3737
    3838!========================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_thermcell_dq.F90

    r5112 r5113  
    77    USE lmdz_abort_physic, ONLY: abort_physic
    88
    9     implicit none
     9    IMPLICIT NONE
    1010
    1111    !=======================================================================
     
    161161    USE lmdz_print_control, ONLY: prt_level
    162162    USE lmdz_abort_physic, ONLY: abort_physic
    163     implicit none
     163    IMPLICIT NONE
    164164
    165165    !=======================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_thermcell_dtke.F90

    r5112 r5113  
    55             rg,pplev,tke)
    66      USE lmdz_print_control, ONLY: prt_level
    7       implicit none
     7      IMPLICIT NONE
    88
    99!=======================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_thermcell_dv2.F90

    r5112 r5113  
    66      ,u,v,du,dv,ua,va,lev_out)
    77      USE lmdz_print_control, ONLY: prt_level,lunout
    8       implicit none
     8      IMPLICIT NONE
    99
    1010!=======================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_thermcell_main.F90

    r5111 r5113  
    868868          therm_tke_max)                                ! out
    869869    USE lmdz_thermcell_ini, ONLY: prt_level
    870     implicit none
     870    IMPLICIT NONE
    871871
    872872    !=======================================================================
  • LMDZ6/branches/Amaury_dev/libf/phylmd/lmdz_thermcell_qsat.F90

    r5103 r5113  
    33
    44SUBROUTINE thermcell_qsat(klon,active,pplev,ztemp,zqta,zqsat)
    5 implicit none
     5IMPLICIT NONE
    66
    77  INCLUDE "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/o3_chem_m.F90

    r5110 r5113  
    44  IMPLICIT none
    55
    6   private o3_prod
     6  PRIVATE o3_prod
    77
    88contains
     
    1717    ! Index "(i, :)" is for longitude "rlon(i)", latitude "rlat(i)".
    1818
    19     use assert_m, only: assert
     19    use lmdz_assert, only: assert
    2020    use dimphy, only: klon
    2121    use regr_pr_comb_coefoz_m, only: c_Mob, a4_mass, a2, r_het_interm
     
    116116
    117117    use regr_pr_comb_coefoz_m, only: a6_mass
    118     use assert_m, only: assert
     118    use lmdz_assert, only: assert
    119119    use dimphy, only: klon
    120120    use lmdz_grid_phy, only: nbp_lev
  • LMDZ6/branches/Amaury_dev/libf/phylmd/output_physiqex_mod.F90

    r5112 r5113  
    1919
    2020
    21 implicit none
     21IMPLICIT NONE
    2222logical, intent(in) :: debut
    2323real, intent(in) :: pdtphys,zjulian
  • LMDZ6/branches/Amaury_dev/libf/phylmd/ozonecm_m.F90

    r5103 r5113  
    2222
    2323    USE dimphy, only: klon, klev
    24     use assert_m, only: assert
     24    use lmdz_assert, only: assert
    2525
    2626    REAL, INTENT (IN) :: rlat(:) ! (klon)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/phyaqua_mod.F90

    r5112 r5113  
    601601      ierr = nf90_put_att(nid, nf90_global, 'title', &
    602602              'Fichier conditions aux limites')
    603       ! !        ierr = nf90_def_dim (nid, "points_physiques", klon, ndim)
     603      !        ierr = nf90_def_dim (nid, "points_physiques", klon, ndim)
    604604      ierr = nf90_def_dim(nid, 'points_physiques', klon_glo, ndim)
    605605      ierr = nf90_def_dim(nid, 'time', nf90_unlimited, ntim)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/physiq_mod.F90

    r5112 r5113  
    2323    USE add_phys_tend_mod, ONLY: add_pbl_tend, add_phys_tend, diag_phys_tend, prt_enerbil, &
    2424            fl_ebil, fl_cor_ebil
    25     USE assert_m, ONLY: assert
     25    USE lmdz_assert, ONLY: assert
    2626    USE change_srf_frac_mod
    2727    USE conf_phys_m, ONLY: conf_phys
     
    600600
    601601    !      REAL,allocatable,save :: run_off_lic_0(:)
    602     ! !$OMP THREADPRIVATE(run_off_lic_0)
     602    !$OMP THREADPRIVATE(run_off_lic_0)
    603603    !ym      SAVE run_off_lic_0
    604604    !KE43
  • LMDZ6/branches/Amaury_dev/libf/phylmd/press_coefoz_m.F90

    r5110 r5113  
    22module press_coefoz_m
    33
    4   implicit none
     4  IMPLICIT NONE
    55
    66  real, allocatable, save:: plev(:)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/radlwsw_m.F90

    r5112 r5113  
    4848    ! Modules necessaires
    4949    USE DIMPHY
    50     USE assert_m, ONLY: assert
     50    USE lmdz_assert, ONLY: assert
    5151    USE infotrac_phy, ONLY: type_trac
    5252    USE lmdz_write_field_phy
  • LMDZ6/branches/Amaury_dev/libf/phylmd/readaerosolstrato.F90

    r5112 r5113  
    1818  USE lmdz_xios
    1919  USE lmdz_abort_physic, ONLY: abort_physic
    20   implicit none
     20  IMPLICIT NONE
    2121
    2222  include "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_horiz_time_climoz_m.F90

    r5112 r5113  
    5757    !     Attribute "missing_value" or "_FillValue" must be present in input file.
    5858    !-------------------------------------------------------------------------------
    59     USE assert_m, ONLY: assert
     59    USE lmdz_assert, ONLY: assert
    6060    USE cal_tools_m, ONLY: year_len, mid_month
    6161    !!  USE control_mod,        ONLY: anneeref
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_lat_time_coefoz_m.F90

    r5112 r5113  
    44  ! Author: Lionel GUEZ
    55
    6   implicit none
    7 
    8   private
     6  IMPLICIT NONE
     7
     8  PRIVATE
    99  public regr_lat_time_coefoz
    1010
     
    241241
    242242    use lmdz_grid_phy, ONLY: nbp_lat
    243     use assert_eq_m, only: assert_eq
     243    use lmdz_assert_eq, only: assert_eq
    244244
    245245    use netcdf95, only: nf95_create, nf95_def_dim, nf95_def_var, &
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_pr_comb_coefoz_m.F90

    r5110 r5113  
    22module regr_pr_comb_coefoz_m
    33
    4   implicit none
     4  IMPLICIT NONE
    55
    66  ! The five module variables declared here are on the partial
     
    7373    use netcdf95, only: nf95_open, nf95_close
    7474    use netcdf, only: nf90_nowrite
    75     use assert_m, only: assert
     75    use lmdz_assert, only: assert
    7676    use dimphy, only: klon
    7777    use lmdz_phys_mpi_data, only: is_mpi_root
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_pr_int_m.F90

    r5110 r5113  
    44  ! Author: Lionel GUEZ
    55
    6   implicit none
     6  IMPLICIT NONE
    77
    88contains
     
    2626    use dimphy, only: klon
    2727    use netcdf95, only: nf95_inq_varid, nf95_get_var
    28     use assert_m, only: assert
     28    use lmdz_assert, only: assert
    2929    use regr_lint_m, only: regr_lint
    3030    use lmdz_phys_mpi_data, only: is_mpi_root
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_pr_o3_m.F90

    r5110 r5113  
    22module regr_pr_o3_m
    33
    4   implicit none
     4  IMPLICIT NONE
    55
    66contains
     
    2727    use netcdf95, only: nf95_open, nf95_close, nf95_inq_varid, nf95_get_var
    2828    use netcdf, only:  nf90_nowrite
    29     use assert_m, only: assert
     29    use lmdz_assert, only: assert
    3030    use regr_conserv_m, only: regr_conserv
    3131    use press_coefoz_m, only: press_in_edg
  • LMDZ6/branches/Amaury_dev/libf/phylmd/regr_pr_time_av_m.F90

    r5112 r5113  
    116116            nf95_inq_dimid, nf95_inquire_dimension, nf95_get_var
    117117    USE netcdf, ONLY: nf90_inq_varid, nf90_noerr
    118     USE assert_m, ONLY: assert
    119     USE assert_eq_m, ONLY: assert_eq
     118    USE lmdz_assert, ONLY: assert
     119    USE lmdz_assert_eq, ONLY: assert_eq
    120120    !!  USE comvert_mod,    ONLY: scaleheight
    121121    USE interpolation, ONLY: locate
  • LMDZ6/branches/Amaury_dev/libf/phylmd/simu_airs.F90

    r5112 r5113  
    44  USE lmdz_abort_physic, ONLY: abort_physic
    55
    6   implicit none
     6  IMPLICIT NONE
    77
    88  REAL, PARAMETER :: tau_thresh = 0.05 ! seuil nuages detectables
  • LMDZ6/branches/Amaury_dev/libf/phylmd/stratosphere_mask.F90

    r5112 r5113  
    111111! reference: Reichler, T., M. Dameris, and R. Sausen (GRL, 10.1029/2003GL018240, 2003)
    112112
    113 implicit none
     113IMPLICIT NONE
    114114
    115115include "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/tilft43.F90

    r5105 r5113  
    1313
    1414  ! -- sb:
    15   ! !      CPD=1005.7
    16   ! !      CPV=1870.0
    17   ! !      CL=4190.0
    18   ! !      RV=461.5
    19   ! !      RD=287.04
    20   ! !      LV0=2.501E6
    21   ! !      G=9.8
    22   ! !      ROWL=1000.0
     15  !      CPD=1005.7
     16  !      CPV=1870.0
     17  !      CL=4190.0
     18  !      RV=461.5
     19  !      RD=287.04
     20  !      LV0=2.501E6
     21  !      G=9.8
     22  !      ROWL=1000.0
    2323  ! ajouts:
    2424  include "YOMCST.h"
  • LMDZ6/branches/Amaury_dev/libf/phylmd/tropopause_m.F90

    r5112 r5113  
    1212
    1313!-------------------------------------------------------------------------------
    14   USE assert_m,     ONLY: assert
    15   USE assert_eq_m,  ONLY: assert_eq
     14  USE lmdz_assert,     ONLY: assert
     15  USE lmdz_assert_eq,  ONLY: assert_eq
    1616  USE dimphy,       ONLY: klon, klev
    1717  USE lmdz_geometry, ONLY: latitude_deg, longitude_deg
  • LMDZ6/branches/Amaury_dev/libf/phylmd/undefSTD.F90

    r5105 r5113  
    2222
    2323  ! nout=1 !var. journaliere "day" moyenne sur tous les pas de temps
    24   ! ! de la physique
     24  ! de la physique
    2525  ! nout=2 !var. mensuelle "mth" moyennee sur tous les pas de temps
    26   ! ! de la physique
     26  ! de la physique
    2727  ! nout=3 !var. mensuelle "NMC" moyennee toutes les ecrit_hf
    2828
  • LMDZ6/branches/Amaury_dev/libf/phylmd/vdif_kcay.F90

    r5105 r5113  
    598598    ! PRINT*,'Q2q20 ',(q2(1,ilev),ilev=1,10)
    599599    ! PRINT*,'Q2km0 ',(km(1,ilev),ilev=1,10)
    600     ! ! C'est quoi ca qu'etait dans l'original???
     600    ! C'est quoi ca qu'etait dans l'original???
    601601    ! do igrid=1,ngrid
    602602    ! q2(igrid,1)=10.
  • LMDZ6/branches/Amaury_dev/libf/phylmd/yamada_ini_mod.F90

    r5112 r5113  
    44! peut on passer une fonction du module au code.
    55
    6 implicit none
     6IMPLICIT NONE
    77
    88  LOGICAL :: new_yamada4
Note: See TracChangeset for help on using the changeset viewer.