Changeset 5101 for LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat
- Timestamp:
- Jul 23, 2024, 8:22:55 AM (14 months ago)
- 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 101 101 c Arguments : 102 102 c ----------- 103 LOGICAL,INTENT(IN) :: lafin ! .true. for the very last callto physics103 LOGICAL,INTENT(IN) :: lafin ! .true. for the very last CALL to physics 104 104 REAL,INTENT(IN):: jD_cur, jH_cur 105 105 REAL,INTENT(IN) :: pvcov(iip1,jjm,llm) ! covariant meridional velocity … … 185 185 write(lunout,*) ' ngridmx jjm iim ' 186 186 write(lunout,*) ngridmx,jjm,iim 187 callabort_gcm("calfis", "", 1)187 CALL abort_gcm("calfis", "", 1) 188 188 ENDIF 189 189 ELSE -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/gr_dyn_fi.F
r5099 r5101 23 23 24 24 IF (ngrid/=2+(jm-2)*(im-1)) then 25 callabort_gcm("gr_dyn_fi", 'probleme de dim', 1)25 CALL abort_gcm("gr_dyn_fi", 'probleme de dim', 1) 26 26 end if 27 27 c traitement des poles -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/inigeomphy_mod.F90
r5099 r5101 16 16 klon_omp_end, & ! end index of local omp subgrid 17 17 klon_mpi_begin ! start indes of columns (on local mpi grid) 18 USE geometry_mod, ONLY 19 USE physics_distribution_mod, ONLY 20 USE regular_lonlat_mod, ONLY 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, & 21 21 east, west, north, south, & 22 22 north_east, north_west, & 23 23 south_west, south_east 24 USE mod_interface_dyn_phys, ONLY 24 USE mod_interface_dyn_phys, ONLY: init_interface_dyn_phys 25 25 USE nrtype, ONLY: pi 26 26 USE comvert_mod, ONLY: preff, ap, bp, aps, bps, presnivs, & -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/lmdz_calfis_loc.F90
r5099 r5101 43 43 Use Write_field_p 44 44 USE Times 45 USE infotrac, ONLY 46 USE control_mod, ONLY 45 USE infotrac, ONLY: nqtot, tracers 46 USE control_mod, ONLY: planet_type, nsplit_phys 47 47 USE callphysiq_mod, ONLY: call_physiq 48 48 USE lmdz_cppkeys_wrapper, ONLY: CPPKEY_PHYS 49 49 50 USE comvert_mod, ONLY 51 USE comconst_mod, ONLY 50 USE comvert_mod, ONLY: preff, presnivs 51 USE comconst_mod, ONLY: cpp, daysec, dtphys, dtvr, kappa, pi 52 52 53 53 !======================================================================= … … 115 115 ! Arguments : 116 116 ! ----------- 117 LOGICAL, INTENT(IN) :: lafin ! .true. for the very last callto physics117 LOGICAL, INTENT(IN) :: lafin ! .true. for the very last CALL to physics 118 118 REAL, INTENT(IN) :: jD_cur, jH_cur 119 119 REAL, INTENT(IN) :: pvcov(iip1, jjb_v:jje_v, llm) ! covariant meridional velocity … … 248 248 write(lunout,*) ' ngridmx jjm iim ' 249 249 write(lunout,*) ngridmx,jjm,iim 250 callabort_gcm("calfis_loc", "", 1)250 CALL abort_gcm("calfis_loc", "", 1) 251 251 ENDIF 252 252 !$OMP MASTER … … 279 279 280 280 !$OMP MASTER 281 callstart_timer(timer_physic)281 CALL start_timer(timer_physic) 282 282 !$OMP END MASTER 283 283 … … 832 832 833 833 !$OMP MASTER 834 callstop_timer(timer_physic)834 CALL stop_timer(timer_physic) 835 835 !$OMP END MASTER 836 836 … … 850 850 !$OMP MASTER 851 851 !$OMP CRITICAL (MPI) 852 callMPI_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, & 853 853 COMM_LMDZ,Req(1),ierr) 854 callMPI_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, & 855 855 COMM_LMDZ,Req(2),ierr) 856 856 !$OMP END CRITICAL (MPI) … … 866 866 !$OMP MASTER 867 867 !$OMP CRITICAL (MPI) 868 callMPI_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, & 869 869 COMM_LMDZ,Req(3),ierr) 870 callMPI_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, & 871 871 COMM_LMDZ,Req(4),ierr) 872 872 !$OMP END CRITICAL (MPI) … … 881 881 !$OMP CRITICAL (MPI) 882 882 if (MPI_rank>0 .and. MPI_rank< MPI_Size-1) then 883 callMPI_WAITALL(4,Req(1),Status,ierr)883 CALL MPI_WAITALL(4,Req(1),Status,ierr) 884 884 else if (MPI_rank>0) then 885 callMPI_WAITALL(2,Req(1),Status,ierr)885 CALL MPI_WAITALL(2,Req(1),Status,ierr) 886 886 else if (MPI_rank <MPI_Size-1) then 887 callMPI_WAITALL(2,Req(3),Status,ierr)887 CALL MPI_WAITALL(2,Req(3),Status,ierr) 888 888 endif 889 889 !$OMP END CRITICAL (MPI) -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phydev/callphysiq_mod.F90
r5099 r5101 27 27 INTEGER,INTENT(IN) :: nqtot ! number of tracers 28 28 CHARACTER(len=*),INTENT(IN) :: tname(nqtot) ! tracer names 29 LOGICAL,INTENT(IN) :: debut_split ! .true. if very first callto physics30 LOGICAL,INTENT(IN) :: lafin_split ! .true. if last callto physics29 LOGICAL,INTENT(IN) :: debut_split ! .true. if very first CALL to physics 30 LOGICAL,INTENT(IN) :: lafin_split ! .true. if last CALL to physics 31 31 REAL,INTENT(IN) :: JD_cur ! Julian day 32 32 REAL,INTENT(IN) :: JH_cur_split ! Julian hour (fraction of day) -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/callphysiq_mod.F90
r5099 r5101 22 22 USE control_mod, ONLY: planet_type, ok_dyn_xios 23 23 USE physiq_mod, ONLY: physiq 24 USE lmdz_xios, ONLY 24 USE lmdz_xios, ONLY: xios_set_current_context, xios_get_current_context, xios_context 25 25 IMPLICIT NONE 26 26 … … 29 29 INTEGER,INTENT(IN) :: nqtot ! number of tracers 30 30 CHARACTER(len=*),INTENT(IN) :: tname(nqtot) ! tracer names 31 LOGICAL,INTENT(IN) :: debut_split ! .true. if very first callto physics32 LOGICAL,INTENT(IN) :: lafin_split ! .true. if last callto physics31 LOGICAL,INTENT(IN) :: debut_split ! .true. if very first CALL to physics 32 LOGICAL,INTENT(IN) :: lafin_split ! .true. if last CALL to physics 33 33 REAL,INTENT(IN) :: JD_cur ! Julian day 34 34 REAL,INTENT(IN) :: JH_cur_split ! Julian hour (fraction of day) -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/ce0l.F90
r5100 r5101 22 22 USE limit, ONLY: limit_netcdf 23 23 USE netcdf, ONLY: nf90_open, nf90_nowrite, nf90_close, nf90_noerr, & 24 nf90_inquire_dimension, nf90_inq_dimid, NF90_INQ_VARID, nf90_get_var24 nf90_inquire_dimension, nf90_inq_dimid, nf90_inq_varid, nf90_get_var 25 25 USE infotrac, ONLY: init_infotrac 26 26 USE dimphy, ONLY: klon … … 200 200 END IF 201 201 ALLOCATE(masktmp(klon)) 202 iret= NF90_INQ_VARID(nid_sta,'masque',nid_msk)202 iret=nf90_inq_varid(nid_sta,'masque',nid_msk) 203 203 iret=nf90_get_var(nid_sta,nid_msk,masktmp) 204 204 iret=nf90_close(nid_sta) … … 249 249 END IF 250 250 IF (using_xios) CALL xios_finalize 251 IF (using_mpi) callMPI_FINALIZE(ierr)251 IF (using_mpi) CALL MPI_FINALIZE(ierr) 252 252 #endif 253 253 -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/etat0phys_netcdf.F90
r5099 r5101 564 564 endif 565 565 enddo 566 calldump2d(imp1,jmp1,phis,'phis ')567 calldump2d(imp1,jmp1,masque,'masque ')568 calldump2d(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 ') 569 569 570 570 END SUBROUTINE filtreoro -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/iniphysiq_mod.F90
r5099 r5101 15 15 USE mod_grid_phy_lmdz, ONLY: nbp_lon,nbp_lat,nbp_lev,klon_glo ! number of atmospheric columns (on full grid) 16 16 USE mod_phys_lmdz_para, ONLY: klon_omp ! number of columns (on local omp grid) 17 USE vertical_layers_mod, ONLY 17 USE vertical_layers_mod, ONLY: init_vertical_layers 18 18 USE infotrac, ONLY: nbtr, type_trac 19 19 20 20 #ifdef REPROBUS 21 USE CHEM_REP, ONLY 21 USE CHEM_REP, ONLY: Init_chem_rep_phys 22 22 #ifdef CPP_PARA 23 USE parallel_lmdz, ONLY 24 USE bands, ONLY 23 USE parallel_lmdz, ONLY: mpi_size, mpi_rank 24 USE bands, ONLY: distrib_phys 25 25 #endif 26 26 USE mod_phys_lmdz_omp_data, ONLY: klon_omp … … 36 36 USE indice_sol_mod, ONLY: nbsrf, is_oce, is_sic, is_ter, is_lic 37 37 #ifdef CPP_PARA 38 USE parallel_lmdz, ONLY 39 USE bands, ONLY 38 USE parallel_lmdz, ONLY: mpi_size, mpi_rank 39 USE bands, ONLY: distrib_phys 40 40 #endif 41 41 USE mod_phys_lmdz_omp_data, ONLY: klon_omp … … 137 137 IF (type_trac == 'repr') THEN 138 138 #ifdef REPROBUS 139 callInit_chem_rep_phys(klon_omp,nlayer)140 callinit_reprobus_para( &139 CALL Init_chem_rep_phys(klon_omp,nlayer) 140 CALL init_reprobus_para( & 141 141 nbp_lon,nbp_lat,nbp_lev,klon_glo,mpi_size, & 142 142 distrib_phys,communicator) … … 148 148 IF (type_trac == 'repr') THEN 149 149 #ifdef REPROBUS 150 callinit_reprobus_para( &150 CALL init_reprobus_para( & 151 151 nbp_lon,nbp_lat,nbp_lev,klon_glo,mpi_size, & 152 152 distrib_phys,communicator) -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/init_ssrf_m.F90
r5099 r5101 6 6 USE dimphy, ONLY: klon, zmasq 7 7 USE phys_state_var_mod, ONLY: pctsrf 8 USE geometry_mod, ONLY 8 USE geometry_mod, ONLY: longitude_deg, latitude_deg 9 9 USE grid_atob_m, ONLY: grille_m 10 10 USE ioipsl, ONLY: flininfo, flinopen, flinget, flinclo -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/limit_netcdf.f90
r5100 r5101 17 17 !------------------------------------------------------------------------------- 18 18 19 USE ioipsl, ONLY 20 USE assert_eq_m, ONLY 21 USE cal_tools_m, ONLY 22 USE conf_dat_m, ONLY 23 USE dimphy, ONLY 24 USE geometry_mod, ONLY 25 USE phys_state_var_mod, ONLY 26 USE control_mod, ONLY 27 USE init_ssrf_m, ONLY 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 28 28 29 29 INTEGER, PARAMETER :: ns = 256 … … 70 70 !------------------------------------------------------------------------------- 71 71 USE indice_sol_mod 72 USE netcdf, ONLY 72 USE netcdf, ONLY: nf90_open, nf90_create, nf90_close, & 73 73 nf90_def_dim, nf90_def_var, nf90_put_var, nf90_put_att, & 74 74 nf90_noerr, nf90_nowrite, nf90_global, & 75 75 nf90_clobber, nf90_enddef, nf90_unlimited, nf90_float, & 76 76 nf90_64bit_offset 77 USE lmdz_cppkeys_wrapper, ONLY 78 USE inter_barxy_m, ONLY 79 USE netcdf95, ONLY 80 USE comconst_mod, ONLY 81 USE phys_cal_mod, ONLY 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 82 82 IMPLICIT NONE 83 83 !------------------------------------------------------------------------------- … … 262 262 CALL ncerr(nf90_def_var(nid, "ALB", nf90_format, dims, id_ALB), fnam) 263 263 CALL ncerr(nf90_def_var(nid, "RUG", nf90_format, dims, id_RUG), fnam) 264 callnf95_def_var(nid, "longitude", nf90_float, ndim, varid_longitude)265 callnf95_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) 266 266 267 267 !--- Attributes creation … … 277 277 CALL ncerr(nf90_put_att(nid, id_RUG, "title", "Rugosite"), fnam) 278 278 279 callnf95_put_att(nid, varid_longitude, "standard_name", "longitude")280 callnf95_put_att(nid, varid_longitude, "units", "degrees_east")281 282 callnf95_put_att(nid, varid_latitude, "standard_name", "latitude")283 callnf95_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") 284 284 285 285 CALL ncerr(nf90_enddef(nid), fnam) … … 295 295 CALL ncerr(nf90_put_var(nid, id_ALB, phy_alb(:, :), [1, 1], [klon, ndays]), fnam) 296 296 CALL ncerr(nf90_put_var(nid, id_RUG, phy_rug(:, :), [1, 1], [klon, ndays]), fnam) 297 callnf95_put_var(nid, varid_longitude, longitude_deg)298 callnf95_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) 299 299 300 300 CALL ncerr(nf90_close(nid), fnam) … … 323 323 ! 2) Dimensional variables have the same names as corresponding dimensions. 324 324 !----------------------------------------------------------------------------- 325 USE netcdf, ONLY : nf90_open, NF90_INQ_VARID, NF90_INQUIRE_VARIABLE, &325 USE netcdf, ONLY: nf90_open, nf90_inq_varid, nf90_inquire_variable, & 326 326 nf90_close, nf90_inq_dimid, nf90_inquire_dimension, nf90_get_var, & 327 327 nf90_get_att 328 USE pchsp_95_m, only: pchsp_95329 USE pchfe_95_m, only: pchfe_95330 USE arth_m, only: arth328 USE pchsp_95_m, ONLY: pchsp_95 329 USE pchfe_95_m, ONLY: pchfe_95 330 USE arth_m, ONLY: arth 331 331 USE indice_sol_mod 332 332 … … 396 396 CALL msg(5, ' Now reading file : ' // TRIM(fnam)) 397 397 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) 400 400 401 401 !--- Longitude 402 402 CALL ncerr(nf90_inquire_dimension(ncid, dids(1), name = dnam, len = imdep), fnam) 403 403 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) 405 405 CALL ncerr(nf90_get_var(ncid, varid, dlon_ini), fnam) 406 406 CALL msg(5, 'variable ' // TRIM(dnam) // ' dimension ', imdep) … … 409 409 CALL ncerr(nf90_inquire_dimension(ncid, dids(2), name = dnam, len = jmdep), fnam) 410 410 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) 412 412 CALL ncerr(nf90_get_var(ncid, varid, dlat_ini), fnam) 413 413 CALL msg(5, 'variable ' // TRIM(dnam) // ' dimension ', jmdep) … … 416 416 CALL ncerr(nf90_inquire_dimension(ncid, dids(3), name = dnam, len = lmdep), fnam) 417 417 ALLOCATE(timeyear(lmdep + 2)) 418 CALL ncerr( NF90_INQ_VARID(ncid, dnam, varid), fnam)418 CALL ncerr(nf90_inq_varid(ncid, dnam, varid), fnam) 419 419 cal_in = ' ' 420 420 IF(nf90_get_att(ncid, varid, 'calendar', cal_in)/=nf90_noerr) THEN … … 450 450 CALL msg(5, '') 451 451 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) 453 453 DO l = 1, lmdep 454 454 CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, l], [imdep, jmdep, 1]), fnam) … … 514 514 IF(nf90_open(fnam_m, nf90_nowrite, ncid)==nf90_noerr) THEN 515 515 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) 518 518 CALL ncerr(nf90_inquire_dimension(ncid, dids(3), len = l), fnam_m) 519 519 CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, l], [imdep, jmdep, 1]), fnam_m) … … 537 537 IF(nf90_open(fnam_p, nf90_nowrite, ncid)==nf90_noerr) THEN 538 538 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) 540 540 CALL ncerr(nf90_get_var(ncid, varid, champ, [1, 1, 1], [imdep, jmdep, 1]), fnam_p) 541 541 CALL ncerr(nf90_close(ncid), fnam_p) … … 597 597 CALL pchfe_95(timeyear, champtime(i, j, :), yder, skip, & 598 598 arth(0.5, real(ndays_in) / ndays, ndays), champan(i, j, :), ierr) 599 if (ierr < 0) callabort_physic("get_2Dfield", "", 1)599 if (ierr < 0) CALL abort_physic("get_2Dfield", "", 1) 600 600 n_extrap = n_extrap + ierr 601 601 END DO … … 653 653 654 654 !------------------------------------------------------------------------------- 655 USE grid_noro_m, ONLY 655 USE grid_noro_m, ONLY: grid_noro0 656 656 IMPLICIT NONE 657 657 !=============================================================================== … … 744 744 ! Purpose: NetCDF errors handling. 745 745 !------------------------------------------------------------------------------- 746 USE netcdf, ONLY : nf90_noerr, NF90_STRERROR746 USE netcdf, ONLY: nf90_noerr, nf90_strerror 747 747 IMPLICIT NONE 748 748 !------------------------------------------------------------------------------- … … 753 753 IF(ncres/=nf90_noerr) THEN 754 754 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) 756 756 END IF 757 757 -
LMDZ6/branches/Amaury_dev/libf/dynphy_lonlat/phylmd/test_disvert_m.F90
r5086 r5101 37 37 ps = (/(5e4 + delta_ps * i, i = 0, ngrid - 1)/) 38 38 forall (l = 1: llm + 1) p(:, l) = ap(l) + bp(l) * ps 39 callexner_hyb(ngrid, ps, p, pks, pk)39 CALL exner_hyb(ngrid, ps, p, pks, pk) 40 40 p_lay = preff * (pk / cpp)**(1. / kappa) 41 41 … … 57 57 END DO 58 58 END DO 59 callabort_physic("test_disvert", "bad order of pressure values", 1)59 CALL abort_physic("test_disvert", "bad order of pressure values", 1) 60 60 end if 61 61
Note: See TracChangeset
for help on using the changeset viewer.