Ignore:
Timestamp:
Dec 14, 2015, 11:43:09 AM (9 years ago)
Author:
Laurent Fairhead
Message:

Merged trunk changes r2298:2396 into testing branch

Location:
LMDZ5/branches/testing
Files:
10 deleted
7 edited
6 copied

Legend:

Unmodified
Added
Removed
  • LMDZ5/branches/testing

  • LMDZ5/branches/testing/libf/phylmd/dyn1d/1DUTILS.h

    r2298 r2408  
    11#include "conf_gcm.F90"
    2 #include "q_sat.F"
    32
    43!
     
    1514      use ioipsl_getincom
    1615#endif
     16      USE print_control_mod, ONLY: lunout
    1717      IMPLICIT NONE
    1818!-----------------------------------------------------------------------
     
    2727#include "fcg_gcssold.h"
    2828#include "fcg_racmo.h"
    29 #include "iniprint.h"
    3029!
    3130!
  • LMDZ5/branches/testing/libf/phylmd/dyn1d/1D_decl_cases.h

    r2298 r2408  
    5151        real dth_rico(llm)
    5252        real dqh_rico(llm)
    53         real du_age(llm),dv_age(llm)
    5453!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    5554! Declarations specifiques au cas TWPice
     
    251250        real hu_mod_cas(llm),vu_mod_cas(llm),du_mod_cas(llm)
    252251        real hv_mod_cas(llm),vv_mod_cas(llm),dv_mod_cas(llm)
    253 !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    254 
     252        integer day_ini_cas
     253!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
     254
  • LMDZ5/branches/testing/libf/phylmd/dyn1d/1D_interp_cases.h

    • Property svn:keywords set to Id
    r2298 r2408  
     1!
     2! $Id$
     3!
    14!---------------------------------------------------------------------
    25! Interpolation forcing in time and onto model levels
     
    610613
    611614! time interpolation:
    612         CALL interp_case_time(daytime,day1,annee_ref                        &
    613      &       ,year_ini_cas,day_ju_ini_cas,nt_cas,pdt_cas,nlev_cas       &
    614      &       ,ts_cas,plev_cas,t_cas,q_cas,u_cas,v_cas,ug_cas,vg_cas    &
    615      &       ,vitw_cas,du_cas,hu_cas,vu_cas           &
    616      &       ,dv_cas,hv_cas,vv_cas,dt_cas,ht_cas,vt_cas,dtrad_cas             &
    617      &       ,dq_cas,hq_cas,vq_cas,lat_cas,sens_cas                 &
     615        CALL interp_case_time(daytime,day1,annee_ref                                        &
     616!    &       ,year_ini_cas,day_ju_ini_cas,nt_cas,pdt_cas,nlev_cas                           &
     617     &       ,nt_cas,nlev_cas                                                               &
     618     &       ,ts_cas,plev_cas,t_cas,q_cas,u_cas,v_cas,ug_cas,vg_cas                         &
     619     &       ,vitw_cas,du_cas,hu_cas,vu_cas                                                 &
     620     &       ,dv_cas,hv_cas,vv_cas,dt_cas,ht_cas,vt_cas,dtrad_cas                           &
     621     &       ,dq_cas,hq_cas,vq_cas,lat_cas,sens_cas,ustar_cas                               &
     622     &       ,uw_cas,vw_cas,q1_cas,q2_cas                                                   &
    618623     &       ,ts_prof_cas,plev_prof_cas,t_prof_cas,q_prof_cas,u_prof_cas,v_prof_cas         &
    619624     &       ,ug_prof_cas,vg_prof_cas,vitw_prof_cas,du_prof_cas,hu_prof_cas,vu_prof_cas     &
    620625     &       ,dv_prof_cas,hv_prof_cas,vv_prof_cas,dt_prof_cas,ht_prof_cas,vt_prof_cas       &
    621626     &       ,dtrad_prof_cas,dq_prof_cas,hq_prof_cas,vq_prof_cas,lat_prof_cas               &
    622      &       ,sens_prof_cas)
     627     &       ,sens_prof_cas,ustar_prof_cas,uw_prof_cas,vw_prof_cas,q1_prof_cas,q2_prof_cas)
    623628
    624629             ts_cur = ts_prof_cas
     
    746751        if (tend_rayo.eq.1) then
    747752           dt_cooling(l) = dtrad_mod_cas(l)
     753!          print *,'dt_cooling=',dt_cooling(l)
    748754        else
    749755           dt_cooling(l) = 0.0
  • LMDZ5/branches/testing/libf/phylmd/dyn1d/1D_read_forc_cases.h

    • Property svn:keywords set to Id
    r2298 r2408  
     1!
     2! $Id$
     3!
    14!----------------------------------------------------------------------
    25! forcing_les = .T. : Impose a constant cooling
     
    323326      write(*,*) 'SST initiale mxcalc: ',tsurf,mxcalc
    324327      do l = 1, llm
    325 ! Ligne du dessous à decommenter si on lit theta au lieu de temp
     328! Ligne du dessous ?? decommenter si on lit theta au lieu de temp
    326329!      temp(l) = t_mod(l)*(play(l)/pzero)**rkappa
    327330       temp(l) = t_mod(l)
     
    407410     &         ,ht_mod,hq_mod,hu_mod,hv_mod,w_mod,omega_mod,mxcalc)
    408411
    409 ! Pour tester les advections horizontales de T et Q, on met w_mod et omega_mod à zero (MPL 20131108)
     412! Pour tester les advections horizontales de T et Q, on met w_mod et omega_mod ?? zero (MPL 20131108)
    410413!     w_mod(:,:)=0.
    411414!     omega_mod(:,:)=0.
     
    421424      write(*,*) 'SST initiale mxcalc: ',tsurf,mxcalc
    422425      do l = 1, llm
    423 ! Ligne du dessous à decommenter si on lit theta au lieu de temp
     426! Ligne du dessous ?? decommenter si on lit theta au lieu de temp
    424427       temp(l) = th_mod(l)*(play(l)/pzero)**rkappa
    425428!      temp(l) = t_mod(l)
     
    733736!Time interpolation for initial conditions using TOGA interpolation routine
    734737         write(*,*) 'AVT 1ere INTERPOLATION: day,day1 = ',daytime,day1   
    735       CALL interp_case_time(day,day1,annee_ref                &
    736      &         ,year_ini_cas,day_ju_ini_cas,nt_cas,pdt_cas,nlev_cas       &
    737      &         ,ts_cas,plev_cas,t_cas,q_cas,u_cas,v_cas               &
    738      &         ,ug_cas,vg_cas,vitw_cas,du_cas,hu_cas,vu_cas           &
    739      &         ,dv_cas,hv_cas,vv_cas,dt_cas,ht_cas,vt_cas,dtrad_cas             &
    740      &         ,dq_cas,hq_cas,vq_cas,lat_cas,sens_cas                 &
    741      &         ,ts_prof_cas,plev_prof_cas,t_prof_cas,q_prof_cas,u_prof_cas,v_prof_cas         &
    742      &         ,ug_prof_cas,vg_prof_cas,vitw_prof_cas,du_prof_cas,hu_prof_cas,vu_prof_cas     &
    743      &         ,dv_prof_cas,hv_prof_cas,vv_prof_cas,dt_prof_cas,ht_prof_cas,vt_prof_cas,dtrad_prof_cas       &
    744      &         ,dq_prof_cas,hq_prof_cas,vq_prof_cas,lat_prof_cas,sens_prof_cas)
     738      CALL interp_case_time(day,day1,annee_ref                                                              &
     739!    &         ,year_ini_cas,day_ju_ini_cas,nt_cas,pdt_cas,nlev_cas                                         &
     740     &         ,nt_cas,nlev_cas                                                                             &
     741     &         ,ts_cas,plev_cas,t_cas,q_cas,u_cas,v_cas                                                     &
     742     &         ,ug_cas,vg_cas,vitw_cas,du_cas,hu_cas,vu_cas                                                 &
     743     &         ,dv_cas,hv_cas,vv_cas,dt_cas,ht_cas,vt_cas,dtrad_cas                                         &
     744     &         ,dq_cas,hq_cas,vq_cas,lat_cas,sens_cas,ustar_cas                                             &
     745     &         ,uw_cas,vw_cas,q1_cas,q2_cas                                                                 &
     746     &         ,ts_prof_cas,plev_prof_cas,t_prof_cas,q_prof_cas,u_prof_cas,v_prof_cas                       &
     747     &         ,ug_prof_cas,vg_prof_cas,vitw_prof_cas,du_prof_cas,hu_prof_cas,vu_prof_cas                   &
     748     &         ,dv_prof_cas,hv_prof_cas,vv_prof_cas,dt_prof_cas,ht_prof_cas,vt_prof_cas,dtrad_prof_cas      &
     749     &         ,dq_prof_cas,hq_prof_cas,vq_prof_cas,lat_prof_cas,sens_prof_cas,ustar_prof_cas               &
     750     &         ,uw_prof_cas,vw_prof_cas,q1_prof_cas,q2_prof_cas)
    745751
    746752! vertical interpolation using TOGA interpolation routine:
     
    778784       d_u_adv(l) = (hv_mod_cas(l)+vv_mod_cas(l))
    779785      enddo     
    780        
     786
     787! In case fluxes are imposed
     788       IF (ok_flux_surf) THEN
     789       fsens=sens_prof_cas
     790       flat=lat_prof_cas
     791       ENDIF
     792       IF (ok_prescr_ust) THEN
     793       ust=ustar_prof_cas
     794       print *,'ust=',ust
     795       ENDIF
     796
    781797      endif !forcing_case
    782798!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
  • LMDZ5/branches/testing/libf/phylmd/dyn1d/1Dconv.h

    • Property svn:keywords set to Id
    r2298 r2408  
     1!
     2! $Id$
     3!
    14        subroutine get_uvd(itap,dtime,file_forctl,file_fordat,                  &
    25     &       ht,hq,hw,hu,hv,hthturb,hqturb,                                     &
  • LMDZ5/branches/testing/libf/phylmd/dyn1d/lmdz1d.F90

    r2298 r2408  
    88      PROGRAM lmdz1d
    99
    10       USE ioipsl, only: ju2ymds, ymds2ju, ioconf_calendar
    11       use phys_state_var_mod
    12       use dimphy
    13       use surface_data, only : type_ocean,ok_veget
    14       use pbl_surface_mod, only : ftsoil, pbl_surface_init,                     &
     10   USE ioipsl, only: ju2ymds, ymds2ju, ioconf_calendar
     11   USE phys_state_var_mod, ONLY : phys_state_var_init, phys_state_var_end, &
     12       clwcon, detr_therm, &
     13       qsol, fevap, z0m, z0h, agesno, &
     14       du_gwd_rando, du_gwd_front, entr_therm, f0, fm_therm, &
     15       falb_dir, falb_dif, &
     16       ftsol, pbl_tke, pctsrf, radsol, rain_fall, snow_fall, ratqs, &
     17       rlat, rlon, rnebcon, rugoro, sig1, w01, solaire_etat0, sollw, sollwdown, &
     18       solsw, t_ancien, q_ancien, u_ancien, v_ancien, wake_cstar, wake_deltaq, &
     19       wake_deltat, wake_delta_pbl_TKE, delta_tsurf, wake_fip, wake_pe, &
     20       wake_s, zgam, &
     21       zmax0, zmea, zpic, zsig, &
     22       zstd, zthe, zval, ale_bl, ale_bl_trig, alp_bl
     23   use dimphy
     24   use surface_data, only : type_ocean,ok_veget
     25   use pbl_surface_mod, only : ftsoil, pbl_surface_init,                     &
    1526     &                            pbl_surface_final
    1627      use fonte_neige_mod, only : fonte_neige_init, fonte_neige_final
    1728
    18       use infotrac ! new
    19       use control_mod
    20       USE indice_sol_mod
    21       USE phyaqua_mod
    22       USE mod_1D_cases_read
    23       USE mod_1D_amma_read
     29   use infotrac ! new
     30   use control_mod
     31   USE indice_sol_mod
     32   USE phyaqua_mod
     33   USE mod_1D_cases_read
     34   USE mod_1D_amma_read
     35   USE print_control_mod, ONLY: prt_level
     36   USE iniphysiq_mod, ONLY: iniphysiq
     37   USE mod_const_mpi, ONLY: comm_lmdz
    2438
    2539      implicit none
     
    2842#include "temps.h"
    2943!!#include "control.h"
    30 #include "iniprint.h"
    3144#include "clesphys.h"
    3245#include "dimsoil.h"
     
    3649#include "compar1d.h"
    3750#include "flux_arp.h"
     51#include "date_cas.h"
    3852#include "tsoilnudge.h"
    3953#include "fcg_gcssold.h"
     
    124138!vertical advection computation
    125139!       real d_t_z(llm), d_q_z(llm)
    126 !       real d_t_dyn_z(llm), d_q_dyn_z(llm)
     140!       real d_t_dyn_z(llm), dq_dyn_z(llm)
    127141!       real zz(llm)
    128142!       real zfact
     
    164178      real :: phi(llm)
    165179      real :: teta(llm),tetal(llm),temp(llm),u(llm),v(llm),w(llm)
     180      REAL rot(1, llm) ! relative vorticity, in s-1
    166181      real :: rlat_rad(1),rlon_rad(1)
    167182      real :: omega(llm+1),omega2(llm),rho(llm+1)
     
    173188      real :: d_u_nudge(llm),d_v_nudge(llm)
    174189      real :: du_adv(llm),dv_adv(llm)
     190      real :: du_age(llm),dv_age(llm)
    175191      real :: alpha
    176192      real :: ttt
     
    237253! INITIALIZATIONS
    238254!=====================================================================
     255      du_phys(:)=0.
     256      dv_phys(:)=0.
     257      dt_phys(:)=0.
     258      dt_dyn(:)=0.
     259      dt_cooling(:)=0.
     260      d_th_adv(:)=0.
     261      d_t_nudge(:)=0.
     262      d_u_nudge(:)=0.
     263      d_v_nudge(:)=0.
     264      du_adv(:)=0.
     265      dv_adv(:)=0.
     266      du_age(:)=0.
     267      dv_age(:)=0.
     268     
    239269! Initialization of Common turb_forcing
    240270       dtime_frcg = 0.
     
    284314!             Different stages: soil model alone, atm. model alone
    285315!             then both models coupled
    286 !forcing_type = 10 ==> forcing_case = .true.
     316!forcing_type >= 100 ==> forcing_case = .true.
    287317!             initial profiles and large scale forcings in cas.nc
    288318!             LS convergence, omega and SST imposed from CINDY-DYNAMO files
     319!             101=cindynamo
     320!             102=bomex
    289321!forcing_type = 40 ==> forcing_GCSSold = .true.
    290322!             initial profile from GCSS file
     
    323355      elseif (forcing_type .eq.7) THEN
    324356       forcing_dice = .true.
    325       elseif (forcing_type .eq.10) THEN
     357      elseif (forcing_type .eq.101) THEN ! Cindynamo starts 1-10-2011 0h
    326358       forcing_case = .true.
     359       year_ini_cas=2011
     360       mth_ini_cas=10
     361       day_deb=1
     362       heure_ini_cas=0.
     363       pdt_cas=3*3600.         ! forcing frequency
     364      elseif (forcing_type .eq.102) THEN ! Bomex starts 24-6-1969 0h
     365       forcing_case = .true.
     366       year_ini_cas=1969
     367       mth_ini_cas=6
     368       day_deb=24
     369       heure_ini_cas=0.
     370       pdt_cas=1800.         ! forcing frequency
    327371      elseif (forcing_type .eq.40) THEN
    328372       forcing_GCSSold = .true.
     
    396440         fnday=-nday/float(day_step)
    397441      endif
     442      print *,'fnday=',fnday
    398443
    399444! Special case for arm_cu which lasts less than one day : 53100s !! (MPL 20111026)
     
    432477     & (year_ini_dice,mth_ini_dice,day_ini_dice,heure_ini_dice             &
    433478     & ,day_ju_ini_dice)
    434       ELSEIF (forcing_type .eq.10) THEN
     479      ELSEIF (forcing_type .gt.100) THEN
    435480! Convert the initial date to Julian day
    436       print*,'time cindy',year_ini_cas,mth_ini_cas,day_ini_cas
     481      day_ini_cas=day_deb
     482      print*,'time case',year_ini_cas,mth_ini_cas,day_ini_cas
    437483      call ymds2ju                                                         &
    438      & (year_ini_cas,mth_ini_cas,day_ini_cas,heure_ini_cas &
     484     & (year_ini_cas,mth_ini_cas,day_ini_cas,heure_ini_cas              &
    439485     & ,day_ju_ini_cas)
    440       print*,'time cindy 2',day_ju_ini_cas
     486      print*,'time case 2',day_ini_cas,day_ju_ini_cas
    441487      ELSEIF (forcing_type .eq.59) THEN
    442488! Convert the initial date of Sandu case to Julian day
     
    467513! Initialization of dimensions, geometry and initial state
    468514!---------------------------------------------------------------------
    469       call init_phys_lmdz(1,1,llm,1,(/1/))
     515!      call init_phys_lmdz(1,1,llm,1,(/1/)) ! job now done via iniphysiq
     516!     but we still need to initialize dimphy module (klon,klev,etc.)  here.
     517      call init_dimphy(1,llm)
    470518      call suphel
    471519      call infotrac_init
     
    478526      allocate(d_q_nudge(llm,nqtot))
    479527!      allocate(d_th_adv(llm))
     528
     529      q(:,:) = 0.
     530      dq(:,:) = 0.
     531      dq_dyn(:,:) = 0.
     532      d_q_adv(:,:) = 0.
     533      d_q_nudge(:,:) = 0.
    480534
    481535!
     
    540594!       Dans ce cas, on lit ap,bp dans le fichier hybrid.txt
    541595      ENDIF
     596      ! initialize ap,bp, etc. in vertical_layers_mod
    542597      sig_s=presnivs/preff
    543598      plev =ap+bp*psurf
    544599      play = 0.5*(plev(1:llm)+plev(2:llm+1))
    545 !cc      zlay=-rd*300.*log(play/psurf)/rg ! moved after reading profiles
     600      zlay=-rd*300.*log(play/psurf)/rg ! moved after reading profiles
    546601
    547602      IF (forcing_type .eq. 59) THEN
     
    572627
    573628      print*,'mxcalc=',mxcalc
    574       print*,'zlay=',zlay(mxcalc)
     629!     print*,'zlay=',zlay(mxcalc)
    575630      print*,'play=',play(mxcalc)
    576631
    577 !Al1 pour SST forced, appellé depuis ocean_forced_noice
     632!Al1 pour SST forced, appell?? depuis ocean_forced_noice
    578633      ts_cur = tsurf ! SST used in read_tsurf1d
    579634!=====================================================================
     
    600655      zcvfi=airefi
    601656!
    602       rlat_rad(:)=rlat(:)*rpi/180.
    603       rlon_rad(:)=rlon(:)*rpi/180.
    604 
    605       call iniphysiq(iim,jjm,llm,rday,day_ini,timestep,                        &
    606      &     rlat_rad,rlon_rad,airefi,zcufi,zcvfi,ra,rg,rd,rcpd,(/1/))
     657      rlat_rad(1)=rlat(1)*rpi/180.
     658      rlon_rad(1)=rlon(1)*rpi/180.
     659
     660     ! Ehouarn: iniphysiq requires arrays related to (3D) dynamics grid,
     661     ! e.g. for cell boundaries, which are meaningless in 1D; so pad these
     662     ! with '0.' when necessary
     663      call iniphysiq(iim,jjm,llm, &
     664           1,comm_lmdz, &
     665           rday,day_ini,timestep,  &
     666           (/rlat_rad(1),0./),(/0./), &
     667           (/0.,0./),(/rlon_rad(1),0./),  &
     668           (/ (/airefi,0./),(/0.,0./) /), &
     669           (/zcufi,0.,0.,0./), &
     670           (/zcvfi,0./), &
     671           ra,rg,rd,rcpd,1)
    607672      print*,'apres iniphysiq'
    608673
     
    682747        solsw=0.
    683748        sollw=0.
     749        sollwdown=rsigma*tsurf**4
    684750        radsol=0.
    685751        rnebcon=0.
    686752        ratqs=0.
    687753        clwcon=0.
     754        zmax0 = 0.
    688755        zmea=0.
    689756        zstd=0.
     
    694761        sig1=0.
    695762        w01=0.
     763        wake_cstar = 0.
     764        wake_deltaq = 0.
     765        wake_deltat = 0.
     766        wake_delta_pbl_TKE = 0.
     767        delta_tsurf = 0.
     768        wake_fip = 0.
     769        wake_pe = 0.
     770        wake_s = 0.
     771        ale_bl = 0.
     772        ale_bl_trig = 0.
     773        alp_bl = 0.
     774        IF (ALLOCATED(du_gwd_rando)) du_gwd_rando = 0.
     775        IF (ALLOCATED(du_gwd_front)) du_gwd_front = 0.
     776        entr_therm = 0.
     777        detr_therm = 0.
     778        f0 = 0.
     779        fm_therm = 0.
    696780        u_ancien(1,:)=u(:)
    697781        v_ancien(1,:)=v(:)
     
    704788! pctsrf(:,is_sic),ftsol(:,nsrf),tsoil(:,isoil,nsrf),qsurf(:,nsrf)
    705789! qsol,falb_dir(:,nsrf),falb_dif(:,nsrf),evap(:,nsrf),snow(:,nsrf)
    706 ! radsol,solsw,sollw,fder,rain_fall,snow_fall,frugs(:,nsrf)
     790! radsol,solsw,sollw, sollwdown,fder,rain_fall,snow_fall,frugs(:,nsrf)
    707791! agesno(:,nsrf),zmea,zstd,zsig,zgam,zthe,zpic,zval,rugoro
    708792! t_ancien,q_ancien,,frugs(:,is_oce),clwcon(:,1),rnebcon(:,1),ratqs(:,1)
     
    805889       if (prt_level.ge.1) then
    806890         print*,'XXXXXXXXXXXXXXXXXXX ITAP,day,time=',                       &
    807      &                                it,day,time,nint(fnday*day_step)
     891     &             it,day,time,nint(fnday*day_step),day_step
    808892         print*,'PAS DE TEMPS ',timestep
    809893       endif
     
    853937!---------------------------------------------------------------------
    854938
    855         call physiq(ngrid,llm,                                              &
    856      &              firstcall,lastcall,                                     &
    857      &              day,time,timestep,                                      &
    858      &              plev,play,phi,phis,presnivs,                            &
    859      &              u,v,temp,q,omega2,                                      &
    860      &              du_phys,dv_phys,dt_phys,dq,dpsrf,                        &
    861      &              dudyn)
     939       call physiq(ngrid,llm, &
     940            firstcall,lastcall, day,time,timestep, &
     941            plev,play,phi,phis,presnivs, &
     942            u,v, rot, temp,q,omega2, &
     943            du_phys,dv_phys,dt_phys,dq,dpsrf, &
     944            dudyn)
    862945        firstcall=.false.
    863946
     
    892975         d_q_adv=0.0
    893976       endif
     977!      print*, 'calcul de fcoriolis ', fcoriolis
    894978
    895979       if (forcing_toga .or. forcing_GCSSold .or. forcing_twpice            &
     
    901985        endif
    902986
    903       print*, 'fcoriolis ', fcoriolis, xlat
    904 
    905         du_age(1:mxcalc)=fcoriolis*(v(1:mxcalc)-vg(1:mxcalc))
     987      IF (prt_level >= 1) print*, 'fcoriolis, xlat,mxcalc ', &
     988                                   fcoriolis, xlat,mxcalc
     989
     990       du_age(1:mxcalc)=fcoriolis*(v(1:mxcalc)-vg(1:mxcalc))
    906991       dv_age(1:mxcalc)=-fcoriolis*(u(1:mxcalc)-ug(1:mxcalc))
     992!       print *,'u-ug=',u-ug
    907993
    908994!!!!!!!!!!!!!!!!!!!!!!!!
     
    911997       sfdt = sin(0.5*fcoriolis*timestep)
    912998       cfdt = cos(0.5*fcoriolis*timestep)
     999!       print *,'fcoriolis,sfdt,cfdt,timestep',fcoriolis,sfdt,cfdt,timestep
    9131000!
    9141001        du_age(1:mxcalc)= -2.*sfdt/timestep*                                &
     
    9701057     &    'physiq-> temp(1),dt_phys(1),d_th_adv(1),dt_cooling(1) ',         &
    9711058     &              temp(1),dt_phys(1),d_th_adv(1),dt_cooling(1)
    972            print*,du_phys
     1059           print* ,'dv_phys=',dv_phys
     1060           print* ,'dv_age=',dv_age
     1061           print* ,'dv_adv=',dv_adv
     1062           print* ,'d_v_nudge=',d_v_nudge
    9731063           print*, v
    9741064           print*, vg
Note: See TracChangeset for help on using the changeset viewer.