Ignore:
Timestamp:
Jan 11, 2021, 11:24:08 PM (4 years ago)
Author:
lguez
Message:

Sync latest trunk changes to Ocean_skin

Location:
LMDZ6/branches/Ocean_skin
Files:
2 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Ocean_skin

  • LMDZ6/branches/Ocean_skin/libf/phylmd/physiq_mod.F90

    • Property svn:keywords changed from Author Date Id Revision to Id
    r3617 r3798  
    1616       d_u, d_v, d_t, d_qx, d_ps)
    1717
     18! For clarity, the "USE" section is now arranged in alphabetical order,
     19! with a separate section for CPP keys
     20! PLEASE try to follow this rule
     21
     22    USE ACAMA_GWD_rando_m, only: ACAMA_GWD_rando
     23    USE aero_mod
     24    USE add_phys_tend_mod, only : add_pbl_tend, add_phys_tend, diag_phys_tend, prt_enerbil, &
     25  &      fl_ebil, fl_cor_ebil
    1826    USE assert_m, only: assert
     27    USE change_srf_frac_mod
     28    USE conf_phys_m, only: conf_phys
     29    USE carbon_cycle_mod, ONLY : infocfields_init, RCO2_glo, carbon_cycle_rad
     30    USE CFMIP_point_locations   ! IM stations CFMIP
     31    USE cmp_seri_mod
     32    USE dimphy
     33    USE etat0_limit_unstruct_mod
     34    USE FLOTT_GWD_rando_m, only: FLOTT_GWD_rando
     35    USE fonte_neige_mod, ONLY  : fonte_neige_get_vars
     36    USE geometry_mod, ONLY: cell_area, latitude_deg, longitude_deg
    1937    USE ioipsl, only: histbeg, histvert, histdef, histend, histsync, &
    2038         histwrite, ju2ymds, ymds2ju, getin
    21     USE geometry_mod, ONLY: cell_area, latitude_deg, longitude_deg
     39    USE ioipsl_getin_p_mod, ONLY : getin_p
     40    USE indice_sol_mod
     41    USE infotrac_phy, ONLY: nqtot, nbtr, nqo, type_trac
     42    USE iophy
     43    USE limit_read_mod, ONLY : init_limit_read
     44    USE mod_grid_phy_lmdz, ONLY: nbp_lon, nbp_lat, nbp_lev, klon_glo, grid1dTo2d_glo, grid_type, unstructured
     45    USE mod_phys_lmdz_mpi_data, only: is_mpi_root
     46    USE mod_phys_lmdz_para
     47    USE netcdf95, only: nf95_close
     48    USE netcdf, only: nf90_fill_real     ! IM for NMC files
     49    USE open_climoz_m, only: open_climoz ! ozone climatology from a file
     50    USE ozonecm_m, only: ozonecm ! ozone of J.-F. Royer
     51    USE pbl_surface_mod, ONLY : pbl_surface
     52    USE phyaqua_mod, only: zenang_an
     53    USE phystokenc_mod, ONLY: offline, phystokenc
    2254    USE phys_cal_mod, only: year_len, mth_len, days_elapsed, jh_1jan, &
    2355         year_cur, mth_cur,jD_cur, jH_cur, jD_ref, day_cur, hour
     56!!  USE phys_local_var_mod, ONLY : a long list of variables
     57!!              ==> see below, after "CPP Keys" section
     58    USE phys_state_var_mod ! Variables sauvegardees de la physique
     59    USE phys_output_mod
     60    USE phys_output_ctrlout_mod
     61    USE print_control_mod, ONLY: mydebug=>debug , lunout, prt_level
     62    USE readaerosol_mod, ONLY : init_aero_fromfile
     63    USE readaerosolstrato_m, ONLY : init_readaerosolstrato
     64    USE radlwsw_m, only: radlwsw
     65    USE regr_horiz_time_climoz_m, ONLY: regr_horiz_time_climoz
     66    USE regr_pr_time_av_m, only: regr_pr_time_av
     67    USE surface_data,     ONLY : type_ocean, ok_veget, landice_opt
     68    USE time_phylmdz_mod, only: annee_ref, current_time, day_ini, day_ref, &
     69          day_step_phy, itau_phy, pdtphys, raz_date, start_time, update_time
     70    USE tracinca_mod, ONLY: config_inca
     71    USE tropopause_m,     ONLY: dyn_tropopause
     72    USE vampir
     73    USE VERTICAL_LAYERS_MOD, ONLY: aps,bps, ap, bp
    2474    USE write_field_phy
    25     USE dimphy
    26     USE infotrac_phy, ONLY: nqtot, nbtr, nqo, type_trac
    27     USE mod_grid_phy_lmdz, ONLY: nbp_lon, nbp_lat, nbp_lev, klon_glo, grid1dTo2d_glo, grid_type, unstructured
    28     USE mod_phys_lmdz_para
    29     USE iophy
    30     USE print_control_mod, ONLY: mydebug=>debug , lunout, prt_level
    31     USE phystokenc_mod, ONLY: offline, phystokenc
    32     USE time_phylmdz_mod, only: raz_date, day_step_phy, update_time,current_time
    33     USE vampir
    34     USE pbl_surface_mod, ONLY : pbl_surface
    35     USE change_srf_frac_mod
    36     USE surface_data,     ONLY : type_ocean, ok_veget, ok_snow
    37     USE tropopause_m,     ONLY: dyn_tropopause
     75
     76    !USE cmp_seri_mod
     77!    USE add_phys_tend_mod, only : add_pbl_tend, add_phys_tend, diag_phys_tend, prt_enerbil, &
     78!  &      fl_ebil, fl_cor_ebil
     79
     80!!!!!!!!!!!!!!!!!! "USE" section for CPP keys !!!!!!!!!!!!!!!!!!!!!!!!
     81!
     82!
    3883#ifdef CPP_Dust
    39     USE phytracr_spl_mod, ONLY: phytracr_spl
     84    USE phytracr_spl_mod, ONLY: phytracr_spl, phytracr_spl_out_init
     85    USE phys_output_write_spl_mod
     86#else
     87    USE phytrac_mod, ONLY : phytrac_init, phytrac
     88    USE phys_output_write_mod
    4089#endif
     90
     91
     92#ifdef REPROBUS
     93    USE CHEM_REP, ONLY : Init_chem_rep_xjour, &
     94         d_q_rep,d_ql_rep,d_qi_rep,ptrop,ttrop, &
     95         ztrop, gravit,itroprep, Z1,Z2,fac,B
     96#endif
     97
     98
     99#ifdef CPP_RRTM
     100    USE YOERAD, ONLY : NRADLP
     101    USE YOESW, ONLY : RSUN
     102#endif
     103
     104
    41105#ifdef CPP_StratAer
    42106    USE strataer_mod, ONLY: strataer_init
    43107#endif
    44     USE phys_local_var_mod, ONLY: phys_local_var_init, phys_local_var_end, &
     108
     109
     110#ifdef CPP_XIOS
     111    USE xios, ONLY: xios_update_calendar, xios_context_finalize, &
     112            xios_get_field_attr, xios_field_is_active
     113    USE wxios, ONLY: missing_val, missing_val_omp
     114#endif
     115#ifndef CPP_XIOS
     116    USE paramLMDZ_phy_mod
     117#endif
     118!
     119!
     120!!!!!!!!!!!!!!!!!!  END "USE" for CPP keys !!!!!!!!!!!!!!!!!!!!!!
     121
     122USE phys_local_var_mod, ONLY: phys_local_var_init, phys_local_var_end, &
    45123       ! [Variables internes non sauvegardees de la physique]
    46124       ! Variables locales pour effectuer les appels en serie
     
    195273       ref_liq, ref_ice, theta,  &
    196274       ref_liq_pi, ref_ice_pi,  &
    197        zphi, zx_rh, &
     275       zphi, zx_rh, zx_rhl, zx_rhi, &
    198276       pmfd, pmfu,  &
    199277       !
     
    216294       zxsnow,snowhgt,qsnow,to_ice,sissnow,runoff,albsol3_lic
    217295       !
    218     USE phys_state_var_mod ! Variables sauvegardees de la physique
    219 #ifdef CPP_Dust
    220     USE phys_output_write_spl_mod
    221 #else
    222     USE phys_output_var_mod ! Variables pour les ecritures des sorties
    223 #endif
    224 
    225     USE phys_output_write_mod
    226     USE fonte_neige_mod, ONLY  : fonte_neige_get_vars
    227     USE phys_output_mod
    228     USE phys_output_ctrlout_mod
    229     USE open_climoz_m, only: open_climoz ! ozone climatology from a file
    230     USE regr_pr_time_av_m, only: regr_pr_time_av
    231     USE netcdf95, only: nf95_close
    232     !IM for NMC files
    233     USE netcdf, only: nf90_fill_real
    234     USE mod_phys_lmdz_mpi_data, only: is_mpi_root
    235     USE aero_mod
    236     USE ozonecm_m, only: ozonecm ! ozone of J.-F. Royer
    237     USE conf_phys_m, only: conf_phys
    238     USE radlwsw_m, only: radlwsw
    239     USE phyaqua_mod, only: zenang_an
    240     USE time_phylmdz_mod, only: day_step_phy, annee_ref, day_ref, itau_phy, &
    241          start_time, pdtphys, day_ini
    242     USE tracinca_mod, ONLY: config_inca
    243 #ifdef CPP_XIOS
    244     USE wxios, ONLY: missing_val, missing_val_omp
    245     USE xios, ONLY: xios_get_field_attr, xios_field_is_active
    246 #endif
    247 #ifdef REPROBUS
    248     USE CHEM_REP, ONLY : Init_chem_rep_xjour
    249 #endif
    250     USE indice_sol_mod
    251     USE phytrac_mod, ONLY : phytrac_init, phytrac
    252     USE carbon_cycle_mod, ONLY : infocfields_init, RCO2_glo, carbon_cycle_rad
    253 
    254 #ifdef CPP_RRTM
    255     USE YOERAD, ONLY : NRADLP
    256     USE YOESW, ONLY : RSUN
    257 #endif
    258     USE ioipsl_getin_p_mod, ONLY : getin_p
    259 
    260 #ifndef CPP_XIOS
    261     USE paramLMDZ_phy_mod
    262 #endif
    263 
    264     USE cmp_seri_mod
    265     USE add_phys_tend_mod, only : add_pbl_tend, add_phys_tend, diag_phys_tend, prt_enerbil, &
    266   &      fl_ebil, fl_cor_ebil
    267 
    268     !IM stations CFMIP
    269     USE CFMIP_point_locations
    270     USE FLOTT_GWD_rando_m, only: FLOTT_GWD_rando
    271     USE ACAMA_GWD_rando_m, only: ACAMA_GWD_rando
    272     USE VERTICAL_LAYERS_MOD, ONLY: aps,bps
    273     USE etat0_limit_unstruct_mod
    274 #ifdef CPP_XIOS
    275     USE xios, ONLY: xios_update_calendar, xios_context_finalize
    276 #endif
    277     USE limit_read_mod, ONLY : init_limit_read
    278     USE regr_horiz_time_climoz_m, ONLY: regr_horiz_time_climoz
    279     USE readaerosol_mod, ONLY : init_aero_fromfile
    280     USE readaerosolstrato_m, ONLY : init_readaerosolstrato
     296
    281297
    282298    IMPLICIT NONE
     
    10651081    LOGICAL, SAVE :: flag_bc_internal_mixture
    10661082    !$OMP THREADPRIVATE(flag_bc_internal_mixture)
    1067     LOGICAL, SAVE :: new_aod
    1068     !$OMP THREADPRIVATE(new_aod)
    10691083    !
    10701084    !--STRAT AEROSOL
     
    12491263            ok_ade, ok_aie, ok_alw, ok_cdnc, ok_volcan, aerosol_couple, &
    12501264            chemistry_couple, &
    1251             flag_aerosol, flag_aerosol_strat, flag_aer_feedback, new_aod, &
     1265            flag_aerosol, flag_aerosol_strat, flag_aer_feedback, &
    12521266            flag_bc_internal_mixture, bl95_b0, bl95_b1, &
    12531267                                ! nv flags pour la convection et les
     
    13471361       iflag_phytrac = 1 ! by default we do want to call phytrac
    13481362       CALL getin_p('iflag_phytrac',iflag_phytrac)
     1363#ifdef CPP_Dust
     1364       IF (iflag_phytrac.EQ.0) THEN
     1365         WRITE(lunout,*) 'In order to run with SPLA, iflag_phytrac will be forced to 1'
     1366         iflag_phytrac = 1
     1367       ENDIF
     1368#endif 
    13491369       nvm_lmdz = 13
    13501370       CALL getin_p('NVM',nvm_lmdz)
     
    15151535       ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    15161536       CALL init_iophy_new(latitude_deg,longitude_deg)
     1537       CALL create_etat0_limit_unstruct
     1538       CALL phyetat0 ("startphy.nc",clesphy0,tabcntr0)
    15171539
    15181540          !===================================================================
     
    15751597            ok_hf,ok_instan,ok_LES,ok_ade,ok_aie, &
    15761598            read_climoz, phys_out_filestations, &
    1577             new_aod, aerosol_couple, &
     1599            aerosol_couple, &
    15781600            flag_aerosol_strat, pdtphys, paprs, pphis,  &
    15791601            pplay, lmax_th, ptconv, ptconvth, ivap,  &
     
    16091631#ifdef CPP_COSP
    16101632      IF (ok_cosp) THEN
    1611            DO k = 1, klev
    1612              DO i = 1, klon
    1613                phicosp(i,k) = pphi(i,k) + pphis(i)
    1614              ENDDO
    1615            ENDDO
     1633!           DO k = 1, klev
     1634!             DO i = 1, klon
     1635!               phicosp(i,k) = pphi(i,k) + pphis(i)
     1636!             ENDDO
     1637!           ENDDO
    16161638        CALL phys_cosp(itap,phys_tstep,freq_cosp, &
    16171639               ok_mensuelCOSP,ok_journeCOSP,ok_hfCOSP, &
     
    16311653#ifdef CPP_COSP2
    16321654        IF (ok_cosp) THEN
    1633            DO k = 1, klev
    1634              DO i = 1, klon
    1635                phicosp(i,k) = pphi(i,k) + pphis(i)
    1636              ENDDO
    1637            ENDDO
     1655!           DO k = 1, klev
     1656!             DO i = 1, klon
     1657!               phicosp(i,k) = pphi(i,k) + pphis(i)
     1658!             ENDDO
     1659!           ENDDO
    16381660          CALL phys_cosp2(itap,phys_tstep,freq_cosp, &
    16391661               ok_mensuelCOSP,ok_journeCOSP,ok_hfCOSP, &
     
    16811703
    16821704       CALL iniradia(klon,klev,paprs(1,1:klev+1))
    1683        ! Initialisation des champs dans phytrac qui sont utilisés par phys_output_write
     1705
     1706       ! Initialisation des champs dans phytrac* qui sont utilisés par phys_output_write*
     1707#ifdef CPP_Dust
     1708       ! Quand on utilise SPLA, on force iflag_phytrac=1
     1709       CALL phytracr_spl_out_init()
     1710       CALL phys_output_write_spl(itap, pdtphys, paprs, pphis,                  &
     1711                                pplay, lmax_th, aerosol_couple,                 &
     1712                                ok_ade, ok_aie, ivap, ok_sync,                  &
     1713                                ptconv, read_climoz, clevSTD,                   &
     1714                                ptconvth, d_t, qx, d_qx, d_tr_dyn, zmasse,      &
     1715                                flag_aerosol, flag_aerosol_strat, ok_cdnc)
     1716#else
     1717       ! phys_output_write écrit des variables traceurs seulement si iflag_phytrac == 1
     1718       ! donc seulement dans ce cas on doit appeler phytrac_init()
    16841719       IF (iflag_phytrac == 1 ) THEN
    16851720          CALL phytrac_init()
    1686         ENDIF
    1687 
     1721       ENDIF
    16881722       CALL phys_output_write(itap, pdtphys, paprs, pphis,                    &
    16891723                              pplay, lmax_th, aerosol_couple,                 &
    1690                               ok_ade, ok_aie, ok_volcan, ivap, iliq, isol, new_aod, ok_sync,&
     1724                              ok_ade, ok_aie, ok_volcan, ivap, iliq, isol, ok_sync,&
    16911725                              ptconv, read_climoz, clevSTD,                   &
    16921726                              ptconvth, d_u, d_t, qx, d_qx, zmasse,           &
    16931727                              flag_aerosol, flag_aerosol_strat, ok_cdnc)
     1728#endif
     1729
    16941730
    16951731#ifdef CPP_XIOS
     
    16971733#endif
    16981734       IF(read_climoz>=1 .AND. create_etat0_limit) CALL regr_horiz_time_climoz(read_climoz,ok_daily_climoz)
    1699        CALL create_etat0_limit_unstruct
    1700        CALL phyetat0 ("startphy.nc",clesphy0,tabcntr0)
    17011735
    17021736!jyg<
     
    19521986#endif
    19531987       ENDIF
     1988       IF (type_trac == 'repr') THEN
     1989#ifdef REPROBUS
     1990          CALL chemini_rep(  &
     1991               presnivs, &
     1992               pdtphys, &
     1993               annee_ref, &
     1994               day_ref,  &
     1995               day_ini, &
     1996               start_time, &
     1997               itau_phy, &
     1998               io_lon, &
     1999               io_lat)
     2000#endif
     2001       ENDIF
    19542002
    19552003       !$omp single
     
    22882336
    22892337          wo(:,:,1)=ozonecm(latitude_deg, paprs,read_climoz,rjour=zzz)
     2338#ifdef REPROBUS
     2339          ptrop=dyn_tropopause(t_seri, ztsol, paprs, pplay, rot)/100.
     2340          DO i = 1, klon
     2341             Z1=t_seri(i,itroprep(i)+1)
     2342             Z2=t_seri(i,itroprep(i))
     2343             fac=(Z1-Z2)/alog(pplay(i,itroprep(i)+1)/pplay(i,itroprep(i)))
     2344             B=Z2-fac*alog(pplay(i,itroprep(i)))
     2345             ttrop(i)= fac*alog(ptrop(i))+B
     2346!       
     2347             Z1= 1.e-3 * ( pphi(i,itroprep(i)+1)+pphis(i) ) / gravit
     2348             Z2= 1.e-3 * ( pphi(i,itroprep(i))  +pphis(i) ) / gravit
     2349             fac=(Z1-Z2)/alog(pplay(i,itroprep(i)+1)/pplay(i,itroprep(i)))
     2350             B=Z2-fac*alog(pplay(i,itroprep(i)))
     2351             ztrop(i)=fac*alog(ptrop(i))+B
     2352          ENDDO
     2353#endif
    22902354       ELSE
    22912355          !--- ro3i = elapsed days number since current year 1st january, 0h
     
    24842548            longitude_deg, latitude_deg, rugoro,  zrmu0,      &
    24852549            zsig,      sollwdown, pphi,    cldt,      &
    2486             rain_fall, snow_fall, solsw,   sollw,     &
     2550            rain_fall, snow_fall, solsw,   solswfdiff, sollw,     &
    24872551            gustiness,                                &
    24882552            t_seri,    q_seri,    u_seri,  v_seri,    &
     
    36743738          ENDIF
    36753739          zx_rh(i,k) = q_seri(i,k)/zx_qs
     3740            IF (iflag_ice_thermo .GT. 0) THEN
     3741          zx_rhl(i,k) = q_seri(i,k)/(qsatl(zx_t)/pplay(i,k))
     3742          zx_rhi(i,k) = q_seri(i,k)/(qsats(zx_t)/pplay(i,k))
     3743            ENDIF
    36763744          zqsat(i,k)=zx_qs
    36773745       ENDDO
     
    37563824#endif
    37573825    ENDIF !type_trac = inca
    3758 
     3826    IF (type_trac == 'repr') THEN
     3827#ifdef REPROBUS
     3828    !CALL chemtime_rep(itap+itau_phy-1, date0, dtime, itap)
     3829    CALL chemtime_rep(itap+itau_phy-1, date0, phys_tstep, itap)
     3830#endif
     3831    ENDIF
    37593832
    37603833    !
     
    37713844                !
    37723845                CALL readaerosol_optic( &
    3773                      debut, new_aod, flag_aerosol, itap, jD_cur-jD_ref, &
     3846                     debut, flag_aerosol, itap, jD_cur-jD_ref, &
    37743847                     pdtphys, pplay, paprs, t_seri, rhcl, presnivs,  &
    37753848                     mass_solu_aero, mass_solu_aero_pi,  &
     
    37963869                   !--climatologies or INCA aerosols
    37973870                   CALL readaerosol_optic_rrtm( debut, aerosol_couple, ok_alw, ok_volcan, &
    3798                         new_aod, flag_aerosol, flag_bc_internal_mixture, itap, jD_cur-jD_ref, &
     3871                        flag_aerosol, flag_bc_internal_mixture, itap, jD_cur-jD_ref, &
    37993872                        pdtphys, pplay, paprs, t_seri, rhcl, presnivs,  &
    38003873                        tr_seri, mass_solu_aero, mass_solu_aero_pi,  &
     
    38133886                   !
    38143887                   CALL readaerosol_optic( &
    3815                         debut, new_aod, flag_aerosol, itap, jD_cur-jD_ref, &
     3888                        debut, flag_aerosol, itap, jD_cur-jD_ref, &
    38163889                        pdtphys, pplay, paprs, t_seri, rhcl, presnivs,  &
    38173890                        mass_solu_aero, mass_solu_aero_pi,  &
     
    41024175               ! Rajoute par OB pour RRTM
    41034176               tau_aero_lw_rrtm, &
    4104                cldtaupirad,new_aod, &
     4177               cldtaupirad, &
    41054178!              zqsat, flwcrad, fiwcrad, &
    41064179               zqsat, flwc, fiwc, &
     
    41084181               heat,heat0,cool,cool0,albpla, &
    41094182               heat_volc,cool_volc, &
    4110                topsw,toplw,solsw,sollw, &
     4183               topsw,toplw,solsw,solswfdiff,sollw, &
    41114184               sollwdown, &
    41124185               topsw0,toplw0,solsw0,sollw0, &
     
    41894262                                ! Rajoute par OB pour RRTM
    41904263                     tau_aero_lw_rrtm, &
    4191                      cldtaupi,new_aod, &
     4264                     cldtaupi, &
    41924265!                    zqsat, flwcrad, fiwcrad, &
    41934266                     zqsat, flwc, fiwc, &
     
    41954268                     heatp,heat0p,coolp,cool0p,albplap, &
    41964269                     heat_volc,cool_volc, &
    4197                      topswp,toplwp,solswp,sollwp, &
     4270                     topswp,toplwp,solswp,solswfdiffp,sollwp, &
    41984271                     sollwdownp, &
    41994272                     topsw0p,toplw0p,solsw0p,sollw0p, &
     
    46654738#ifdef CPP_COSPV2
    46664739       IF (itap.eq.1.or.MOD(itap,NINT(freq_cosp/phys_tstep)).EQ.0) THEN
     4740!        IF (MOD(itap,NINT(freq_cosp/phys_tstep)).EQ.0) THEN
    46674741
    46684742          IF (prt_level .GE.10) THEN
    46694743             print*,'freq_cosp',freq_cosp
    46704744          ENDIF
     4745           DO k = 1, klev
     4746             DO i = 1, klon
     4747               phicosp(i,k) = pphi(i,k) + pphis(i)
     4748             ENDDO
     4749           ENDDO
    46714750          mr_ozone=wo(:, :, 1) * dobson_u * 1e3 / zmasse
    46724751                 print*,'Dans physiq.F avant appel '
     
    47214800
    47224801    IF (type_trac=='repr') THEN
     4802!MM pas d'impact, car on recupere q_seri,tr_seri,t_seri via phys_local_var_mod
     4803!MM                               dans Reprobus
    47234804       sh_in(:,:) = q_seri(:,:)
     4805#ifdef REPROBUS
     4806       d_q_rep(:,:) = 0.
     4807       d_ql_rep(:,:) = 0.
     4808       d_qi_rep(:,:) = 0.
     4809#endif
    47244810    ELSE
    47254811       sh_in(:,:) = qx(:,:,ivap)
     
    47274813    ENDIF
    47284814
    4729     IF (iflag_phytrac == 1 ) THEN
    4730 
    47314815#ifdef CPP_Dust
    4732       CALL       phytracr_spl ( debut,lafin , jD_cur,jH_cur,iflag_con,       &  ! I
     4816    !  Avec SPLA, iflag_phytrac est forcé =1
     4817    CALL       phytracr_spl ( debut,lafin , jD_cur,jH_cur,iflag_con,       &  ! I
    47334818                      pdtphys,ftsol,                                   &  ! I
    47344819                      t,q_seri,paprs,pplay,RHcl,                  &  ! I
     
    47464831
    47474832#else
    4748 
    4749     CALL phytrac ( &
     4833    IF (iflag_phytrac == 1 ) THEN
     4834      CALL phytrac ( &
    47504835         itap,     days_elapsed+1,    jH_cur,   debut, &
    47514836         lafin,    phys_tstep,     u, v,     t, &
     
    47714856         d_tr_dyn, &                                 !<<RomP
    47724857         tr_seri, init_source)
     4858#ifdef REPROBUS
     4859
     4860
     4861          print*,'avt add phys rep',abortphy
     4862
     4863     CALL add_phys_tend &
     4864            (du0,dv0,dt0,d_q_rep,d_ql_rep,d_qi_rep,paprs,&
     4865             'rep',abortphy,flag_inhib_tend,itap,0)
     4866        IF (abortphy==1) Print*,'ERROR ABORT REP'
     4867
     4868          print*,'apr add phys rep',abortphy
     4869
    47734870#endif
    47744871    ENDIF    ! (iflag_phytrac=1)
     4872
     4873#endif
     4874    !ENDIF    ! (iflag_phytrac=1)
    47754875
    47764876    IF (offline) THEN
     
    48664966            pphis, &
    48674967            zx_rh, &
    4868             aps, bps)
     4968            aps, bps, ap, bp)
    48694969
    48704970       CALL VTe(VTinca)
     
    50725172  CALL phys_output_write_spl(itap, pdtphys, paprs, pphis,  &
    50735173       pplay, lmax_th, aerosol_couple,                 &
    5074        ok_ade, ok_aie, ivap, new_aod, ok_sync,         &
     5174       ok_ade, ok_aie, ivap, ok_sync,                  &
    50755175       ptconv, read_climoz, clevSTD,                   &
    50765176       ptconvth, d_t, qx, d_qx, d_tr_dyn, zmasse,      &
     
    50795179    CALL phys_output_write(itap, pdtphys, paprs, pphis,  &
    50805180         pplay, lmax_th, aerosol_couple,                 &
    5081          ok_ade, ok_aie, ok_volcan, ivap, iliq, isol, new_aod,      &
     5181         ok_ade, ok_aie, ok_volcan, ivap, iliq, isol,    &
    50825182         ok_sync, ptconv, read_climoz, clevSTD,          &
    50835183         ptconvth, d_u, d_t, qx, d_qx, zmasse,           &
     
    50915191#endif
    50925192
    5093 ! On remet des variables a .false. apres un premier appel
     5193! Pour XIOS : On remet des variables a .false. apres un premier appel
    50945194    IF (debut) THEN
    50955195#ifdef CPP_XIOS
Note: See TracChangeset for help on using the changeset viewer.