Ignore:
Timestamp:
Jul 23, 2024, 8:22:55 AM (14 months ago)
Author:
abarral
Message:

Handle DEBUG_IO in lmdz_cppkeys_wrapper.F90
Transform some files .F -> .[fF]90
[ne compile pas à cause de writefield_u non défini - en attente de réponse Laurent]

Location:
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat
Files:
12 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/calfis.F

    r5099 r5101  
    101101c    Arguments :
    102102c    -----------
    103       LOGICAL,INTENT(IN) ::  lafin ! .true. for the very last call to physics
     103      LOGICAL,INTENT(IN) ::  lafin ! .true. for the very last CALL to physics
    104104      REAL,INTENT(IN):: jD_cur, jH_cur
    105105      REAL,INTENT(IN) :: pvcov(iip1,jjm,llm) ! covariant meridional velocity
     
    185185         write(lunout,*) '  ngridmx  jjm   iim   '
    186186         write(lunout,*) ngridmx,jjm,iim
    187          call abort_gcm("calfis", "", 1)
     187         CALL abort_gcm("calfis", "", 1)
    188188        ENDIF
    189189      ELSE
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/gr_dyn_fi.F

    r5099 r5101  
    2323
    2424      IF (ngrid/=2+(jm-2)*(im-1)) then
    25          call abort_gcm("gr_dyn_fi", 'probleme de dim', 1)
     25         CALL abort_gcm("gr_dyn_fi", 'probleme de dim', 1)
    2626      end if
    2727c   traitement des poles
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/inigeomphy_mod.F90

    r5099 r5101  
    1616                                klon_omp_end, & ! end index of local omp subgrid
    1717                                klon_mpi_begin ! start indes of columns (on local mpi grid)
    18   USE geometry_mod, ONLY : init_geometry
    19   USE physics_distribution_mod, ONLY : init_physics_distribution
    20   USE regular_lonlat_mod, ONLY : init_regular_lonlat, &
     18  USE geometry_mod, ONLY: init_geometry
     19  USE physics_distribution_mod, ONLY: init_physics_distribution
     20  USE regular_lonlat_mod, ONLY: init_regular_lonlat, &
    2121                                 east, west, north, south, &
    2222                                 north_east, north_west, &
    2323                                 south_west, south_east
    24   USE mod_interface_dyn_phys, ONLY :  init_interface_dyn_phys
     24  USE mod_interface_dyn_phys, ONLY:  init_interface_dyn_phys
    2525  USE nrtype, ONLY: pi
    2626  USE comvert_mod, ONLY: preff, ap, bp, aps, bps, presnivs, &
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/lmdz_calfis_loc.F90

    r5099 r5101  
    4343    Use Write_field_p
    4444    USE Times
    45     USE infotrac, ONLY : nqtot, tracers
    46     USE control_mod, ONLY : planet_type, nsplit_phys
     45    USE infotrac, ONLY: nqtot, tracers
     46    USE control_mod, ONLY: planet_type, nsplit_phys
    4747    USE callphysiq_mod, ONLY: call_physiq
    4848    USE lmdz_cppkeys_wrapper, ONLY: CPPKEY_PHYS
    4949
    50     USE comvert_mod, ONLY : preff, presnivs
    51     USE comconst_mod, ONLY : cpp, daysec, dtphys, dtvr, kappa, pi
     50    USE comvert_mod, ONLY: preff, presnivs
     51    USE comconst_mod, ONLY: cpp, daysec, dtphys, dtvr, kappa, pi
    5252
    5353    !=======================================================================
     
    115115    !    Arguments :
    116116    !    -----------
    117     LOGICAL, INTENT(IN) :: lafin ! .true. for the very last call to physics
     117    LOGICAL, INTENT(IN) :: lafin ! .true. for the very last CALL to physics
    118118    REAL, INTENT(IN) :: jD_cur, jH_cur
    119119    REAL, INTENT(IN) :: pvcov(iip1, jjb_v:jje_v, llm) ! covariant meridional velocity
     
    248248      write(lunout,*) '  ngridmx  jjm   iim   '
    249249      write(lunout,*) ngridmx,jjm,iim
    250       call abort_gcm("calfis_loc", "", 1)
     250      CALL abort_gcm("calfis_loc", "", 1)
    251251    ENDIF
    252252!$OMP MASTER
     
    279279
    280280!$OMP MASTER
    281   call start_timer(timer_physic)
     281  CALL start_timer(timer_physic)
    282282!$OMP END MASTER
    283283
     
    832832
    833833!$OMP MASTER
    834   call stop_timer(timer_physic)
     834  CALL stop_timer(timer_physic)
    835835!$OMP END MASTER
    836836
     
    850850!$OMP MASTER
    851851!$OMP CRITICAL (MPI)
    852     call MPI_ISSEND(du_send,iim*llm,MPI_REAL8,MPI_Rank-1,401, &
     852    CALL MPI_ISSEND(du_send,iim*llm,MPI_REAL8,MPI_Rank-1,401, &
    853853          COMM_LMDZ,Req(1),ierr)
    854     call MPI_ISSEND(dv_send,iim*llm,MPI_REAL8,MPI_Rank-1,402, &
     854    CALL MPI_ISSEND(dv_send,iim*llm,MPI_REAL8,MPI_Rank-1,402, &
    855855          COMM_LMDZ,Req(2),ierr)
    856856!$OMP END CRITICAL (MPI)
     
    866866!$OMP MASTER
    867867!$OMP CRITICAL (MPI)
    868     call MPI_IRECV(du_recv,iim*llm,MPI_REAL8,MPI_Rank+1,401, &
     868    CALL MPI_IRECV(du_recv,iim*llm,MPI_REAL8,MPI_Rank+1,401, &
    869869          COMM_LMDZ,Req(3),ierr)
    870     call MPI_IRECV(dv_recv,iim*llm,MPI_REAL8,MPI_Rank+1,402, &
     870    CALL MPI_IRECV(dv_recv,iim*llm,MPI_REAL8,MPI_Rank+1,402, &
    871871          COMM_LMDZ,Req(4),ierr)
    872872!$OMP END CRITICAL (MPI)
     
    881881!$OMP CRITICAL (MPI)
    882882  if (MPI_rank>0 .and. MPI_rank< MPI_Size-1) then
    883     call MPI_WAITALL(4,Req(1),Status,ierr)
     883    CALL MPI_WAITALL(4,Req(1),Status,ierr)
    884884  else if (MPI_rank>0) then
    885     call MPI_WAITALL(2,Req(1),Status,ierr)
     885    CALL MPI_WAITALL(2,Req(1),Status,ierr)
    886886  else if (MPI_rank <MPI_Size-1) then
    887     call MPI_WAITALL(2,Req(3),Status,ierr)
     887    CALL MPI_WAITALL(2,Req(3),Status,ierr)
    888888  endif
    889889!$OMP END CRITICAL (MPI)
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phydev/callphysiq_mod.F90

    r5099 r5101  
    2727  INTEGER,INTENT(IN) :: nqtot ! number of tracers
    2828  CHARACTER(len=*),INTENT(IN) :: tname(nqtot) ! tracer names
    29   LOGICAL,INTENT(IN) :: debut_split ! .true. if very first call to physics
    30   LOGICAL,INTENT(IN) :: lafin_split ! .true. if last call to physics
     29  LOGICAL,INTENT(IN) :: debut_split ! .true. if very first CALL to physics
     30  LOGICAL,INTENT(IN) :: lafin_split ! .true. if last CALL to physics
    3131  REAL,INTENT(IN) :: JD_cur ! Julian day
    3232  REAL,INTENT(IN) :: JH_cur_split ! Julian hour (fraction of day)
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/callphysiq_mod.F90

    r5099 r5101  
    2222  USE control_mod, ONLY: planet_type, ok_dyn_xios
    2323  USE physiq_mod, ONLY: physiq
    24   USE lmdz_xios, ONLY : xios_set_current_context, xios_get_current_context, xios_context
     24  USE lmdz_xios, ONLY: xios_set_current_context, xios_get_current_context, xios_context
    2525  IMPLICIT NONE
    2626
     
    2929  INTEGER,INTENT(IN) :: nqtot ! number of tracers
    3030  CHARACTER(len=*),INTENT(IN) :: tname(nqtot) ! tracer names
    31   LOGICAL,INTENT(IN) :: debut_split ! .true. if very first call to physics
    32   LOGICAL,INTENT(IN) :: lafin_split ! .true. if last call to physics
     31  LOGICAL,INTENT(IN) :: debut_split ! .true. if very first CALL to physics
     32  LOGICAL,INTENT(IN) :: lafin_split ! .true. if last CALL to physics
    3333  REAL,INTENT(IN) :: JD_cur ! Julian day
    3434  REAL,INTENT(IN) :: JH_cur_split ! Julian hour (fraction of day)
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/ce0l.F90

    r5100 r5101  
    2222  USE limit,          ONLY: limit_netcdf
    2323  USE netcdf,         ONLY: nf90_open, nf90_nowrite, nf90_close, nf90_noerr,    &
    24          nf90_inquire_dimension, nf90_inq_dimid, NF90_INQ_VARID, nf90_get_var
     24         nf90_inquire_dimension, nf90_inq_dimid, nf90_inq_varid, nf90_get_var
    2525  USE infotrac,       ONLY: init_infotrac
    2626  USE dimphy,         ONLY: klon
     
    200200    END IF
    201201    ALLOCATE(masktmp(klon))
    202     iret=NF90_INQ_VARID(nid_sta,'masque',nid_msk)
     202    iret=nf90_inq_varid(nid_sta,'masque',nid_msk)
    203203    iret=nf90_get_var(nid_sta,nid_msk,masktmp)
    204204    iret=nf90_close(nid_sta)
     
    249249  END IF
    250250  IF (using_xios) CALL xios_finalize
    251   IF (using_mpi) call MPI_FINALIZE(ierr)
     251  IF (using_mpi) CALL MPI_FINALIZE(ierr)
    252252#endif
    253253
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/etat0phys_netcdf.F90

    r5099 r5101  
    564564     endif
    565565  enddo
    566   call dump2d(imp1,jmp1,phis,'phis ')
    567   call dump2d(imp1,jmp1,masque,'masque ')
    568   call dump2d(imp1,jmp1,phis-phiso,'dphis ')
     566  CALL dump2d(imp1,jmp1,phis,'phis ')
     567  CALL dump2d(imp1,jmp1,masque,'masque ')
     568  CALL dump2d(imp1,jmp1,phis-phiso,'dphis ')
    569569
    570570END SUBROUTINE filtreoro
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/iniphysiq_mod.F90

    r5099 r5101  
    1515  USE mod_grid_phy_lmdz, ONLY: nbp_lon,nbp_lat,nbp_lev,klon_glo ! number of atmospheric columns (on full grid)
    1616  USE mod_phys_lmdz_para, ONLY: klon_omp ! number of columns (on local omp grid)
    17   USE vertical_layers_mod, ONLY : init_vertical_layers
     17  USE vertical_layers_mod, ONLY: init_vertical_layers
    1818  USE infotrac, ONLY: nbtr, type_trac
    1919
    2020#ifdef REPROBUS
    21   USE CHEM_REP, ONLY : Init_chem_rep_phys
     21  USE CHEM_REP, ONLY: Init_chem_rep_phys
    2222#ifdef CPP_PARA
    23   USE parallel_lmdz, ONLY : mpi_size, mpi_rank
    24   USE bands, ONLY : distrib_phys
     23  USE parallel_lmdz, ONLY: mpi_size, mpi_rank
     24  USE bands, ONLY: distrib_phys
    2525#endif
    2626  USE mod_phys_lmdz_omp_data, ONLY: klon_omp
     
    3636  USE indice_sol_mod, ONLY: nbsrf, is_oce, is_sic, is_ter, is_lic
    3737#ifdef CPP_PARA
    38   USE parallel_lmdz, ONLY : mpi_size, mpi_rank
    39   USE bands, ONLY : distrib_phys
     38  USE parallel_lmdz, ONLY: mpi_size, mpi_rank
     39  USE bands, ONLY: distrib_phys
    4040#endif
    4141  USE mod_phys_lmdz_omp_data, ONLY: klon_omp
     
    137137  IF (type_trac == 'repr') THEN
    138138#ifdef REPROBUS
    139     call Init_chem_rep_phys(klon_omp,nlayer)
    140     call init_reprobus_para( &
     139    CALL Init_chem_rep_phys(klon_omp,nlayer)
     140    CALL init_reprobus_para( &
    141141          nbp_lon,nbp_lat,nbp_lev,klon_glo,mpi_size, &
    142142          distrib_phys,communicator)
     
    148148  IF (type_trac == 'repr') THEN
    149149#ifdef REPROBUS
    150     call init_reprobus_para( &
     150    CALL init_reprobus_para( &
    151151          nbp_lon,nbp_lat,nbp_lev,klon_glo,mpi_size, &
    152152          distrib_phys,communicator)
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/init_ssrf_m.F90

    r5099 r5101  
    66  USE dimphy,             ONLY: klon, zmasq
    77  USE phys_state_var_mod, ONLY: pctsrf
    8   USE geometry_mod,       ONLY : longitude_deg, latitude_deg
     8  USE geometry_mod,       ONLY: longitude_deg, latitude_deg
    99  USE grid_atob_m,        ONLY: grille_m
    1010  USE ioipsl,             ONLY: flininfo, flinopen, flinget, flinclo
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/limit_netcdf.f90

    r5100 r5101  
    1717  !-------------------------------------------------------------------------------
    1818
    19   USE ioipsl, ONLY : flininfo, flinopen, flinget, flinclo
    20   USE assert_eq_m, ONLY : assert_eq
    21   USE cal_tools_m, ONLY : year_len, mid_month
    22   USE conf_dat_m, ONLY : conf_dat2d, conf_dat3d
    23   USE dimphy, ONLY : klon, zmasq
    24   USE geometry_mod, ONLY : longitude_deg, latitude_deg
    25   USE phys_state_var_mod, ONLY : pctsrf
    26   USE control_mod, ONLY : anneeref
    27   USE init_ssrf_m, ONLY : start_init_subsurf
     19  USE ioipsl, ONLY: flininfo, flinopen, flinget, flinclo
     20  USE assert_eq_m, ONLY: assert_eq
     21  USE cal_tools_m, ONLY: year_len, mid_month
     22  USE conf_dat_m, ONLY: conf_dat2d, conf_dat3d
     23  USE dimphy, ONLY: klon, zmasq
     24  USE geometry_mod, ONLY: longitude_deg, latitude_deg
     25  USE phys_state_var_mod, ONLY: pctsrf
     26  USE control_mod, ONLY: anneeref
     27  USE init_ssrf_m, ONLY: start_init_subsurf
    2828
    2929  INTEGER, PARAMETER :: ns = 256
     
    7070    !-------------------------------------------------------------------------------
    7171    USE indice_sol_mod
    72     USE netcdf, ONLY : nf90_open, nf90_create, nf90_close, &
     72    USE netcdf, ONLY: nf90_open, nf90_create, nf90_close, &
    7373            nf90_def_dim, nf90_def_var, nf90_put_var, nf90_put_att, &
    7474            nf90_noerr, nf90_nowrite, nf90_global, &
    7575            nf90_clobber, nf90_enddef, nf90_unlimited, nf90_float, &
    7676            nf90_64bit_offset
    77     USE lmdz_cppkeys_wrapper, ONLY : nf90_format
    78     USE inter_barxy_m, ONLY : inter_barxy
    79     USE netcdf95, ONLY : nf95_def_var, nf95_put_att, nf95_put_var
    80     USE comconst_mod, ONLY : pi
    81     USE phys_cal_mod, ONLY : calend
     77    USE lmdz_cppkeys_wrapper, ONLY: nf90_format
     78    USE inter_barxy_m, ONLY: inter_barxy
     79    USE netcdf95, ONLY: nf95_def_var, nf95_put_att, nf95_put_var
     80    USE comconst_mod, ONLY: pi
     81    USE phys_cal_mod, ONLY: calend
    8282    IMPLICIT NONE
    8383    !-------------------------------------------------------------------------------
     
    262262    CALL ncerr(nf90_def_var(nid, "ALB", nf90_format, dims, id_ALB), fnam)
    263263    CALL ncerr(nf90_def_var(nid, "RUG", nf90_format, dims, id_RUG), fnam)
    264     call nf95_def_var(nid, "longitude", nf90_float, ndim, varid_longitude)
    265     call nf95_def_var(nid, "latitude", nf90_float, ndim, varid_latitude)
     264    CALL nf95_def_var(nid, "longitude", nf90_float, ndim, varid_longitude)
     265    CALL nf95_def_var(nid, "latitude", nf90_float, ndim, varid_latitude)
    266266
    267267    !--- Attributes creation
     
    277277    CALL ncerr(nf90_put_att(nid, id_RUG, "title", "Rugosite"), fnam)
    278278
    279     call nf95_put_att(nid, varid_longitude, "standard_name", "longitude")
    280     call nf95_put_att(nid, varid_longitude, "units", "degrees_east")
    281 
    282     call nf95_put_att(nid, varid_latitude, "standard_name", "latitude")
    283     call nf95_put_att(nid, varid_latitude, "units", "degrees_north")
     279    CALL nf95_put_att(nid, varid_longitude, "standard_name", "longitude")
     280    CALL nf95_put_att(nid, varid_longitude, "units", "degrees_east")
     281
     282    CALL nf95_put_att(nid, varid_latitude, "standard_name", "latitude")
     283    CALL nf95_put_att(nid, varid_latitude, "units", "degrees_north")
    284284
    285285    CALL ncerr(nf90_enddef(nid), fnam)
     
    295295    CALL ncerr(nf90_put_var(nid, id_ALB, phy_alb(:, :), [1, 1], [klon, ndays]), fnam)
    296296    CALL ncerr(nf90_put_var(nid, id_RUG, phy_rug(:, :), [1, 1], [klon, ndays]), fnam)
    297     call nf95_put_var(nid, varid_longitude, longitude_deg)
    298     call nf95_put_var(nid, varid_latitude, latitude_deg)
     297    CALL nf95_put_var(nid, varid_longitude, longitude_deg)
     298    CALL nf95_put_var(nid, varid_latitude, latitude_deg)
    299299
    300300    CALL ncerr(nf90_close(nid), fnam)
     
    323323      !     2) Dimensional variables have the same names as corresponding dimensions.
    324324      !-----------------------------------------------------------------------------
    325       USE netcdf, ONLY : nf90_open, NF90_INQ_VARID, NF90_INQUIRE_VARIABLE, &
     325      USE netcdf, ONLY: nf90_open, nf90_inq_varid, nf90_inquire_variable, &
    326326              nf90_close, nf90_inq_dimid, nf90_inquire_dimension, nf90_get_var, &
    327327              nf90_get_att
    328       USE pchsp_95_m, only : pchsp_95
    329       USE pchfe_95_m, only : pchfe_95
    330       USE arth_m, only : arth
     328      USE pchsp_95_m, ONLY: pchsp_95
     329      USE pchfe_95_m, ONLY: pchfe_95
     330      USE arth_m, ONLY: arth
    331331      USE indice_sol_mod
    332332
     
    396396      CALL msg(5, ' Now reading file : ' // TRIM(fnam))
    397397      CALL ncerr(nf90_open(fnam, nf90_nowrite, ncid), fnam)
    398       CALL ncerr(NF90_INQ_VARID(ncid, trim(varname), varid), fnam)
    399       CALL ncerr(NF90_INQUIRE_VARIABLE(ncid, varid, dimids = dids), fnam)
     398      CALL ncerr(nf90_inq_varid(ncid, trim(varname), varid), fnam)
     399      CALL ncerr(nf90_inquire_variable(ncid, varid, dimids = dids), fnam)
    400400
    401401      !--- Longitude
    402402      CALL ncerr(nf90_inquire_dimension(ncid, dids(1), name = dnam, len = imdep), fnam)
    403403      ALLOCATE(dlon_ini(imdep), dlon(imdep))
    404       CALL ncerr(NF90_INQ_VARID(ncid, dnam, varid), fnam)
     404      CALL ncerr(nf90_inq_varid(ncid, dnam, varid), fnam)
    405405      CALL ncerr(nf90_get_var(ncid, varid, dlon_ini), fnam)
    406406      CALL msg(5, 'variable ' // TRIM(dnam) // ' dimension ', imdep)
     
    409409      CALL ncerr(nf90_inquire_dimension(ncid, dids(2), name = dnam, len = jmdep), fnam)
    410410      ALLOCATE(dlat_ini(jmdep), dlat(jmdep))
    411       CALL ncerr(NF90_INQ_VARID(ncid, dnam, varid), fnam)
     411      CALL ncerr(nf90_inq_varid(ncid, dnam, varid), fnam)
    412412      CALL ncerr(nf90_get_var(ncid, varid, dlat_ini), fnam)
    413413      CALL msg(5, 'variable ' // TRIM(dnam) // ' dimension ', jmdep)
     
    416416      CALL ncerr(nf90_inquire_dimension(ncid, dids(3), name = dnam, len = lmdep), fnam)
    417417      ALLOCATE(timeyear(lmdep + 2))
    418       CALL ncerr(NF90_INQ_VARID(ncid, dnam, varid), fnam)
     418      CALL ncerr(nf90_inq_varid(ncid, dnam, varid), fnam)
    419419      cal_in = ' '
    420420      IF(nf90_get_att(ncid, varid, 'calendar', cal_in)/=nf90_noerr) THEN
     
    450450      CALL msg(5, '')
    451451      CALL msg(5, 'READ AND INTERPOLATE HORIZONTALLY ', lmdep, ' FIELDS.')
    452       CALL ncerr(NF90_INQ_VARID(ncid, varname, varid), fnam)
     452      CALL ncerr(nf90_inq_varid(ncid, varname, varid), fnam)
    453453      DO l = 1, lmdep
    454454        CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, l], [imdep, jmdep, 1]), fnam)
     
    514514      IF(nf90_open(fnam_m, nf90_nowrite, ncid)==nf90_noerr) THEN
    515515        CALL msg(0, 'Reading previous year file ("' // TRIM(fnam_m) // '") last record for ' // TRIM(title))
    516         CALL ncerr(NF90_INQ_VARID(ncid, varname, varid), fnam_m)
    517         CALL ncerr(NF90_INQUIRE_VARIABLE(ncid, varid, dimids = dids), fnam_m)
     516        CALL ncerr(nf90_inq_varid(ncid, varname, varid), fnam_m)
     517        CALL ncerr(nf90_inquire_variable(ncid, varid, dimids = dids), fnam_m)
    518518        CALL ncerr(nf90_inquire_dimension(ncid, dids(3), len = l), fnam_m)
    519519        CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, l], [imdep, jmdep, 1]), fnam_m)
     
    537537      IF(nf90_open(fnam_p, nf90_nowrite, ncid)==nf90_noerr) THEN
    538538        CALL msg(0, 'Reading next year file ("' // TRIM(fnam_p) // '") first record for ' // TRIM(title))
    539         CALL ncerr(NF90_INQ_VARID(ncid, varname, varid), fnam_p)
     539        CALL ncerr(nf90_inq_varid(ncid, varname, varid), fnam_p)
    540540        CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, 1], [imdep, jmdep, 1]), fnam_p)
    541541        CALL ncerr(nf90_close(ncid), fnam_p)
     
    597597            CALL pchfe_95(timeyear, champtime(i, j, :), yder, skip, &
    598598                    arth(0.5, real(ndays_in) / ndays, ndays), champan(i, j, :), ierr)
    599             if (ierr < 0) call abort_physic("get_2Dfield", "", 1)
     599            if (ierr < 0) CALL abort_physic("get_2Dfield", "", 1)
    600600            n_extrap = n_extrap + ierr
    601601          END DO
     
    653653
    654654      !-------------------------------------------------------------------------------
    655       USE grid_noro_m, ONLY : grid_noro0
     655      USE grid_noro_m, ONLY: grid_noro0
    656656      IMPLICIT NONE
    657657      !===============================================================================
     
    744744      ! Purpose: NetCDF errors handling.
    745745      !-------------------------------------------------------------------------------
    746       USE netcdf, ONLY : nf90_noerr, NF90_STRERROR
     746      USE netcdf, ONLY: nf90_noerr, nf90_strerror
    747747      IMPLICIT NONE
    748748      !-------------------------------------------------------------------------------
     
    753753      IF(ncres/=nf90_noerr) THEN
    754754        WRITE(lunout, *)'Problem with file ' // TRIM(fnam) // ' in routine limit_netcdf.'
    755         CALL abort_physic('limit_netcdf', NF90_STRERROR(ncres), 1)
     755        CALL abort_physic('limit_netcdf', nf90_strerror(ncres), 1)
    756756      END IF
    757757
  • LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/test_disvert_m.F90

    r5086 r5101  
    3737    ps = (/(5e4 + delta_ps * i, i = 0, ngrid - 1)/)
    3838    forall (l = 1: llm + 1) p(:, l) = ap(l) + bp(l) * ps
    39     call exner_hyb(ngrid, ps, p, pks, pk)
     39    CALL exner_hyb(ngrid, ps, p, pks, pk)
    4040    p_lay = preff * (pk / cpp)**(1. / kappa)
    4141
     
    5757          END DO
    5858       END DO
    59        call abort_physic("test_disvert", "bad order of pressure values", 1)
     59       CALL abort_physic("test_disvert", "bad order of pressure values", 1)
    6060    end if
    6161
Note: See TracChangeset for help on using the changeset viewer.