Ignore:
Timestamp:
Sep 29, 2016, 11:26:46 PM (9 years ago)
Author:
Laurent Fairhead
Message:

Merged trunk changes r2593:2640 into testing branch

Location:
LMDZ5/branches/testing
Files:
2 deleted
27 edited
2 copied

Legend:

Unmodified
Added
Removed
  • LMDZ5/branches/testing

  • LMDZ5/branches/testing/libf/dyn3d/addfi.F

    r1999 r2641  
    4646c    ------------------
    4747c
    48 #include "dimensions.h"
    49 #include "paramet.h"
    50 #include "comconst.h"
    51 #include "comgeom.h"
    52 #include "serre.h"
     48      include "dimensions.h"
     49      include "paramet.h"
     50      include "comgeom.h"
    5351c
    5452c    Arguments :
  • LMDZ5/branches/testing/libf/dyn3d/advect.F

    r1910 r2641  
    44      SUBROUTINE advect(ucov,vcov,teta,w,massebx,masseby,du,dv,dteta)
    55
     6      USE comconst_mod, ONLY: daysec
     7      USE logic_mod, ONLY: conser
     8      USE ener_mod, ONLY: gtot
     9     
    610      IMPLICIT NONE
    711c=======================================================================
     
    2428c   -------------
    2529
    26 #include "dimensions.h"
    27 #include "paramet.h"
    28 #include "comconst.h"
    29 #include "comvert.h"
    30 #include "comgeom.h"
    31 #include "logic.h"
    32 #include "ener.h"
     30      include "dimensions.h"
     31      include "paramet.h"
     32      include "comgeom.h"
    3333
    3434c   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/advtrac.F90

    r2298 r2641  
    1111  USE infotrac, ONLY: nqtot, iadv,nqperes,ok_iso_verif
    1212  USE control_mod, ONLY: iapp_tracvl, day_step
    13 
     13  USE comconst_mod, ONLY: dtvr
    1414
    1515  IMPLICIT NONE
     
    1717  include "dimensions.h"
    1818  include "paramet.h"
    19   include "comconst.h"
    20   include "comvert.h"
    2119  include "comdissip.h"
    2220  include "comgeom2.h"
    23   include "logic.h"
    24   include "temps.h"
    25   include "ener.h"
    2621  include "description.h"
    2722  include "iniprint.h"
  • LMDZ5/branches/testing/libf/dyn3d/bilan_dyn.F

    r1910 r2641  
    1313      USE IOIPSL
    1414#endif
     15      USE comconst_mod, ONLY: pi, cpp
     16      USE comvert_mod, ONLY: presnivs
     17      USE temps_mod, ONLY: annee_ref, day_ref, itau_dyn
    1518
    1619      IMPLICIT NONE
    1720
    18 #include "dimensions.h"
    19 #include "paramet.h"
    20 #include "comconst.h"
    21 #include "comvert.h"
    22 #include "comgeom2.h"
    23 #include "temps.h"
    24 #include "iniprint.h"
     21      include "dimensions.h"
     22      include "paramet.h"
     23      include "comgeom2.h"
     24      include "iniprint.h"
    2525
    2626c====================================================================
  • LMDZ5/branches/testing/libf/dyn3d/caladvtrac.F

    r2298 r2641  
    1010      USE infotrac, ONLY : nqtot
    1111      USE control_mod, ONLY : iapp_tracvl,planet_type
     12      USE comconst_mod, ONLY: dtvr
    1213 
    1314      IMPLICIT NONE
     
    2324
    2425
    25 #include "dimensions.h"
    26 #include "paramet.h"
    27 #include "comconst.h"
     26      include "dimensions.h"
     27      include "paramet.h"
    2828
    2929c   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/caldyn.F

    r1999 r2641  
    66     $  phi,conser,du,dv,dteta,dp,w,pbaru,pbarv,time )
    77
     8     
     9      USE comvert_mod, ONLY: ap, bp
     10     
    811      IMPLICIT NONE
    912
     
    2427!   ----------------
    2528
    26 #include "dimensions.h"
    27 #include "paramet.h"
    28 #include "comconst.h"
    29 #include "comvert.h"
    30 #include "comgeom.h"
     29      include "dimensions.h"
     30      include "paramet.h"
     31      include "comgeom.h"
    3132
    3233!   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/conf_gcm.F90

    r2471 r2641  
    1313  USE infotrac, ONLY : type_trac
    1414  use assert_m, only: assert
     15  USE comconst_mod, ONLY: dissip_deltaz, dissip_factz, dissip_zref, &
     16                          iflag_top_bound, mode_top_bound, tau_top_bound, &
     17                          ngroup
     18  USE logic_mod, ONLY: fxyhypb, iflag_phys, ok_etat0, ok_gradsfile, &
     19                       ok_guide, ok_limit, ok_strato, purmats, read_start, &
     20                       ysinus
     21  USE serre_mod, ONLY: clon,clat,grossismx,grossismy,dzoomx,dzoomy, &
     22                       alphax,alphay,taux,tauy
     23  USE temps_mod, ONLY: calend
    1524
    1625  IMPLICIT NONE
     
    3140  include "dimensions.h"
    3241  include "paramet.h"
    33   include "logic.h"
    34   include "serre.h"
    3542  include "comdissnew.h"
    36   include "temps.h"
    37   include "comconst.h"
    3843  include "iniprint.h"
    3944
     
    4146  !   ------
    4247
    43   CHARACTER ch1*72,ch2*72,ch3*72,ch4*12
    4448  REAL clonn,clatt,grossismxx,grossismyy
    4549  REAL dzoomxx,dzoomyy, tauxx,tauyy
    4650  LOGICAL  fxyhypbb, ysinuss
    47   INTEGER i
    4851
    4952  !  -------------------------------------------------------------------
  • LMDZ5/branches/testing/libf/dyn3d/dissip.F

    r1999 r2641  
    44      SUBROUTINE dissip( vcov,ucov,teta,p, dv,du,dh )
    55c
     6      USE comconst_mod, ONLY: dtdiss
     7     
    68      IMPLICIT NONE
    79
     
    2527c   -------------
    2628
    27 #include "dimensions.h"
    28 #include "paramet.h"
    29 #include "comconst.h"
    30 #include "comgeom.h"
    31 #include "comdissnew.h"
    32 #include "comdissipn.h"
     29      include "dimensions.h"
     30      include "paramet.h"
     31      include "comgeom.h"
     32      include "comdissnew.h"
     33      include "comdissipn.h"
    3334
    3435c   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/dteta1.F

    r1910 r2641  
    2121
    2222
    23 #include "dimensions.h"
    24 #include "paramet.h"
    25 #include "logic.h"
     23      include "dimensions.h"
     24      include "paramet.h"
    2625
    2726      REAL teta( ip1jmp1,llm ),pbaru( ip1jmp1,llm ),pbarv( ip1jm,llm)
  • LMDZ5/branches/testing/libf/dyn3d/dudv2.F

    r1910 r2641  
    2626c=======================================================================
    2727c
    28 #include "dimensions.h"
    29 #include "paramet.h"
    30 #include "comvert.h"
     28      include "dimensions.h"
     29      include "paramet.h"
    3130
    3231      REAL teta( ip1jmp1,llm ),pkf( ip1jmp1,llm ) ,bern( ip1jmp1,llm ),
  • LMDZ5/branches/testing/libf/dyn3d/dynetat0.f90

    r2408 r2641  
    1111  USE control_mod, ONLY: planet_type
    1212  USE assert_eq_m, ONLY: assert_eq
     13  USE comvert_mod, ONLY: pa,preff
     14  USE comconst_mod, ONLY: cpp, daysec, dtvr, g, im, jm, kappa, lllm, omeg, rad
     15  USE logic_mod, ONLY: fxyhypb, ysinus
     16  USE serre_mod, ONLY: clon, clat, grossismx, grossismy
     17  USE temps_mod, ONLY: annee_ref, day_ini, day_ref, itau_dyn, start_time
     18  USE ener_mod, ONLY: etot0,ptot0,ztot0,stot0,ang0
     19
    1320  IMPLICIT NONE
    1421  include "dimensions.h"
    1522  include "paramet.h"
    16   include "temps.h"
    17   include "comconst.h"
    18   include "comvert.h"
    1923  include "comgeom2.h"
    20   include "ener.h"
    2124  include "description.h"
    22   include "serre.h"
    23   include "logic.h"
    2425  include "iniprint.h"
    2526!===============================================================================
  • LMDZ5/branches/testing/libf/dyn3d/dynredem.F90

    r2408 r2641  
    1111                    NF90_CLOSE,  NF90_PUT_ATT, NF90_UNLIMITED, NF90_CLOBBER
    1212  USE dynredem_mod, ONLY: cre_var, put_var1, put_var2, err, modname, fil
     13  USE comvert_mod, ONLY: ap,bp,aps,bps,presnivs,pseudoalt,pa,preff, &
     14                              nivsig,nivsigs
     15  USE comconst_mod, ONLY: cpp, daysec, dtvr, g, kappa, omeg, rad
     16  USE logic_mod, ONLY: fxyhypb, ysinus
     17  USE serre_mod, ONLY: clon,clat,grossismx,grossismy,dzoomx,dzoomy, &
     18                              taux,tauy
     19  USE temps_mod, ONLY: annee_ref, day_ref, itau_dyn, itaufin, start_time
     20  USE ener_mod, ONLY: etot0,ptot0,ztot0,stot0,ang0
     21 
    1322  IMPLICIT NONE
    1423  include "dimensions.h"
    1524  include "paramet.h"
    16   include "comconst.h"
    17   include "comvert.h"
    1825  include "comgeom2.h"
    19   include "temps.h"
    20   include "ener.h"
    21   include "logic.h"
    2226  include "description.h"
    23   include "serre.h"
    2427  include "iniprint.h"
    2528!===============================================================================
     
    168171  USE dynredem_mod, ONLY: dynredem_write_u, dynredem_write_v, dynredem_read_u, &
    169172                          err, modname, fil, msg
     173  USE temps_mod, ONLY: itau_dyn, itaufin
     174 
    170175  IMPLICIT NONE
    171176  include "dimensions.h"
    172177  include "paramet.h"
    173178  include "description.h"
    174   include "comvert.h"
    175179  include "comgeom.h"
    176   include "temps.h"
    177180  include "iniprint.h"
    178181!===============================================================================
  • LMDZ5/branches/testing/libf/dyn3d/fluxstokenc.F

    r2298 r2641  
    1616      IMPLICIT NONE
    1717c
    18 #include "dimensions.h"
    19 #include "paramet.h"
    20 #include "comconst.h"
    21 #include "comvert.h"
    22 #include "comgeom.h"
    23 #include "tracstoke.h"
    24 #include "temps.h"
    25 #include "iniprint.h"
     18      include "dimensions.h"
     19      include "paramet.h"
     20      include "comgeom.h"
     21      include "tracstoke.h"
     22      include "iniprint.h"
    2623
    2724      REAL time_step,t_wrt, t_ops
     
    3633
    3734      REAL pbarvst(iip1,jjp1,llm),zistdyn
    38         real dtcum
     35        real dtcum
    3936
    4037      INTEGER iadvtr,ndex(1)
     
    6057      if(first) then
    6158
    62         CALL initfluxsto( 'fluxstoke',
     59        CALL initfluxsto( 'fluxstoke',
    6360     .  time_step,istdyn* time_step,istdyn* time_step,
    6461     .  fluxid,fluxvid,fluxdid)
    65        
    66         ndex(1) = 0
     62       
     63        ndex(1) = 0
    6764        call histwrite(fluxid, 'phis', 1, phis, iip1*jjp1, ndex)
    6865        call histwrite(fluxid, 'aire', 1, aire, iip1*jjp1, ndex)
    69        
    70         ndex(1) = 0
     66       
     67        ndex(1) = 0
    7168        nscal = 1
    7269        tst(1) = time_step
     
    7673        istp(1)= istphy
    7774        call histwrite(fluxdid, 'istphy', 1, istp, nscal, ndex)
    78        
    79         first = .false.
     75       
     76        first = .false.
    8077
    8178      endif
     
    141138
    142139         iadvtr=0
    143         write(lunout,*)'ITAU auquel on stoke les fluxmasses',itau
    144        
    145         call histwrite(fluxid, 'masse', itau, massem,
     140        write(lunout,*)'ITAU auquel on stoke les fluxmasses',itau
     141       
     142        call histwrite(fluxid, 'masse', itau, massem,
    146143     .               iip1*jjp1*llm, ndex)
    147        
    148         call histwrite(fluxid, 'pbaru', itau, pbarug,
     144       
     145        call histwrite(fluxid, 'pbaru', itau, pbarug,
    149146     .               iip1*jjp1*llm, ndex)
    150        
    151         call histwrite(fluxvid, 'pbarv', itau, pbarvg,
     147       
     148        call histwrite(fluxvid, 'pbarv', itau, pbarvg,
    152149     .               iip1*jjm*llm, ndex)
    153        
     150       
    154151        call histwrite(fluxid, 'w' ,itau, wg,
    155152     .             iip1*jjp1*llm, ndex)
    156        
    157         call histwrite(fluxid, 'teta' ,itau, tetac,
     153       
     154        call histwrite(fluxid, 'teta' ,itau, tetac,
    158155     .             iip1*jjp1*llm, ndex)
    159        
    160         call histwrite(fluxid, 'phi' ,itau, phic,
     156       
     157        call histwrite(fluxid, 'phi' ,itau, phic,
    161158     .             iip1*jjp1*llm, ndex)
    162        
     159       
    163160C
    164161
  • LMDZ5/branches/testing/libf/dyn3d/friction.F

    r1910 r2641  
    1212      USE ioipsl_getincom
    1313#endif
    14      
     14      USE comconst_mod, ONLY: pi
    1515      IMPLICIT NONE
    1616
     
    2727!=======================================================================
    2828
    29 #include "dimensions.h"
    30 #include "paramet.h"
    31 #include "comgeom2.h"
    32 #include "comconst.h"
    33 #include "iniprint.h"
    34 #include "academic.h"
     29      include "dimensions.h"
     30      include "paramet.h"
     31      include "comgeom2.h"
     32      include "iniprint.h"
     33      include "academic.h"
    3534
    3635! arguments:
  • LMDZ5/branches/testing/libf/dyn3d/gcm.F90

    r2471 r2641  
    2323  USE control_mod
    2424  USE mod_const_mpi, ONLY: COMM_LMDZ
    25 
     25  USE temps_mod, ONLY: calend,start_time,annee_ref,day_ref, &
     26                     itau_dyn,itau_phy,day_ini,jD_ref,jH_ref,day_end
     27  USE comconst_mod, ONLY: cpp, daysec, dtphys, dtvr, g, r, rad
     28  USE logic_mod, ONLY: ecripar, iflag_phys, read_start
    2629
    2730!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
     
    6871  include "dimensions.h"
    6972  include "paramet.h"
    70   include "comconst.h"
    7173  include "comdissnew.h"
    72   include "comvert.h"
    7374  include "comgeom.h"
    74   include "logic.h"
    75   include "temps.h"
    76 !!!!!!!!!!!include "control.h"
    77   include "ener.h"
    7875  include "description.h"
    79   include "serre.h"
    80   !include "com_io_dyn.h"
    8176  include "iniprint.h"
    8277  include "tracstoke.h"
     
    8984  REAL, ALLOCATABLE, DIMENSION(:,:,:):: q! champs advectes
    9085  REAL ps(ip1jmp1)                       ! pression  au sol
    91   REAL p (ip1jmp1,llmp1  )               ! pression aux interfac.des couches
     86!  REAL p (ip1jmp1,llmp1  )               ! pression aux interfac.des couches
    9287  REAL masse(ip1jmp1,llm)                ! masse d'air
    9388  REAL phis(ip1jmp1)                     ! geopotentiel au sol
    94   REAL phi(ip1jmp1,llm)                  ! geopotentiel
    95   REAL w(ip1jmp1,llm)                    ! vitesse verticale
     89!  REAL phi(ip1jmp1,llm)                  ! geopotentiel
     90!  REAL w(ip1jmp1,llm)                    ! vitesse verticale
    9691
    9792  ! variables dynamiques intermediaire pour le transport
     
    10398
    10499  LOGICAL lafin
    105   INTEGER ij,iq,l,i,j
    106100
    107101
    108102  real time_step, t_wrt, t_ops
    109 
    110   LOGICAL first
    111103
    112104  !      LOGICAL call_iniphys
     
    118110  !     tansformation d'energie cinetique en energie thermique
    119111  !     cree par la dissipation
    120   REAL dhecdt(ip1jmp1,llm)
     112!  REAL dhecdt(ip1jmp1,llm)
    121113  !      REAL vcont(ip1jm,llm),ucont(ip1jmp1,llm)
    122114  !      REAL      d_h_vcol, d_qt, d_qw, d_ql, d_ec
    123   CHARACTER (len=15) :: ztit
     115!  CHARACTER (len=15) :: ztit
    124116  !-jld
    125117
  • LMDZ5/branches/testing/libf/dyn3d/groupe.F

    r2471 r2641  
    33!
    44      subroutine groupe(pext,pbaru,pbarv,pbarum,pbarvm,wm)
     5     
     6      use comconst_mod, only: ngroup
     7     
    58      implicit none
    69
     
    1619c   pas besoin de w en entree.
    1720
    18 #include "dimensions.h"
    19 #include "paramet.h"
    20 #include "comconst.h"
    21 #include "comgeom2.h"
    22 #include "comvert.h"
     21      include "dimensions.h"
     22      include "paramet.h"
     23      include "comgeom2.h"
    2324
    2425!     integer ngroup
  • LMDZ5/branches/testing/libf/dyn3d/groupeun.F

    r2471 r2641  
    33!
    44      SUBROUTINE groupeun(jjmax,llmax,q)
     5     
     6      USE comconst_mod, ONLY: ngroup
     7     
    58      IMPLICIT NONE
    69
    7 #include "dimensions.h"
    8 #include "paramet.h"
    9 #include "comconst.h"
    10 #include "comgeom2.h"
     10      include "dimensions.h"
     11      include "paramet.h"
     12      include "comgeom2.h"
    1113
    1214      INTEGER jjmax,llmax
     
    135137     
    136138      SUBROUTINE INIT_GROUPEUN(airen_tab, aires_tab)
     139     
     140      USE comconst_mod, ONLY: ngroup
     141     
    137142      IMPLICIT NONE
    138143
    139 #include "dimensions.h"
    140 #include "paramet.h"
    141 #include "comconst.h"
    142 #include "comgeom2.h"
     144      include "dimensions.h"
     145      include "paramet.h"
     146      include "comgeom2.h"
    143147
    144148!     INTEGER ngroup
  • LMDZ5/branches/testing/libf/dyn3d/guide_mod.F90

    r2298 r2641  
    6363  SUBROUTINE guide_init
    6464
    65     USE control_mod
     65    USE control_mod, ONLY: day_step
     66    USE serre_mod, ONLY: grossismx
    6667
    6768    IMPLICIT NONE
     
    7071    INCLUDE "paramet.h"
    7172    INCLUDE "netcdf.inc"
    72 
    73     ! For grossismx:
    74     include "serre.h"
    7573
    7674    INTEGER                :: error,ncidpl,rid,rcod
     
    314312  SUBROUTINE guide_main(itau,ucov,vcov,teta,q,masse,ps)
    315313
    316     USE control_mod
     314    USE control_mod, ONLY: day_step, iperiod
     315    USE comconst_mod, ONLY: dtvr, daysec
     316    USE comvert_mod, ONLY: ap, bp, preff, presnivs
    317317 
    318318    IMPLICIT NONE
     
    320320    INCLUDE "dimensions.h"
    321321    INCLUDE "paramet.h"
    322     INCLUDE "comconst.h"
    323     INCLUDE "comvert.h"
    324322
    325323    ! Variables entree
     
    542540  SUBROUTINE guide_zonave(typ,hsize,vsize,field)
    543541
     542    USE comconst_mod, ONLY: pi
     543   
    544544    IMPLICIT NONE
    545545
     
    547547    INCLUDE "paramet.h"
    548548    INCLUDE "comgeom.h"
    549     INCLUDE "comconst.h"
    550549   
    551550    ! input/output variables
     
    607606  use exner_hyb_m, only: exner_hyb
    608607  use exner_milieu_m, only: exner_milieu
     608  use comconst_mod, only: kappa, cpp
     609  use comvert_mod, only: preff, pressure_exner, bp, ap
    609610  IMPLICIT NONE
    610611
    611612  include "dimensions.h"
    612613  include "paramet.h"
    613   include "comvert.h"
    614614  include "comgeom2.h"
    615   include "comconst.h"
    616615
    617616  REAL, DIMENSION (iip1,jjp1),     INTENT(IN) :: psi ! Psol gcm
     
    777776            do j=1,jjp1
    778777                IF (guide_teta) THEN
    779                     do i=1,iim
    780                         ij=(j-1)*iip1+i
    781                         tgui1(ij,l)=zu1(i,j,l)
    782                         tgui2(ij,l)=zu2(i,j,l)
    783                     enddo
     778                    do i=1,iim
     779                        ij=(j-1)*iip1+i
     780                        tgui1(ij,l)=zu1(i,j,l)
     781                        tgui2(ij,l)=zu2(i,j,l)
     782                    enddo
    784783                ELSE
    785                     do i=1,iim
    786                         ij=(j-1)*iip1+i
    787                         tgui1(ij,l)=zu1(i,j,l)*cpp/pk(i,j,l)
    788                         tgui2(ij,l)=zu2(i,j,l)*cpp/pk(i,j,l)
    789                     enddo
     784                    do i=1,iim
     785                        ij=(j-1)*iip1+i
     786                        tgui1(ij,l)=zu1(i,j,l)*cpp/pk(i,j,l)
     787                        tgui2(ij,l)=zu2(i,j,l)*cpp/pk(i,j,l)
     788                    enddo
    790789                ENDIF
    791790                tgui1(j*iip1,l)=tgui1((j-1)*iip1+1,l)   
     
    855854! Calcul des constantes de rappel alpha (=1/tau)
    856855
     856    use comconst_mod, only: pi
     857    use serre_mod, only: clon, clat, grossismx, grossismy
     858   
    857859    implicit none
    858860
    859861    include "dimensions.h"
    860862    include "paramet.h"
    861     include "comconst.h"
    862863    include "comgeom2.h"
    863     include "serre.h"
    864864
    865865! input arguments :
     
    15161516  SUBROUTINE guide_out(varname,hsize,vsize,field)
    15171517
     1518    USE comconst_mod, ONLY: pi
     1519    USE comvert_mod, ONLY: presnivs
     1520   
    15181521    IMPLICIT NONE
    15191522
     
    15221525    INCLUDE "netcdf.inc"
    15231526    INCLUDE "comgeom2.h"
    1524     INCLUDE "comconst.h"
    1525     INCLUDE "comvert.h"
    15261527   
    15271528    ! Variables entree
  • LMDZ5/branches/testing/libf/dyn3d/iniacademic.F90

    r2298 r2641  
    1616  use exner_hyb_m, only: exner_hyb
    1717  use exner_milieu_m, only: exner_milieu
     18  USE comconst_mod, ONLY: cpp, kappa, g, daysec, dtvr, pi, im, jm
     19  USE logic_mod, ONLY: iflag_phys, read_start
     20  USE comvert_mod, ONLY: ap, bp, preff, presnivs, pressure_exner
     21  USE temps_mod, ONLY: annee_ref, day_ini, day_ref
     22  USE ener_mod, ONLY: etot0,ptot0,ztot0,stot0,ang0
    1823
    1924  !   Author:    Frederic Hourdin      original: 15/01/93
     
    2833  include "dimensions.h"
    2934  include "paramet.h"
    30   include "comvert.h"
    31   include "comconst.h"
    3235  include "comgeom.h"
    3336  include "academic.h"
    34   include "ener.h"
    35   include "temps.h"
    3637  include "iniprint.h"
    37   include "logic.h"
    3838
    3939  !   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/integrd.F

    r2160 r2641  
    88
    99      use control_mod, only : planet_type
     10      use comconst_mod, only: pi
     11      USE logic_mod, ONLY: leapf
     12      use comvert_mod, only: ap, bp
     13      USE temps_mod, ONLY: dt
    1014
    1115      IMPLICIT NONE
     
    2731c   -------------
    2832
    29 #include "dimensions.h"
    30 #include "paramet.h"
    31 #include "comconst.h"
    32 #include "comgeom.h"
    33 #include "comvert.h"
    34 #include "logic.h"
    35 #include "temps.h"
    36 #include "serre.h"
    37 #include "iniprint.h"
     33      include "dimensions.h"
     34      include "paramet.h"
     35      include "comgeom.h"
     36      include "iniprint.h"
    3837
    3938c   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/leapfrog.F

    r2488 r2641  
    2020      use exner_hyb_m, only: exner_hyb
    2121      use exner_milieu_m, only: exner_milieu
     22      USE comvert_mod, ONLY: ap,bp,pressure_exner,presnivs
     23      USE comconst_mod, ONLY: cpp, dtphys, dtvr, pi, ihf
     24      USE logic_mod, ONLY: iflag_phys,ok_guide,forward,leapf,apphys,
     25     &                     statcl,conser,apdiss,purmats,ok_strato
     26      USE temps_mod, ONLY: jD_ref,jH_ref,itaufin,day_ini,day_ref,
     27     &                        start_time,dt
    2228
    2329      IMPLICIT NONE
     
    5460c   -------------
    5561
    56 #include "dimensions.h"
    57 #include "paramet.h"
    58 #include "comconst.h"
    59 #include "comdissnew.h"
    60 #include "comvert.h"
    61 #include "comgeom.h"
    62 #include "logic.h"
    63 #include "temps.h"
    64 #include "ener.h"
    65 #include "description.h"
    66 #include "serre.h"
    67 !#include "com_io_dyn.h"
    68 #include "iniprint.h"
    69 #include "academic.h"
     62      include "dimensions.h"
     63      include "paramet.h"
     64      include "comdissnew.h"
     65      include "comgeom.h"
     66      include "description.h"
     67      include "iniprint.h"
     68      include "academic.h"
    7069
    7170      REAL,INTENT(IN) :: time_0 ! not used
     
    714713            IF( MOD(itau,iecri).EQ.0) THEN
    715714             ! Ehouarn: output only during LF or Backward Matsuno
    716              if (leapf.or.(.not.leapf.and.(.not.forward))) then
     715             if (leapf.or.(.not.leapf.and.(.not.forward))) then
    717716              CALL geopot(ip1jmp1,teta,pk,pks,phis,phi)
    718717              unat=0.
     
    724723              if (ok_dyn_ins) then
    725724!               write(lunout,*) "leapfrog: call writehist, itau=",itau
    726                CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
     725               CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
    727726!               call WriteField('ucov',reshape(ucov,(/iip1,jmp1,llm/)))
    728727!               call WriteField('vcov',reshape(vcov,(/iip1,jjm,llm/)))
     
    854853!                write(lunout,*) "leapfrog: call writehist (b)",
    855854!     &                        itau,iecri
    856                 CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
     855                CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
    857856              endif ! of if (ok_dyn_ins)
    858857#endif
  • LMDZ5/branches/testing/libf/dyn3d/qminimum.F

    r2298 r2641  
    1010c             pour l'eau vapeur et l'eau liquide
    1111c
    12 #include "dimensions.h"
    13 #include "paramet.h"
    14 #include "comvert.h"
     12      include "dimensions.h"
     13      include "paramet.h"
    1514c
    1615      INTEGER nqtot
  • LMDZ5/branches/testing/libf/dyn3d/sw_case_williamson91_6.F

    r1910 r2641  
    2626c
    2727c=======================================================================
     28      USE comconst_mod, ONLY: cpp, omeg, rad
     29      USE comvert_mod, ONLY: ap, bp, preff
     30     
    2831      IMPLICIT NONE
    2932c-----------------------------------------------------------------------
     
    3134c   ---------------
    3235
    33 #include "dimensions.h"
    34 #include "paramet.h"
    35 #include "comvert.h"
    36 #include "comconst.h"
    37 #include "comgeom.h"
    38 #include "iniprint.h"
     36      include "dimensions.h"
     37      include "paramet.h"
     38      include "comgeom.h"
     39      include "iniprint.h"
    3940
    4041c   Arguments:
  • LMDZ5/branches/testing/libf/dyn3d/top_bound.F

    r1910 r2641  
    33!
    44      SUBROUTINE top_bound(vcov,ucov,teta,masse,dt)
     5     
     6      USE comconst_mod, ONLY: iflag_top_bound, mode_top_bound,
     7     &                        tau_top_bound
     8      USE comvert_mod, ONLY: presnivs, preff, scaleheight
     9     
    510      IMPLICIT NONE
    611c
    7 #include "dimensions.h"
    8 #include "paramet.h"
    9 #include "comconst.h"
    10 #include "comvert.h"
    11 #include "comgeom2.h"
     12      include "dimensions.h"
     13      include "paramet.h"
     14      include "comgeom2.h"
    1215
    1316
     
    3942! NB: top_bound sponge is only called from leapfrog if ok_strato=.true.
    4043
    41 ! sponge parameters: (loaded/set in conf_gcm.F ; stored in comconst.h)
     44! sponge parameters: (loaded/set in conf_gcm.F ; stored in comconst_mod)
    4245!    iflag_top_bound=0 for no sponge
    4346!    iflag_top_bound=1 for sponge over 4 topmost layers
  • LMDZ5/branches/testing/libf/dyn3d/vlsplt.F

    r2298 r2641  
    2121      IMPLICIT NONE
    2222c
    23 #include "dimensions.h"
    24 #include "paramet.h"
    25 #include "logic.h"
    26 #include "comvert.h"
    27 #include "comconst.h"
     23      include "dimensions.h"
     24      include "paramet.h"
    2825
    2926c
     
    157154      include "dimensions.h"
    158155      include "paramet.h"
    159       include "logic.h"
    160       include "comvert.h"
    161       include "comconst.h"
    162156      include "iniprint.h"
    163157c
     
    528522c
    529523c   --------------------------------------------------------------------
     524      USE comconst_mod, ONLY: pi
    530525      IMPLICIT NONE
    531526c
    532 #include "dimensions.h"
    533 #include "paramet.h"
    534 #include "logic.h"
    535 #include "comvert.h"
    536 #include "comconst.h"
    537 #include "comgeom.h"
     527      include "dimensions.h"
     528      include "paramet.h"
     529      include "comgeom.h"
    538530c
    539531c
     
    893885      IMPLICIT NONE
    894886c
    895 #include "dimensions.h"
    896 #include "paramet.h"
    897 #include "logic.h"
    898 #include "comvert.h"
    899 #include "comconst.h"
     887      include "dimensions.h"
     888      include "paramet.h"
    900889c
    901890c
  • LMDZ5/branches/testing/libf/dyn3d/vlspltqs.F

    r2298 r2641  
    2323c     pk exner au milieu des couches necessaire pour calculer Qsat
    2424c   --------------------------------------------------------------------
     25     
     26      USE comconst_mod, ONLY: cpp
     27     
    2528      IMPLICIT NONE
    2629c
    27 #include "dimensions.h"
    28 #include "paramet.h"
    29 #include "logic.h"
    30 #include "comvert.h"
    31 #include "comconst.h"
     30      include "dimensions.h"
     31      include "paramet.h"
    3232
    3333c
     
    192192      IMPLICIT NONE
    193193c
    194 #include "dimensions.h"
    195 #include "paramet.h"
    196 #include "logic.h"
    197 #include "comvert.h"
    198 #include "comconst.h"
     194      include "dimensions.h"
     195      include "paramet.h"
    199196c
    200197c
     
    559556c
    560557c   --------------------------------------------------------------------
     558     
     559      USE comconst_mod, ONLY: pi
     560     
    561561      IMPLICIT NONE
    562562c
    563 #include "dimensions.h"
    564 #include "paramet.h"
    565 #include "logic.h"
    566 #include "comvert.h"
    567 #include "comconst.h"
    568 #include "comgeom.h"
     563      include "dimensions.h"
     564      include "paramet.h"
     565      include "comgeom.h"
    569566c
    570567c
Note: See TracChangeset for help on using the changeset viewer.