Changeset 5281


Ignore:
Timestamp:
Oct 28, 2024, 11:17:48 AM (8 weeks ago)
Author:
abarral
Message:

Turn comgeom.h comgeom2.h into modules

Location:
LMDZ6/trunk/libf
Files:
149 edited
4 moved

Legend:

Unmodified
Added
Removed
  • LMDZ6/trunk/libf/dyn3d/addfi.f90

    r5272 r5281  
    1111  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    1212          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     13  USE comgeom_mod_h
    1314  IMPLICIT NONE
    1415  !
     
    4546  !
    4647  !-----------------------------------------------------------------------
    47   !
    48   !    0.  Declarations :
    49   !    ------------------
    50   !
    51   include "comgeom.h"
    5248  !
    5349  !    Arguments :
  • LMDZ6/trunk/libf/dyn3d/advect.f90

    r5272 r5281  
    33!
    44SUBROUTINE advect(ucov,vcov,teta,w,massebx,masseby,du,dv,dteta)
     5  USE comgeom_mod_h
    56  USE comconst_mod, ONLY: daysec
    67  USE logic_mod, ONLY: conser
     
    2829  !   Declarations:
    2930  !   -------------
    30   include "comgeom.h"
    3131
    3232  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d/advtrac.f90

    r5280 r5281  
    99   !            M.A Filiberti (04/2002)
    1010   !
     11   USE comgeom2_mod_h
    1112   USE comdissip_mod_h
    1213   USE infotrac,     ONLY: nqtot, tracers, isoCheck
     
    2223
    2324
    24    include "comgeom2.h"
    2525   include "description.h"
    2626   include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/bilan_dyn.f90

    r5272 r5281  
    1010  !             vQ..A=Cp T + L * ...
    1111
     12  USE comgeom2_mod_h
    1213  USE IOIPSL
    1314  USE comconst_mod, ONLY: pi, cpp
     
    2223
    2324
    24   include "comgeom2.h"
    2525  include "iniprint.h"
    2626
  • LMDZ6/trunk/libf/dyn3d/caldyn.f90

    r5272 r5281  
    77
    88
     9  USE comgeom_mod_h
    910  USE comvert_mod, ONLY: ap, bp
    1011
     
    3233
    3334
    34   include "comgeom.h"
    3535
    3636  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d/covnat.F90

    r5272 r5281  
    33!
    44SUBROUTINE covnat (klevel,ucov, vcov, unat, vnat )
     5  USE comgeom_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2122  !
    2223  !=======================================================================
    23   INCLUDE "comgeom.h"
    2424
    2525  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3d/dissip.f90

    r5280 r5281  
    44SUBROUTINE dissip( vcov,ucov,teta,p, dv,du,dh )
    55  !
     6  USE comgeom_mod_h
    67  USE comdissipn_mod_h
    78  USE comdissnew_mod_h
     
    3435
    3536
    36   include "comgeom.h"
    3737
    3838  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d/dynetat0.f90

    r5272 r5281  
    66! Purpose: Initial state reading.
    77!-------------------------------------------------------------------------------
     8  USE comgeom2_mod_h
    89  USE infotrac,    ONLY: nqtot, tracers, niso, iqIsoPha, iH2O, isoName, &
    910                         new2oldH2O, newHNO3, oldHNO3
     
    3031
    3132
    32   include "comgeom2.h"
    3333  include "description.h"
    3434  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/dynredem.f90

    r5272 r5281  
    1818  USE temps_mod, ONLY: annee_ref, day_ref, itau_dyn, itaufin, start_time
    1919  USE ener_mod, ONLY: etot0,ptot0,ztot0,stot0,ang0
    20  
     20
    2121  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    22 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     22  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    2323          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     24  USE comgeom2_mod_h
    2425IMPLICIT NONE
    2526
    2627
    27   include "comgeom2.h"
    2828  include "description.h"
    2929  include "iniprint.h"
     
    3131! Arguments:
    3232  CHARACTER(LEN=*), INTENT(IN) :: fichnom          !--- FILE NAME
    33   INTEGER,          INTENT(IN) :: iday_end         !--- 
     33  INTEGER,          INTENT(IN) :: iday_end         !---
    3434  REAL,             INTENT(IN) :: phis(iip1, jjp1) !--- GROUND GEOPOTENTIAL
    3535!===============================================================================
     
    7272  tab_cntrl(19) = preff
    7373
    74 !    .....    parameters for zoom    ......   
     74!    .....    parameters for zoom    ......
    7575  tab_cntrl(20) = clon
    7676  tab_cntrl(21) = clat
     
    169169                          err, modname, fil, msg
    170170  USE temps_mod, ONLY: itau_dyn, itaufin
    171  
     171
    172172  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    173 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     173  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    174174          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     175  USE comgeom_mod_h
    175176IMPLICIT NONE
    176177
    177178
    178179  include "description.h"
    179   include "comgeom.h"
    180180  include "iniprint.h"
    181181!===============================================================================
  • LMDZ6/trunk/libf/dyn3d/fluxstokenc.f90

    r5272 r5281  
    66  ! This routine is designed to work with ioipsl
    77
    8    USE IOIPSL
     8   USE comgeom_mod_h
     9  USE IOIPSL
    910  !
    1011  ! Auteur :  F. Hourdin
     
    2021
    2122
    22   include "comgeom.h"
    2323  include "tracstoke.h"
    2424  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/friction.f90

    r5272 r5281  
    44!=======================================================================
    55SUBROUTINE friction(ucov,vcov,pdt)
     6  USE comgeom2_mod_h
    67  USE control_mod
    78  USE IOIPSL
     
    2526
    2627
    27   include "comgeom2.h"
    2828  include "iniprint.h"
    2929  include "academic.h"
  • LMDZ6/trunk/libf/dyn3d/gcm.f90

    r5280 r5281  
    55!
    66PROGRAM gcm
     7  USE comgeom_mod_h
    78  USE comdissnew_mod_h
    89  USE IOIPSL
     
    5758  !   Declarations:
    5859  !   -------------
    59   include "comgeom.h"
    6060  include "description.h"
    6161  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/groupe.f90

    r5272 r5281  
    44subroutine groupe(pext,pbaru,pbarv,pbarum,pbarvm,wm)
    55
     6  USE comgeom2_mod_h
    67  use comconst_mod, only: ngroup
    78
     
    2425
    2526
    26   include "comgeom2.h"
    2727
    2828  ! integer ngroup
  • LMDZ6/trunk/libf/dyn3d/groupeun.f90

    r5272 r5281  
    44SUBROUTINE groupeun(jjmax,llmax,q)
    55
     6  USE comgeom2_mod_h
    67  USE comconst_mod, ONLY: ngroup
    78
     
    1314
    1415
    15   include "comgeom2.h"
    1616
    1717  INTEGER :: jjmax,llmax
     
    141141SUBROUTINE INIT_GROUPEUN(airen_tab, aires_tab)
    142142
     143  USE comgeom2_mod_h
    143144  USE comconst_mod, ONLY: ngroup
    144145
     
    150151
    151152
    152   include "comgeom2.h"
    153153
    154154  ! INTEGER ngroup
  • LMDZ6/trunk/libf/dyn3d/guide_mod.f90

    r5272 r5281  
    88!            F. Codron 01/09
    99!=======================================================================
    10 
    11   USE getparam, only: ini_getparam, fin_getparam, getpar
     10    USE getparam, only: ini_getparam, fin_getparam, getpar
    1211  USE Write_Field
    1312  use netcdf, only: nf90_nowrite, nf90_open, nf90_inq_varid, nf90_close, &
     
    9291
    9392! ---------------------------------------------
    94 ! Lecture des parametres: 
     93! Lecture des parametres:
    9594! ---------------------------------------------
    9695    call ini_getparam("nudging_parameters_out.txt")
     
    172171
    173172    call fin_getparam
    174    
     173
    175174! ---------------------------------------------
    176175! Determination du nombre de niveaux verticaux
     
    230229
    231230
    232     endif 
     231    endif
    233232    error=nf90_inq_dimid(ncidpl,'LEVEL',rid)
    234233    IF (error.NE.NF90_NOERR) error=nf90_inq_dimid(ncidpl,'PRESSURE',rid)
     
    237236    ENDIF
    238237    error=nf90_inquire_dimension(ncidpl,rid,len=nlevnc)
    239     write(*,*)trim(modname)//' : number of vertical levels nlevnc', nlevnc 
     238    write(*,*)trim(modname)//' : number of vertical levels nlevnc', nlevnc
    240239    rcod = nf90_close(ncidpl)
    241240
     
    264263    IF (error /= 0) CALL abort_gcm(modname,abort_message,1)
    265264    alpha_u=0.;alpha_v=0;alpha_T=0;alpha_Q=0;alpha_P=0
    266    
     265
    267266    IF (guide_u) THEN
    268267        ALLOCATE(unat1(iip1,jjp1,nlevnc), stat = error)
     
    288287        tnat1=0.;tnat2=0.;tgui1=0.;tgui2=0.
    289288    ENDIF
    290      
     289
    291290    IF (guide_Q) THEN
    292291        ALLOCATE(qnat1(iip1,jjp1,nlevnc), stat = error)
     
    361360    USE comconst_mod, ONLY: cpp, dtvr, daysec,kappa
    362361    USE comvert_mod, ONLY: ap, bp, preff, presnivs, pressure_exner
    363  
     362
    364363    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    365364USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    391390    REAL          :: tau,reste ! position entre 2 etats de guidage
    392391    REAL, SAVE    :: factt ! pas de temps en fraction de jour
    393    
     392
    394393    INTEGER       :: l
    395394    CHARACTER(LEN=20) :: modname="guide_main"
     
    402401    IF (first) THEN
    403402        first=.FALSE.
    404         CALL guide_init 
     403        CALL guide_init
    405404        itau_test=1001
    406405        step_rea=1
    407406        count_no_rea=0
    408407! Calcul des constantes de rappel
    409         factt=dtvr*iperiod/daysec 
     408        factt=dtvr*iperiod/daysec
    410409        call tau2alpha(3,iip1,jjm ,factt,tau_min_v,tau_max_v,alpha_v)
    411410        call tau2alpha(2,iip1,jjp1,factt,tau_min_u,tau_max_u,alpha_u)
     
    421420            enddo
    422421        endif
    423 ! ini_anal: etat initial egal au guidage       
     422! ini_anal: etat initial egal au guidage
    424423        IF (ini_anal) THEN
    425424            CALL guide_interp(ps,teta)
     
    464463            itau
    465464              abort_message='stopped'
    466               CALL abort_gcm(modname,abort_message,1) 
     465              CALL abort_gcm(modname,abort_message,1)
    467466          ELSE
    468467              IF (guide_v) vnat1=vnat2
     
    503502
    504503!-----------------------------------------------------------------------
    505 !   Ajout des champs de guidage 
     504!   Ajout des champs de guidage
    506505!-----------------------------------------------------------------------
    507506! Sauvegarde du guidage?
    508     f_out=((MOD(itau,iguide_sav).EQ.0).AND.guide_sav) 
     507    f_out=((MOD(itau,iguide_sav).EQ.0).AND.guide_sav)
    509508    IF (f_out) THEN
    510509      ! compute pressures at layer interfaces
     
    522521      CALL guide_out("SP",jjp1,llm,p(:,1:llm))
    523522    ENDIF
    524    
     523
    525524    if (guide_u) then
    526525        if (guide_add) then
     
    528527        else
    529528           f_add=(1.-tau)*ugui1+tau*ugui2-ucov
    530         endif 
     529        endif
    531530        if (guide_zon) CALL guide_zonave(1,jjp1,llm,f_add)
    532531        CALL guide_addfield(ip1jmp1,llm,f_add,alpha_u)
     
    542541        else
    543542           f_add=(1.-tau)*tgui1+tau*tgui2-teta
    544         endif 
     543        endif
    545544        if (guide_zon) CALL guide_zonave(2,jjp1,llm,f_add)
    546545        CALL guide_addfield(ip1jmp1,llm,f_add,alpha_T)
     
    554553        else
    555554           f_add(1:ip1jmp1,1)=(1.-tau)*psgui1+tau*psgui2-ps
    556         endif 
     555        endif
    557556        if (guide_zon) CALL guide_zonave(2,jjp1,1,f_add(1:ip1jmp1,1))
    558557        CALL guide_addfield(ip1jmp1,1,f_add(1:ip1jmp1,1),alpha_P)
     
    568567        else
    569568           f_add=(1.-tau)*qgui1+tau*qgui2-q
    570         endif 
     569        endif
    571570        if (guide_zon) CALL guide_zonave(2,jjp1,llm,f_add)
    572571        CALL guide_addfield(ip1jmp1,llm,f_add,alpha_Q)
     
    580579        else
    581580           f_add(1:ip1jm,:)=(1.-tau)*vgui1+tau*vgui2-vcov
    582         endif 
     581        endif
    583582        if (guide_zon) CALL guide_zonave(2,jjm,llm,f_add(1:ip1jm,:))
    584583        CALL guide_addfield(ip1jm,llm,f_add(1:ip1jm,:),alpha_v)
     
    599598    INTEGER,                      INTENT(IN)    :: hsize
    600599    INTEGER,                      INTENT(IN)    :: vsize
    601     REAL, DIMENSION(hsize),       INTENT(IN)    :: alpha 
     600    REAL, DIMENSION(hsize),       INTENT(IN)    :: alpha
    602601    REAL, DIMENSION(hsize,vsize), INTENT(INOUT) :: field
    603602
     
    615614
    616615    USE comconst_mod, ONLY: pi
    617    
     616
    618617    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    619618USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    620619          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     620    USE comgeom_mod_h
    621621IMPLICIT NONE
    622622
    623623
    624624
    625     INCLUDE "comgeom.h"
    626    
     625
    627626    ! input/output variables
    628627    INTEGER,                           INTENT(IN)    :: typ
     
    665664                fieldm(j,l)=fieldm(j,l)+field(ij,l)
    666665            ENDDO
    667         ENDDO 
     666        ENDDO
    668667        fieldm(:,l)=fieldm(:,l)/REAL(imax(typ)-imin(typ)+1)
    669668    ! Compute forcing
     
    680679!=======================================================================
    681680  SUBROUTINE guide_interp(psi,teta)
    682  
     681
    683682  use exner_hyb_m, only: exner_hyb
    684683  use exner_milieu_m, only: exner_milieu
     
    686685  use comvert_mod, only: preff, pressure_exner, bp, ap
    687686  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    688 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     687  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    689688          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     689  USE comgeom2_mod_h
    690690IMPLICIT NONE
    691 
    692 
    693 
    694   include "comgeom2.h"
    695 
    696691  REAL, DIMENSION (iip1,jjp1),     INTENT(IN) :: psi ! Psol gcm
    697692  REAL, DIMENSION (iip1,jjp1,llm), INTENT(IN) :: teta ! Temp. Pot. gcm
     
    702697  REAL, DIMENSION (iip1,jjp1,llm)    :: plunc,plsnc !niveaux pression modele
    703698  REAL, DIMENSION (iip1,jjm,llm)     :: plvnc       !niveaux pression modele
    704   REAL, DIMENSION (iip1,jjp1,llmp1)  :: p           ! pression intercouches 
     699  REAL, DIMENSION (iip1,jjp1,llmp1)  :: p           ! pression intercouches
    705700  REAL, DIMENSION (iip1,jjp1,llm)    :: pls, pext   ! var intermediaire
    706   REAL, DIMENSION (iip1,jjp1,llm)    :: pbarx 
    707   REAL, DIMENSION (iip1,jjm,llm)     :: pbary 
     701  REAL, DIMENSION (iip1,jjp1,llm)    :: pbarx
     702  REAL, DIMENSION (iip1,jjm,llm)     :: pbary
    708703  ! Variables pour fonction Exner (P milieu couche)
    709704  REAL, DIMENSION (iip1,jjp1,llm)    :: pk
    710   REAL, DIMENSION (iip1,jjp1)        :: pks   
     705  REAL, DIMENSION (iip1,jjp1)        :: pks
    711706  REAL                               :: prefkap,unskap
    712707  ! Pression de vapeur saturante
    713708  REAL, DIMENSION (ip1jmp1,llm)      :: qsat
    714709  !Variables intermediaires interpolation
    715   REAL, DIMENSION (iip1,jjp1,llm)    :: zu1,zu2 
     710  REAL, DIMENSION (iip1,jjp1,llm)    :: zu1,zu2
    716711  REAL, DIMENSION (iip1,jjm,llm)     :: zv1,zv2
    717  
     712
    718713  INTEGER                            :: i,j,l,ij
    719714  CHARACTER(LEN=20),PARAMETER :: modname="guide_interp"
    720  
     715
    721716    write(*,*)trim(modname)//': interpolate nudging variables'
    722717! -----------------------------------------------------------------
     
    767762        endif
    768763    endif
    769    
     764
    770765! -----------------------------------------------------------------
    771 ! Calcul niveaux pression modele 
     766! Calcul niveaux pression modele
    772767! -----------------------------------------------------------------
    773768    CALL pression( ip1jmp1, ap, bp, psi, p )
     
    839834                    ugui2(ij,l)=zu2(i,j,l)*cu(i,j)
    840835                enddo
    841                 ugui1(j*iip1,l)=ugui1((j-1)*iip1+1,l)   
    842                 ugui2(j*iip1,l)=ugui2((j-1)*iip1+1,l)   
     836                ugui1(j*iip1,l)=ugui1((j-1)*iip1+1,l)
     837                ugui2(j*iip1,l)=ugui2((j-1)*iip1+1,l)
    843838            enddo
    844839            do i=1,iip1
     
    850845        enddo
    851846    ENDIF
    852    
     847
    853848    IF (guide_T) THEN
    854849        CALL pres2lev(tnat1,zu1,nlevnc,llm,plnc1,plsnc,iip1,jjp1,invert_p)
     
    869864                    enddo
    870865                ENDIF
    871                 tgui1(j*iip1,l)=tgui1((j-1)*iip1+1,l)   
    872                 tgui2(j*iip1,l)=tgui2((j-1)*iip1+1,l)   
     866                tgui1(j*iip1,l)=tgui1((j-1)*iip1+1,l)
     867                tgui2(j*iip1,l)=tgui2((j-1)*iip1+1,l)
    873868            enddo
    874869            do i=1,iip1
    875870                tgui1(i,l)=tgui1(1,l)
    876                 tgui1(ip1jm+i,l)=tgui1(ip1jm+1,l) 
     871                tgui1(ip1jm+i,l)=tgui1(ip1jm+1,l)
    877872                tgui2(i,l)=tgui2(1,l)
    878                 tgui2(ip1jm+i,l)=tgui2(ip1jm+1,l) 
     873                tgui2(ip1jm+i,l)=tgui2(ip1jm+1,l)
    879874            enddo
    880875        enddo
     
    893888                    vgui2(ij,l)=zv2(i,j,l)*cv(i,j)
    894889                enddo
    895                 vgui1(j*iip1,l)=vgui1((j-1)*iip1+1,l)   
    896                 vgui2(j*iip1,l)=vgui2((j-1)*iip1+1,l)   
     890                vgui1(j*iip1,l)=vgui1((j-1)*iip1+1,l)
     891                vgui2(j*iip1,l)=vgui2((j-1)*iip1+1,l)
    897892            enddo
    898893        enddo
    899894    ENDIF
    900    
     895
    901896    IF (guide_Q) THEN
    902897        ! On suppose qu'on a la bonne variable dans le fichier de guidage:
     
    911906                    qgui2(ij,l)=zu2(i,j,l)
    912907                enddo
    913                 qgui1(j*iip1,l)=qgui1((j-1)*iip1+1,l)   
    914                 qgui2(j*iip1,l)=qgui2((j-1)*iip1+1,l)   
     908                qgui1(j*iip1,l)=qgui1((j-1)*iip1+1,l)
     909                qgui2(j*iip1,l)=qgui2((j-1)*iip1+1,l)
    915910            enddo
    916911            do i=1,iip1
    917912                qgui1(i,l)=qgui1(1,l)
    918                 qgui1(ip1jm+i,l)=qgui1(ip1jm+1,l) 
     913                qgui1(ip1jm+i,l)=qgui1(ip1jm+1,l)
    919914                qgui2(i,l)=qgui2(1,l)
    920                 qgui2(ip1jm+i,l)=qgui2(ip1jm+1,l) 
     915                qgui2(ip1jm+i,l)=qgui2(ip1jm+1,l)
    921916            enddo
    922917        enddo
     
    924919            CALL q_sat(iip1*jjp1*llm,teta*pk/cpp,plsnc,qsat)
    925920            qgui1=qgui1*qsat*0.01 !hum. rel. en %
    926             qgui2=qgui2*qsat*0.01 
     921            qgui2=qgui2*qsat*0.01
    927922        ENDIF
    928923    ENDIF
     
    937932    use comconst_mod, only: pi
    938933    use serre_mod, only: clon, clat, grossismx, grossismy
    939    
     934
    940935    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    941 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     936    USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    942937          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    943 implicit none
    944 
    945 
    946 
    947     include "comgeom2.h"
    948 
     938    USE comgeom2_mod_h
     939    implicit none
    949940! input arguments :
    950941    INTEGER, INTENT(IN) :: typ    ! u(2),v(3), ou scalaire(1)
     
    953944    REAL, INTENT(IN)    :: taumin,taumax
    954945! output arguments:
    955     REAL, DIMENSION(pim,pjm), INTENT(OUT) :: alpha 
    956  
     946    REAL, DIMENSION(pim,pjm), INTENT(OUT) :: alpha
     947
    957948!  local variables:
    958949    LOGICAL, SAVE               :: first=.TRUE.
     
    10401031        ENDIF
    10411032! Premier appel: calcul des aires min et max et de gamma.
    1042         IF (first) THEN 
     1033        IF (first) THEN
    10431034            first=.FALSE.
    10441035            ! coordonnees du centre du zoom
    1045             CALL coordij(clon,clat,ilon,ilat) 
     1036            CALL coordij(clon,clat,ilon,ilat)
    10461037            ! aire de la maille au centre du zoom
    10471038            dxdy_min=dxdys(ilon,ilat)
     
    10671058              endif
    10681059              gamma=log(0.5)/log(gamma)
    1069               if (gamma4) then 
     1060              if (gamma4) then
    10701061                gamma=min(gamma,4.)
    10711062              endif
     
    11681159             ENDIF
    11691160             rcode = nf90_inq_varid(ncidp, 'PRES', varidp)
    1170              IF (rcode.NE.NF90_NOERR) THEN 
     1161             IF (rcode.NE.NF90_NOERR) THEN
    11711162              abort_message='Nudging: error -> no PRES variable in file P.nc'
    11721163              CALL abort_gcm(modname,abort_message,1)
     
    12211212             write(*,*) trim(modname)//' ncidv,varidv',ncidv,varidv
    12221213             if (ncidpl.eq.-99) ncidpl=ncidv
    1223              
     1214
    12241215             status=NF90_INQ_DIMID(ncidv, "LONV", dimid)
    12251216             status=NF90_INQUIRE_DIMENSION(ncidv,dimid,namedim,lendim)
    1226              
     1217
    12271218                IF (lendim .NE. iip1) THEN
    12281219                abort_message='dimension LONV different from iip1 in v.nc'
     
    12371228                CALL abort_gcm(modname,abort_message,1)
    12381229             ENDIF
    1239        
     1230
    12401231         endif
    12411232
     
    13501341     count(4)=1
    13511342
    1352 ! Pression 
     1343! Pression
    13531344     if (guide_plevs.EQ.2) then
    13541345         status=NF90_GET_VAR(ncidp,varidp,pnat2,start,count)
     
    13821373           CALL invert_lat(iip1,jjp1,nlevnc,qnat2)
    13831374         ENDIF
    1384          
     1375
    13851376     endif
    13861377
     
    16721663
    16731664  END SUBROUTINE guide_read2D
    1674  
     1665
    16751666!=======================================================================
    16761667  SUBROUTINE guide_out(varname,hsize,vsize,field)
     
    16801671    use netcdf95, only: nf95_def_var, nf95_put_var
    16811672    use netcdf, only: nf90_float, nf90_def_var, nf90_put_var
    1682    
     1673
    16831674    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1684 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     1675    USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    16851676          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     1677    USE comgeom2_mod_h
    16861678IMPLICIT NONE
    16871679
    16881680
    16891681
    1690     INCLUDE "comgeom2.h"
    16911682   
    16921683    ! Variables entree
  • LMDZ6/trunk/libf/dyn3d/iniacademic.f90

    r5272 r5281  
    44SUBROUTINE iniacademic(vcov,ucov,teta,q,masse,ps,phis,time_0)
    55
     6  USE comgeom_mod_h
    67  USE filtreg_mod, ONLY: inifilr
    78  USE infotrac,    ONLY: nqtot, niso, iqIsoPha, tracers, isoName, addPhase
     
    3637
    3738
    38   include "comgeom.h"
    3939  include "academic.h"
    4040  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/integrd.f90

    r5272 r5281  
    77        )
    88
     9  USE comgeom_mod_h
    910  use control_mod, only : planet_type
    1011  use comconst_mod, only: pi
     
    3637
    3738
    38   include "comgeom.h"
    3939  include "iniprint.h"
    4040
  • LMDZ6/trunk/libf/dyn3d/leapfrog.F90

    r5280 r5281  
    66SUBROUTINE leapfrog(ucov,vcov,teta,ps,masse,phis,q,time_0)
    77  !IM : pour sortir les param. du modele dans un fis. netcdf 110106
     8  USE comgeom_mod_h
    89  USE comdissnew_mod_h
    910  use IOIPSL
     
    6061  !   Declarations:
    6162  !   -------------
    62   include "comgeom.h"
    6363  include "description.h"
    6464  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d/replay3d.f90

    r5280 r5281  
    55!
    66PROGRAM replay3d
     7  USE comgeom2_mod_h
    78  USE comdissnew_mod_h
    89  USE comvert_mod, only :  preff, pa
     
    5758  !   Declarations:
    5859  !   -------------
    59   include "comgeom2.h"
    6060
    6161  REAL zdtvr
  • LMDZ6/trunk/libf/dyn3d/sw_case_williamson91_6.f90

    r5272 r5281  
    2626  !
    2727  !=======================================================================
     28  USE comgeom_mod_h
    2829  USE comconst_mod, ONLY: cpp, omeg, rad
    2930  USE comvert_mod, ONLY: ap, bp, preff
     
    3940
    4041
    41   include "comgeom.h"
    4242  include "iniprint.h"
    4343
  • LMDZ6/trunk/libf/dyn3d/top_bound.F90

    r5280 r5281  
    44SUBROUTINE top_bound(vcov,ucov,teta,masse,dt)
    55
     6  USE comgeom2_mod_h
    67  USE comdissipn_mod_h
    78USE comconst_mod, ONLY: iflag_top_bound, mode_top_bound, &
     
    1617
    1718
    18   include "comgeom2.h"
    1919
    2020
  • LMDZ6/trunk/libf/dyn3d/vlsplt.F90

    r5272 r5281  
    487487END SUBROUTINE vlx
    488488RECURSIVE SUBROUTINE vly(q,pente_max,masse,masse_adv_v,iq)
     489  USE comgeom_mod_h
    489490  USE infotrac, ONLY : nqtot,tracers, & ! CRisi
    490491        min_qParent,min_qMass,min_ratio ! MVals et CRisi
     
    508509
    509510
    510   include "comgeom.h"
    511511  !
    512512  !
  • LMDZ6/trunk/libf/dyn3d/vlspltqs.F90

    r5272 r5281  
    545545END SUBROUTINE vlxqs
    546546SUBROUTINE vlyqs(q,pente_max,masse,masse_adv_v,qsat,iq)
     547  USE comgeom_mod_h
    547548  USE infotrac, ONLY : nqtot,tracers ! CRisi
    548549  !
     
    567568
    568569
    569   include "comgeom.h"
    570570  !
    571571  !
  • LMDZ6/trunk/libf/dyn3d_common/adaptdt.f90

    r5280 r5281  
    55        masse)
    66
     7  USE comgeom2_mod_h
    78  USE comdissip_mod_h
    89  USE comconst_mod, ONLY: dtvr
     
    1415
    1516
    16   include "comgeom2.h"
    1717  include "description.h"
    1818
  • LMDZ6/trunk/libf/dyn3d_common/advn.F90

    r5272 r5281  
    1515  !
    1616  !   --------------------------------------------------------------------
     17  USE comgeom_mod_h
    1718  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1819USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2223
    2324
    24   include "comgeom.h"
    2525  include "iniprint.h"
    2626
     
    759759  !
    760760  !   --------------------------------------------------------------------
     761  USE comgeom_mod_h
    761762  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    762763USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    766767
    767768
    768   INCLUDE "comgeom.h"
    769769  INCLUDE "iniprint.h"
    770770  !
     
    893893  !
    894894  !   --------------------------------------------------------------------
     895  USE comgeom_mod_h
    895896  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    896897USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    900901
    901902
    902   INCLUDE "comgeom.h"
    903903  INCLUDE "iniprint.h"
    904904  !
  • LMDZ6/trunk/libf/dyn3d_common/advy.f90

    r5272 r5281  
    33!
    44SUBROUTINE advy(limit,dty,pbarv,sm,s0,sx,sy,sz)
     5  USE comgeom2_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3132
    3233
    33   include "comgeom2.h"
    3434
    3535  !  Arguments :
  • LMDZ6/trunk/libf/dyn3d_common/advyp.f90

    r5272 r5281  
    44SUBROUTINE ADVYP(LIMIT,DTY,PBARV,SM,S0,SSX,SY,SZ &
    55        ,SSXX,SSXY,SSXZ,SYY,SYZ,SZZ,ntra )
     6  USE comgeom_mod_h
    67  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    78USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3334
    3435
    35   include "comgeom.h"
    3636
    3737  !  Arguments :
  • LMDZ6/trunk/libf/dyn3d_common/advzp.f90

    r5272 r5281  
    55        ,SSXX,SSXY,SSXZ,SYY,SYZ,SZZ,ntra )
    66
     7  USE comgeom_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3637
    3738
    38   include "comgeom.h"
    3939  !
    4040  !  Arguments :
  • LMDZ6/trunk/libf/dyn3d_common/caldyn0.f90

    r5272 r5281  
    66! Purpose: Compute dynamic tendencies.
    77!-------------------------------------------------------------------------------
    8   USE control_mod, ONLY: resetvarc
     8  USE comgeom_mod_h
     9  USE control_mod, ONLY: resetvarc
    910  USE comvert_mod, ONLY: ap, bp
    1011  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1415
    1516
    16   include "comgeom.h"
    1717!===============================================================================
    1818! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/comgeom2_mod_h.f90

    r5280 r5281  
    1 !
    2 ! $Header$
    3 !
    4 !CDK comgeom2
    5       COMMON/comgeom/                                                   &
    6      & cu(iip1,jjp1),cv(iip1,jjm),unscu2(iip1,jjp1),unscv2(iip1,jjm)  , &
    7      & aire(iip1,jjp1),airesurg(iip1,jjp1),aireu(iip1,jjp1)           , &
    8      & airev(iip1,jjm),unsaire(iip1,jjp1),apoln,apols                 , &
    9      & unsairez(iip1,jjm),airuscv2(iip1,jjm),airvscu2(iip1,jjm)       , &
    10      & aireij1(iip1,jjp1),aireij2(iip1,jjp1),aireij3(iip1,jjp1)       , &
    11      & aireij4(iip1,jjp1),alpha1(iip1,jjp1),alpha2(iip1,jjp1)         , &
    12      & alpha3(iip1,jjp1),alpha4(iip1,jjp1),alpha1p2(iip1,jjp1)        , &
    13      & alpha1p4(iip1,jjp1),alpha2p3(iip1,jjp1),alpha3p4(iip1,jjp1)    , &
    14      & fext(iip1,jjm),constang(iip1,jjp1), rlatu(jjp1),rlatv(jjm),      &
    15      & rlonu(iip1),rlonv(iip1),cuvsurcv(iip1,jjm),cvsurcuv(iip1,jjm)  , &
    16      & cvusurcu(iip1,jjp1),cusurcvu(iip1,jjp1)                        , &
    17      & cuvscvgam1(iip1,jjm),cuvscvgam2(iip1,jjm),cvuscugam1(iip1,jjp1), &
    18      & cvuscugam2(iip1,jjp1),cvscuvgam(iip1,jjm),cuscvugam(iip1,jjp1) , &
    19      & unsapolnga1,unsapolnga2,unsapolsga1,unsapolsga2                , &
    20      & unsair_gam1(iip1,jjp1),unsair_gam2(iip1,jjp1)                  , &
    21      & unsairz_gam(iip1,jjm),aivscu2gam(iip1,jjm),aiuscv2gam(iip1,jjm)  &
    22      & , xprimu(iip1),xprimv(iip1)
     1! Replaces comgeom2.h
    232
     3! AB 07/24: NOTE: THIS USES A LEGACY COMMON BLOCK SHARED WITH comgeom_mod_h.f90 !
     4! See comgeom_mod_h.f90 comment.
    245
    25       REAL                                                               &
    26      & cu,cv,unscu2,unscv2,aire,airesurg,aireu,airev,apoln,apols,unsaire &
    27      & ,unsairez,airuscv2,airvscu2,aireij1,aireij2,aireij3,aireij4     , &
    28      & alpha1,alpha2,alpha3,alpha4,alpha1p2,alpha1p4,alpha2p3,alpha3p4 , &
    29      & fext,constang,rlatu,rlatv,rlonu,rlonv,cuvscvgam1,cuvscvgam2     , &
    30      & cvuscugam1,cvuscugam2,cvscuvgam,cuscvugam,unsapolnga1           , &
    31      & unsapolnga2,unsapolsga1,unsapolsga2,unsair_gam1,unsair_gam2     , &
    32      & unsairz_gam,aivscu2gam,aiuscv2gam,cuvsurcv,cvsurcuv,cvusurcu    , &
    33      & cusurcvu,xprimu,xprimv
     6MODULE comgeom2_mod_h
     7  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     8  USE paramet_mod_h
     9  IMPLICIT NONE; PRIVATE
     10  PUBLIC                                                               &
     11          cu, cv, unscu2, unscv2, aire, airesurg, aireu, airev, apoln, apols, unsaire &
     12          , unsairez, airuscv2, airvscu2, aireij1, aireij2, aireij3, aireij4, &
     13          alpha1, alpha2, alpha3, alpha4, alpha1p2, alpha1p4, alpha2p3, alpha3p4, &
     14          fext, constang, rlatu, rlatv, rlonu, rlonv, cuvscvgam1, cuvscvgam2, &
     15          cvuscugam1, cvuscugam2, cvscuvgam, cuscvugam, unsapolnga1, &
     16          unsapolnga2, unsapolsga1, unsapolsga2, unsair_gam1, unsair_gam2, &
     17          unsairz_gam, aivscu2gam, aiuscv2gam, cuvsurcv, cvsurcuv, cvusurcu, &
     18          cusurcvu, xprimu, xprimv
     19
     20  COMMON/comgeom/                                                   &
     21          cu(iip1, jjp1), cv(iip1, jjm), unscu2(iip1, jjp1), unscv2(iip1, jjm), &
     22          aire(iip1, jjp1), airesurg(iip1, jjp1), aireu(iip1, jjp1), &
     23          airev(iip1, jjm), unsaire(iip1, jjp1), apoln, apols, &
     24          unsairez(iip1, jjm), airuscv2(iip1, jjm), airvscu2(iip1, jjm), &
     25          aireij1(iip1, jjp1), aireij2(iip1, jjp1), aireij3(iip1, jjp1), &
     26          aireij4(iip1, jjp1), alpha1(iip1, jjp1), alpha2(iip1, jjp1), &
     27          alpha3(iip1, jjp1), alpha4(iip1, jjp1), alpha1p2(iip1, jjp1), &
     28          alpha1p4(iip1, jjp1), alpha2p3(iip1, jjp1), alpha3p4(iip1, jjp1), &
     29          fext(iip1, jjm), constang(iip1, jjp1), rlatu(jjp1), rlatv(jjm), &
     30          rlonu(iip1), rlonv(iip1), cuvsurcv(iip1, jjm), cvsurcuv(iip1, jjm), &
     31          cvusurcu(iip1, jjp1), cusurcvu(iip1, jjp1), &
     32          cuvscvgam1(iip1, jjm), cuvscvgam2(iip1, jjm), cvuscugam1(iip1, jjp1), &
     33          cvuscugam2(iip1, jjp1), cvscuvgam(iip1, jjm), cuscvugam(iip1, jjp1), &
     34          unsapolnga1, unsapolnga2, unsapolsga1, unsapolsga2, &
     35          unsair_gam1(iip1, jjp1), unsair_gam2(iip1, jjp1), &
     36          unsairz_gam(iip1, jjm), aivscu2gam(iip1, jjm), aiuscv2gam(iip1, jjm)  &
     37          , xprimu(iip1), xprimv(iip1)
     38
     39  REAL                                                               &
     40          cu, cv, unscu2, unscv2, aire, airesurg, aireu, airev, apoln, apols, unsaire &
     41          , unsairez, airuscv2, airvscu2, aireij1, aireij2, aireij3, aireij4, &
     42          alpha1, alpha2, alpha3, alpha4, alpha1p2, alpha1p4, alpha2p3, alpha3p4, &
     43          fext, constang, rlatu, rlatv, rlonu, rlonv, cuvscvgam1, cuvscvgam2, &
     44          cvuscugam1, cvuscugam2, cvscuvgam, cuscvugam, unsapolnga1, &
     45          unsapolnga2, unsapolsga1, unsapolsga2, unsair_gam1, unsair_gam2, &
     46          unsairz_gam, aivscu2gam, aiuscv2gam, cuvsurcv, cvsurcuv, cvusurcu, &
     47          cusurcvu, xprimu, xprimv
     48
     49END MODULE comgeom2_mod_h
  • LMDZ6/trunk/libf/dyn3d_common/comgeom_mod_h.f90

    r5280 r5281  
    1 !
    2 ! $Header$
    3 !
    4 !CDK comgeom
    5       COMMON/comgeom/                                                   &
    6      & cu(ip1jmp1),cv(ip1jm),unscu2(ip1jmp1),unscv2(ip1jm),             &
    7      & aire(ip1jmp1),airesurg(ip1jmp1),aireu(ip1jmp1),                  &
    8      & airev(ip1jm),unsaire(ip1jmp1),apoln,apols,                       &
    9      & unsairez(ip1jm),airuscv2(ip1jm),airvscu2(ip1jm),                 &
    10      & aireij1(ip1jmp1),aireij2(ip1jmp1),aireij3(ip1jmp1),              &
    11      & aireij4(ip1jmp1),alpha1(ip1jmp1),alpha2(ip1jmp1),                &
    12      & alpha3(ip1jmp1),alpha4(ip1jmp1),alpha1p2(ip1jmp1),               &
    13      & alpha1p4(ip1jmp1),alpha2p3(ip1jmp1),alpha3p4(ip1jmp1),           &
    14      & fext(ip1jm),constang(ip1jmp1),rlatu(jjp1),rlatv(jjm),            &
    15      & rlonu(iip1),rlonv(iip1),cuvsurcv(ip1jm),cvsurcuv(ip1jm),         &
    16      & cvusurcu(ip1jmp1),cusurcvu(ip1jmp1),cuvscvgam1(ip1jm),           &
    17      & cuvscvgam2(ip1jm),cvuscugam1(ip1jmp1),                           &
    18      & cvuscugam2(ip1jmp1),cvscuvgam(ip1jm),cuscvugam(ip1jmp1),         &
    19      & unsapolnga1,unsapolnga2,unsapolsga1,unsapolsga2,                 &
    20      & unsair_gam1(ip1jmp1),unsair_gam2(ip1jmp1),unsairz_gam(ip1jm),    &
    21      & aivscu2gam(ip1jm),aiuscv2gam(ip1jm),xprimu(iip1),xprimv(iip1)
     1! Replaces comgeom.h
    222
    23 !
    24         REAL                                                            &
    25      & cu,cv,unscu2,unscv2,aire,airesurg,aireu,airev,unsaire,apoln     ,&
    26      & apols,unsairez,airuscv2,airvscu2,aireij1,aireij2,aireij3,aireij4,&
    27      & alpha1,alpha2,alpha3,alpha4,alpha1p2,alpha1p4,alpha2p3,alpha3p4 ,&
    28      & fext,constang,rlatu,rlatv,rlonu,rlonv,cuvscvgam1,cuvscvgam2     ,&
    29      & cvuscugam1,cvuscugam2,cvscuvgam,cuscvugam,unsapolnga1,unsapolnga2&
    30      & ,unsapolsga1,unsapolsga2,unsair_gam1,unsair_gam2,unsairz_gam    ,&
    31      & aivscu2gam ,aiuscv2gam,cuvsurcv,cvsurcuv,cvusurcu,cusurcvu,xprimu&
    32      & , xprimv
    33 !
     3! AB 07/24: NOTE: THIS USES A LEGACY COMMON BLOCK SHARED WITH comgeom2_mod_h.f90 !
     4! This file defines a number of 1D arrays.
     5! The COMMON block is used to transparently (but using unsafe procedures) cast those as 2D arrays, without duplication.
     6! Therefore there's no trivial way to turn this into a module without COMMON.
     7! In the future we'd still like to get rid of this COMMON block.
     8
     9MODULE comgeom_mod_h
     10  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     11  USE paramet_mod_h
     12  IMPLICIT NONE; PRIVATE
     13  PUBLIC cu, cv, unscu2, unscv2, aire, airesurg, aireu, airev, unsaire, apoln, &
     14          apols, unsairez, airuscv2, airvscu2, aireij1, aireij2, aireij3, aireij4, &
     15          alpha1, alpha2, alpha3, alpha4, alpha1p2, alpha1p4, alpha2p3, alpha3p4, &
     16          fext, constang, rlatu, rlatv, rlonu, rlonv, cuvscvgam1, cuvscvgam2, &
     17          cvuscugam1, cvuscugam2, cvscuvgam, cuscvugam, unsapolnga1, unsapolnga2&
     18          , unsapolsga1, unsapolsga2, unsair_gam1, unsair_gam2, unsairz_gam, &
     19          aivscu2gam, aiuscv2gam, cuvsurcv, cvsurcuv, cvusurcu, cusurcvu, xprimu&
     20          , xprimv
     21
     22  COMMON/comgeom/                                                   &
     23          cu(ip1jmp1), cv(ip1jm), unscu2(ip1jmp1), unscv2(ip1jm), &
     24          aire(ip1jmp1), airesurg(ip1jmp1), aireu(ip1jmp1), &
     25          airev(ip1jm), unsaire(ip1jmp1), apoln, apols, &
     26          unsairez(ip1jm), airuscv2(ip1jm), airvscu2(ip1jm), &
     27          aireij1(ip1jmp1), aireij2(ip1jmp1), aireij3(ip1jmp1), &
     28          aireij4(ip1jmp1), alpha1(ip1jmp1), alpha2(ip1jmp1), &
     29          alpha3(ip1jmp1), alpha4(ip1jmp1), alpha1p2(ip1jmp1), &
     30          alpha1p4(ip1jmp1), alpha2p3(ip1jmp1), alpha3p4(ip1jmp1), &
     31          fext(ip1jm), constang(ip1jmp1), rlatu(jjp1), rlatv(jjm), &
     32          rlonu(iip1), rlonv(iip1), cuvsurcv(ip1jm), cvsurcuv(ip1jm), &
     33          cvusurcu(ip1jmp1), cusurcvu(ip1jmp1), cuvscvgam1(ip1jm), &
     34          cuvscvgam2(ip1jm), cvuscugam1(ip1jmp1), &
     35          cvuscugam2(ip1jmp1), cvscuvgam(ip1jm), cuscvugam(ip1jmp1), &
     36          unsapolnga1, unsapolnga2, unsapolsga1, unsapolsga2, &
     37          unsair_gam1(ip1jmp1), unsair_gam2(ip1jmp1), unsairz_gam(ip1jm), &
     38          aivscu2gam(ip1jm), aiuscv2gam(ip1jm), xprimu(iip1), xprimv(iip1)
     39
     40  REAL                                                            &
     41          cu, cv, unscu2, unscv2, aire, airesurg, aireu, airev, unsaire, apoln, &
     42          apols, unsairez, airuscv2, airvscu2, aireij1, aireij2, aireij3, aireij4, &
     43          alpha1, alpha2, alpha3, alpha4, alpha1p2, alpha1p4, alpha2p3, alpha3p4, &
     44          fext, constang, rlatu, rlatv, rlonu, rlonv, cuvscvgam1, cuvscvgam2, &
     45          cvuscugam1, cvuscugam2, cvscuvgam, cuscvugam, unsapolnga1, unsapolnga2&
     46          , unsapolsga1, unsapolsga2, unsair_gam1, unsair_gam2, unsairz_gam, &
     47          aivscu2gam, aiuscv2gam, cuvsurcv, cvsurcuv, cvusurcu, cusurcvu, xprimu&
     48          , xprimv
     49
     50END MODULE comgeom_mod_h
     51
  • LMDZ6/trunk/libf/dyn3d_common/convflu.f90

    r5272 r5281  
    1818  ! nbniv   est le nombre de niveaux vert. de  xflu et de yflu .
    1919  !
     20  USE comgeom_mod_h
    2021  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2122USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3334  !
    3435  !
    35   INCLUDE "comgeom.h"
    3636  !
    3737  DO l = 1,nbniv
  • LMDZ6/trunk/libf/dyn3d_common/convmas.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute mass flux convergence at p levels.
     7  USE comgeom_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1112
    1213
    13   include "comgeom.h"
    1414!===============================================================================
    1515! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/coordij.f90

    r5272 r5281  
    1111  !=======================================================================
    1212
     13  USE comgeom_mod_h
    1314  USE comconst_mod, ONLY: pi
    1415
     
    2324
    2425
    25   include "comgeom.h"
    2626
    2727  real :: zlon,zlat
  • LMDZ6/trunk/libf/dyn3d_common/covcont.f90

    r5272 r5281  
    66! Purpose: Compute contravariant components from covariant components.
    77!-------------------------------------------------------------------------------
     8  USE comgeom_mod_h
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    910USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1213
    1314
    14   include "comgeom.h"
    1515!===============================================================================
    1616! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/diagedyn.f90

    r5274 r5281  
    5353  !======================================================================
    5454
     55  USE comgeom_mod_h
    5556  USE control_mod, ONLY : planet_type
    5657
     
    6263
    6364
    64   INCLUDE "comgeom.h"
    6565  INCLUDE "iniprint.h"
    6666
  • LMDZ6/trunk/libf/dyn3d_common/diverg.f90

    r5272 r5281  
    1111  !          x et y  etant des composantes covariantes   ...
    1212  !  *********************************************************************
     13  USE comgeom_mod_h
    1314  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1415USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2728
    2829
    29   INCLUDE "comgeom.h"
    3030  !
    3131  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3d_common/diverg_gam.f90

    r5272 r5281  
    1212  !          x et y  etant des composantes covariantes   ...
    1313  !  *********************************************************************
     14  USE comgeom_mod_h
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1516USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2829
    2930
    30   INCLUDE "comgeom.h"
    3131  !
    3232  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3d_common/divergf.f90

    r5272 r5281  
    1111  !          x et y  etant des composantes covariantes   ...
    1212  !  *********************************************************************
     13  USE comgeom_mod_h
    1314  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1415USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2728
    2829
    29   INCLUDE "comgeom.h"
    3030  !
    3131  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3d_common/divergst.f90

    r5272 r5281  
    33!
    44SUBROUTINE divergst(klevel,x,y,div)
     5  USE comgeom_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2122  !   -------------------------------------------------------------------
    2223  !
    23   INCLUDE "comgeom.h"
    2424
    2525  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3d_common/divgrad.f90

    r5280 r5281  
    33!
    44SUBROUTINE divgrad (klevel,h, lh, divgra )
     5  USE comgeom_mod_h
    56  USE comdissipn_mod_h
    67  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2627
    2728
    28   include "comgeom.h"
    2929  !
    3030  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3d_common/divgrad2.f90

    r5280 r5281  
    1313  !     divgra     est  un argument  de sortie pour le s-prg
    1414  !
     15  USE comgeom2_mod_h
    1516  USE comdissipn_mod_h
    1617  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2122
    2223
    23   INCLUDE "comgeom2.h"
    2424
    2525  !    .......    variables en arguments   .......
  • LMDZ6/trunk/libf/dyn3d_common/enercin.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute kinetic energy at sigma levels.
     7  USE comgeom_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1112
    1213
    13   include "comgeom.h"
    1414!===============================================================================
    1515! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/exner_hyb_m.f90

    r5272 r5281  
    11module exner_hyb_m
    22
    3   IMPLICIT NONE
     3  USE comgeom_mod_h
     4    IMPLICIT NONE
    45
    56contains
     
    1415    !
    1516    !   ************************************************************************
    16     !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des 
     17    !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des
    1718    !    couches .   Pk(l) sera calcule aux milieux  des couches l ,entre les
    1819    !    pressions p(l) et p(l+1) ,definis aux interfaces des llm couches .
     
    2627    !    ( voir note de Fr.Hourdin )  ,
    2728    !
    28     !    on determine successivement , du haut vers le bas des couches, les 
    29     !    coef. alpha(llm),beta(llm) .,.,alpha(l),beta(l),,,alpha(2),beta(2), 
    30     !    puis pk(ij,1). Ensuite ,on calcule,du bas vers le haut des couches, 
     29    !    on determine successivement , du haut vers le bas des couches, les
     30    !    coef. alpha(llm),beta(llm) .,.,alpha(l),beta(l),,,alpha(2),beta(2),
     31    !    puis pk(ij,1). Ensuite ,on calcule,du bas vers le haut des couches,
    3132    !     pk(ij,l)  donne  par la relation (2),  pour l = 2 a l = llm .
    3233    !
     
    3536    USE comconst_mod, ONLY: jmp1, cpp, kappa, r
    3637    USE comvert_mod, ONLY: preff
    37    
     38
    3839    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    3940USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    4344
    4445
    45     include "comgeom.h"
    4646
    4747    INTEGER  ngrid
  • LMDZ6/trunk/libf/dyn3d_common/exner_milieu_m.f90

    r5272 r5281  
    11module exner_milieu_m
    22
    3   IMPLICIT NONE
     3  USE comgeom_mod_h
     4    IMPLICIT NONE
    45
    56contains
     
    1516    !
    1617    !   ************************************************************************
    17     !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des 
     18    !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des
    1819    !    couches .   Pk(l) sera calcule aux milieux  des couches l ,entre les
    1920    !    pressions p(l) et p(l+1) ,definis aux interfaces des llm couches .
     
    2324    !
    2425    !     WARNING : CECI est une version speciale de exner_hyb originale
    25     !               Utilise dans la version martienne pour pouvoir 
     26    !               Utilise dans la version martienne pour pouvoir
    2627    !               tourner avec des coordonnees verticales complexe
    27     !              => Il ne verifie PAS la condition la proportionalite en 
     28    !              => Il ne verifie PAS la condition la proportionalite en
    2829    !              energie totale/ interne / potentielle (F.Forget 2001)
    2930    !    ( voir note de Fr.Hourdin )  ,
     
    3233    USE comconst_mod, ONLY: jmp1, cpp, kappa, r
    3334    USE comvert_mod, ONLY: preff
    34    
     35
    3536    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    3637USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    4041
    4142
    42     include "comgeom.h"
    4343
    4444    INTEGER  ngrid
  • LMDZ6/trunk/libf/dyn3d_common/flumass.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute mass flux at s levels.
     7  USE comgeom_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1112
    1213
    13   include "comgeom.h"
    1414!===============================================================================
    1515! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/gr_u_scal.f90

    r5272 r5281  
    2525  !
    2626  !=======================================================================
     27  USE comgeom_mod_h
    2728  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2829USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3536
    3637
    37   INCLUDE "comgeom.h"
    3838
    3939  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/gr_v_scal.f90

    r5272 r5281  
    2525  !
    2626  !=======================================================================
     27  USE comgeom_mod_h
    2728  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2829USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3536
    3637
    37   INCLUDE "comgeom.h"
    3838
    3939  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/gradiv2.f90

    r5280 r5281  
    1616  !
    1717  !
     18  USE comgeom_mod_h
    1819  USE comdissipn_mod_h
    1920  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2425
    2526
    26   INCLUDE "comgeom.h"
    2727  !
    2828  ! ........    variables en arguments      ........
  • LMDZ6/trunk/libf/dyn3d_common/grilles_gcm_netcdf_sub.f90

    r5272 r5281  
    1212SUBROUTINE grilles_gcm_netcdf_sub(masque,phis)
    1313
     14  USE comgeom_mod_h
    1415  USE comconst_mod, ONLY: cpp, kappa, g, omeg, daysec, rad, pi
    1516  USE comvert_mod, ONLY: presnivs, preff, pa
    1617  USE netcdf, ONLY: nf90_def_var, nf90_int, nf90_float, nf90_put_var, nf90_clobber, nf90_64bit_offset, nf90_def_dim, &
    1718          nf90_put_att, nf90_enddef, nf90_create
    18  
     19
    1920  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2021USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2425
    2526
    26   INCLUDE "comgeom.h"
    2727
    2828!========================
  • LMDZ6/trunk/libf/dyn3d_common/inigeom.f90

    r5280 r5281  
    1616  !
    1717  !
     18  USE comgeom2_mod_h
    1819  USE comdissnew_mod_h
    1920  use fxhyp_m, only: fxhyp
     
    3031
    3132
    32   include "comgeom2.h"
    3333
    3434  !-----------------------------------------------------------------------
  • LMDZ6/trunk/libf/dyn3d_common/initdynav.f90

    r5272 r5281  
    33subroutine initdynav(day0,anne0,tstep,t_ops,t_wrt)
    44
     5  USE comgeom_mod_h
    56  USE IOIPSL
    67  USE infotrac, ONLY : nqtot
     
    1011  USE comvert_mod, ONLY: presnivs
    1112  USE temps_mod, ONLY: itau_dyn
    12  
     13
    1314  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1415USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3940
    4041
    41   include "comgeom.h"
    4242  include "description.h"
    4343  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d_common/initfluxsto.f90

    r5272 r5281  
    66        fileid,filevid,filedid)
    77
    8    USE IOIPSL
     8   USE comgeom_mod_h
     9  USE IOIPSL
    910  USE comconst_mod, ONLY: pi
    1011  USE comvert_mod, ONLY: nivsigs
     
    4546
    4647
    47   include "comgeom.h"
    4848  include "description.h"
    4949  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d_common/inithist.f90

    r5272 r5281  
    44subroutine inithist(day0,anne0,tstep,t_ops,t_wrt)
    55
    6    USE IOIPSL
     6   USE comgeom_mod_h
     7  USE IOIPSL
    78   USE infotrac, ONLY : nqtot
    89   use com_io_dyn_mod, only : histid,histvid,histuid,               &
     
    4445
    4546
    46   include "comgeom.h"
    4747  include "description.h"
    4848  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d_common/inter_barxy_m.f90

    r5272 r5281  
    66  ! Authors: Robert SADOURNY, Phu LE VAN, Lionel GUEZ
    77
    8   USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     8  USE comgeom2_mod_h
     9    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    910USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    1011          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     
    2728    ! (for other included files)
    2829
    29     include "comgeom2.h"
    3030    ! (for "aire", "apoln", "apols")
    3131
  • LMDZ6/trunk/libf/dyn3d_common/interpost.f90

    r5272 r5281  
    44  subroutine interpost(q,qppm)
    55
    6    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     6   USE comgeom2_mod_h
     7  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    78USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    89          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     
    1213
    1314
    14   include "comgeom2.h"
    1515
    1616  ! Arguments
  • LMDZ6/trunk/libf/dyn3d_common/interpre.f90

    r5280 r5281  
    66         unatppm,vnatppm,psppm)
    77
     8  USE comgeom2_mod_h
    89  USE comdissip_mod_h
    910  USE comconst_mod, ONLY: g
     
    1718
    1819
    19   include "comgeom2.h"
    2020  include "description.h"
    2121
  • LMDZ6/trunk/libf/dyn3d_common/laplacien.f90

    r5272 r5281  
    1212  !  divgra     est  un argument  de sortie pour le s-prog
    1313  !
     14  USE comgeom_mod_h
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1516USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222
    2323  !
  • LMDZ6/trunk/libf/dyn3d_common/laplacien_gam.f90

    r5272 r5281  
    1414  !  divgra     est  un argument  de sortie pour le s-prog
    1515  !
     16  USE comgeom_mod_h
    1617  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1718USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2122
    2223
    23   INCLUDE "comgeom.h"
    2424
    2525  !
  • LMDZ6/trunk/libf/dyn3d_common/laplacien_rot.f90

    r5272 r5281  
    1313  !  rotout           est  un argument  de sortie pour le s-prog
    1414  !
     15  USE comgeom_mod_h
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   INCLUDE "comgeom.h"
    2323
    2424  !
  • LMDZ6/trunk/libf/dyn3d_common/laplacien_rotgam.f90

    r5272 r5281  
    1212  !  divgra     est  un argument  de sortie pour le s-prog
    1313  !
     14  USE comgeom_mod_h
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1516USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222
    2323  !
  • LMDZ6/trunk/libf/dyn3d_common/limx.f90

    r5272 r5281  
    1313  !
    1414  !   --------------------------------------------------------------------
     15  USE comgeom_mod_h
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   include "comgeom.h"
    2323  !
    2424  !
  • LMDZ6/trunk/libf/dyn3d_common/limy.f90

    r5272 r5281  
    1414  !
    1515  !   --------------------------------------------------------------------
     16  USE comgeom_mod_h
    1617  USE comconst_mod, ONLY: pi
    1718  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2223
    2324
    24   include "comgeom.h"
    2525  !
    2626  !
  • LMDZ6/trunk/libf/dyn3d_common/limz.f90

    r5272 r5281  
    1313  !
    1414  !   --------------------------------------------------------------------
     15  USE comgeom_mod_h
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   include "comgeom.h"
    2323  !
    2424  !
  • LMDZ6/trunk/libf/dyn3d_common/massbar.f90

    r5272 r5281  
    66! Purpose: Compute air mass mean along X and Y in each cell.
    77! See iniconst for more details.
     8  USE comgeom_mod_h
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    910USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1213
    1314
    14   include "comgeom.h"
    1515!===============================================================================
    1616! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/massbarxy.f90

    r5277 r5281  
    66! Purpose: Compute air mass mean along X and Y in each cell.
    77! See iniconst for more details.
     8  USE comgeom_mod_h
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    910USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1213
    1314
    14   include "comgeom.h"
    1515!===============================================================================
    1616! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/massdair.f90

    r5272 r5281  
    1616  !  ....  p est defini aux interfaces des llm couches   .....
    1717  !
     18  USE comgeom_mod_h
    1819  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1920USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2324
    2425
    25   include "comgeom.h"
    2626  !
    2727  !  .....   arguments  ....
  • LMDZ6/trunk/libf/dyn3d_common/nxgrad.f90

    r5272 r5281  
    1212  !   x  et y    sont des arguments de sortie pour le s-prog
    1313  !
     14  USE comgeom_mod_h
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1516USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222  INTEGER :: klevel
    2323  REAL :: rot( ip1jm,klevel ),x( ip1jmp1,klevel ),y(ip1jm,klevel )
  • LMDZ6/trunk/libf/dyn3d_common/nxgrad_gam.f90

    r5272 r5281  
    1212  !   x  et y    sont des arguments de sortie pour le s-prog
    1313  !
     14  USE comgeom_mod_h
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1516USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222  INTEGER :: klevel
    2323  REAL :: rot( ip1jm,klevel ),x( ip1jmp1,klevel ),y(ip1jm,klevel )
  • LMDZ6/trunk/libf/dyn3d_common/nxgradst.f90

    r5272 r5281  
    33!
    44SUBROUTINE nxgradst (klevel,rot, x, y )
     5  USE comgeom_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1617  !
    1718
    18   INCLUDE "comgeom.h"
    1919
    2020  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3d_common/pbar.f90

    r5272 r5281  
    33!
    44SUBROUTINE pbar ( pext, pbarx, pbary, pbarxy )
     5  USE comgeom_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    7778  !=======================================================================
    7879
    79   INCLUDE "comgeom.h"
    8080
    8181  REAL :: pext( ip1jmp1 ),  pbarx ( ip1jmp1 )
  • LMDZ6/trunk/libf/dyn3d_common/pentes_ini.f90

    r5272 r5281  
    33!
    44SUBROUTINE pentes_ini (q,w,masse,pbaru,pbarv,mode)
     5  USE comgeom2_mod_h
    56  USE comconst_mod, ONLY: pi, dtvr
    67  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2425  !
    2526  !=======================================================================
    26   include "comgeom2.h"
    2727
    2828  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/prather.f90

    r5272 r5281  
    33!
    44SUBROUTINE prather (q,w,masse,pbaru,pbarv,nt,dt)
     5  USE comgeom2_mod_h
    56  USE comconst_mod, ONLY: pi
    67  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2122  !
    2223  !=======================================================================
    23   include "comgeom2.h"
    2424
    2525  !   Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/psextbar.f90

    r5272 r5281  
    33!
    44SUBROUTINE psextbar ( ps, psexbarxy )
     5  USE comgeom_mod_h
    56  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    67  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    7677  !
    7778  !=======================================================================
    78   INCLUDE "comgeom.h"
    7979
    8080  REAL :: ps( ip1jmp1 ), psexbarxy ( ip1jm ), pext( ip1jmp1 )
  • LMDZ6/trunk/libf/dyn3d_common/rotat.f90

    r5272 r5281  
    1313  !        rot          est  un argument  de sortie pour le s-prog
    1414  !
     15  USE comgeom_mod_h
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   INCLUDE "comgeom.h"
    2323  !
    2424  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3d_common/rotat_nfil.f90

    r5272 r5281  
    1313  !        rot          est  un argument  de sortie pour le s-prog
    1414  !
     15  USE comgeom_mod_h
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   INCLUDE "comgeom.h"
    2323  !
    2424  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3d_common/rotatf.f90

    r5272 r5281  
    1414  !        rot          est  un argument  de sortie pour le s-prog
    1515  !
     16  USE comgeom_mod_h
    1617  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1718USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2122
    2223
    23   INCLUDE "comgeom.h"
    2424  !
    2525  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3d_common/sortvarc.f90

    r5272 r5281  
    66        vcov )
    77
     8  USE comgeom_mod_h
    89  USE control_mod, ONLY: resetvarc
    910  USE comconst_mod, ONLY: dtvr, daysec, g, rad, omeg
     
    3536
    3637
    37   INCLUDE "comgeom.h"
    3838  INCLUDE "iniprint.h"
    3939
  • LMDZ6/trunk/libf/dyn3d_common/tourpot.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute potential vorticity.
     7  USE comgeom_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1112
    1213
    13   include "comgeom.h"
    1414!===============================================================================
    1515! Arguments:
  • LMDZ6/trunk/libf/dyn3d_common/traceurpole.f90

    r5280 r5281  
    44    subroutine traceurpole(q,masse)
    55
    6       USE comdissip_mod_h
     6      USE comgeom2_mod_h
     7  USE comdissip_mod_h
    78  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    89USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1213
    1314
    14   include "comgeom2.h"
    1515  include "description.h"
    1616
  • LMDZ6/trunk/libf/dyn3d_common/ugeostr.f90

    r5272 r5281  
    1111  ! levels are pressure levels.
    1212
     13  USE comgeom2_mod_h
    1314  use comconst_mod, only: omeg, rad
    14  
     15
    1516  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1617USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    2021
    2122
    22   include "comgeom2.h"
    2323
    2424  real ucov(iip1,jjp1,llm),phi(iip1,jjp1,llm)
  • LMDZ6/trunk/libf/dyn3d_common/writedynav.f90

    r5272 r5281  
    33subroutine writedynav(time, vcov, ucov, teta, ppk, phi, q, masse, ps, phis)
    44
     5  USE comgeom_mod_h
    56  USE ioipsl
    67  USE infotrac, ONLY : nqtot
     
    3334
    3435
    35   include "comgeom.h"
    3636  include "description.h"
    3737  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3d_common/writehist.f90

    r5272 r5281  
    33!
    44subroutine writehist(time,vcov,ucov,teta,phi,q,masse,ps,phis)
     5  USE comgeom_mod_h
    56  USE ioipsl
    67  USE infotrac, ONLY : nqtot
     
    3536  !   Declarations
    3637
    37   include "comgeom.h"
    3838  include "description.h"
    3939  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/addfi_loc.f90

    r5272 r5281  
    1111  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    1212          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     13  USE comgeom_mod_h
    1314  IMPLICIT NONE
    1415  !
     
    4647  !-----------------------------------------------------------------------
    4748  !
    48   !    0.  Declarations :
    49   !    ------------------
    50   include "comgeom.h"
    51   !
    5249  !    Arguments :
    5350  !    -----------
  • LMDZ6/trunk/libf/dyn3dmem/advect_new_loc.f90

    r5272 r5281  
    44SUBROUTINE advect_new_loc(ucov,vcov,teta,w,massebx,masseby, &
    55        du,dv,dteta)
     6  USE comgeom_mod_h
    67  USE parallel_lmdz
    78  USE write_field_loc
     
    3233  !   Declarations:
    3334  !   -------------
    34   include "comgeom.h"
    3535
    3636  !   Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/advtrac_loc.f90

    r5280 r5281  
    88   !            M.A Filiberti (04/2002)
    99   !
     10   USE comgeom2_mod_h
    1011   USE comdissip_mod_h
    1112   USE infotrac,     ONLY: nqtot, tracers
     
    2930
    3031
    31    include "comgeom2.h"
    3232   include "description.h"
    3333!   include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/bilan_dyn_loc.f90

    r5272 r5281  
    1010  !             vQ..A=Cp T + L * ...
    1111
     12  USE comgeom2_mod_h
    1213  USE IOIPSL
    1314  USE parallel_lmdz
     
    2627
    2728
    28   include "comgeom2.h"
    2929  include "iniprint.h"
    3030
  • LMDZ6/trunk/libf/dyn3dmem/caldyn_loc.f90

    r5272 r5281  
    22        (itau,ucov,vcov,teta,ps,masse,pk,pkf,phis , &
    33        phi,conser,du,dv,dteta,dp,w,pbaru,pbarv,time )
     4  USE comgeom_mod_h
    45  USE parallel_lmdz
    56  USE Write_Field_loc
     
    3132
    3233
    33   include "comgeom.h"
    3434
    3535  !   Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/call_dissip_mod.f90

    r5272 r5281  
    4747    CALL allocate_u(dtetadis,llm,d)
    4848    CALL allocate_u(dtetaecdt,llm,d)
    49    
    50    
     49
     50
    5151    CALL dissip_allocate
    52    
     52
    5353  END SUBROUTINE call_dissip_allocate
    54  
     54
    5555  SUBROUTINE call_dissip_switch_dissip(dist)
    5656  USE allocate_field_mod
     
    7676
    7777    CALL dissip_switch_dissip(dist)
    78    
    79   END SUBROUTINE call_dissip_switch_dissip 
    80  
    81 
    82  
     78
     79  END SUBROUTINE call_dissip_switch_dissip
     80
     81
     82
    8383  SUBROUTINE call_dissip(ucov_dyn,vcov_dyn,teta_dyn,p_dyn,pk_dyn,ps_dyn)
    8484  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    9292  USE write_field_loc
    9393  USE lmdz_cppkeys_wrapper, ONLY: CPPKEY_DEBUGIO
     94  USE comgeom_mod_h
    9495  IMPLICIT NONE
    95     INCLUDE 'comgeom.h'
    9696    REAL,INTENT(INOUT) :: ucov_dyn(ijb_u:ije_u,llm) ! covariant zonal wind
    9797    REAL,INTENT(INOUT) :: vcov_dyn(ijb_v:ije_v,llm) ! covariant meridional wind
  • LMDZ6/trunk/libf/dyn3dmem/convflu_loc.f90

    r5272 r5281  
    1515  ! nbniv   est le nombre de niveaux vert. de  xflu et de yflu .
    1616  !
     17  USE comgeom_mod_h
    1718  USE parallel_lmdz
    1819  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    3334  !
    3435  !
    35   INCLUDE "comgeom.h"
    3636  !
    3737
  • LMDZ6/trunk/libf/dyn3dmem/convmas1_loc.f90

    r5272 r5281  
    66! Purpose: Compute mass flux convergence at p levels.
    77!          Equivalent to convmas_loc if convmas2_loc is called after.
     8  USE comgeom_mod_h
    89  USE parallel_lmdz
    910  USE mod_filtreg_p
     
    1415
    1516
    16   include "comgeom.h"
    1717!===============================================================================
    1818! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/convmas2_loc.f90

    r5272 r5281  
    66! Purpose: Compute mass flux convergence at p levels.
    77!          Equivalent to convmas_loc if convmas1_loc is called before.
     8  USE comgeom_mod_h
    89  USE parallel_lmdz
    910  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1314
    1415
    15   include "comgeom.h"
    1616!===============================================================================
    1717! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/convmas_loc.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute mass flux convergence at p levels.
     7  USE comgeom_mod_h
    78  USE parallel_lmdz
    89  USE mod_filtreg_p
     
    1314
    1415
    15   include "comgeom.h"
    1616!===============================================================================
    1717! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/covcont_loc.f90

    r5272 r5281  
    11SUBROUTINE covcont_loc (klevel,ucov, vcov, ucont, vcont )
     2  USE comgeom_mod_h
    23  USE parallel_lmdz
    34  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1920  !
    2021  !=======================================================================
    21   INCLUDE "comgeom.h"
    2222
    2323  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3dmem/covnat_loc.f90

    r5272 r5281  
    33!
    44SUBROUTINE covnat_loc(klevel,ucov, vcov, unat, vnat )
     5  USE comgeom_mod_h
    56  USE parallel_lmdz
    67  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2223  !
    2324  !=======================================================================
    24   INCLUDE "comgeom.h"
    2525
    2626  INTEGER :: klevel
  • LMDZ6/trunk/libf/dyn3dmem/dissip_loc.f90

    r5280 r5281  
    44SUBROUTINE dissip_loc( vcov,ucov,teta,p, dv,du,dh )
    55  !
     6  USE comgeom_mod_h
    67  USE comdissipn_mod_h
    78  USE comdissnew_mod_h
     
    3738
    3839
    39   include "comgeom.h"
    4040
    4141  !   Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/diverg_gam_loc.f90

    r5272 r5281  
    99  !          x et y  etant des composantes covariantes   ...
    1010  !  *********************************************************************
     11  USE comgeom_mod_h
    1112  USE parallel_lmdz
    1213  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2627
    2728
    28   INCLUDE "comgeom.h"
    2929  !
    3030  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3dmem/diverg_p.f90

    r5272 r5281  
    88  !          x et y  etant des composantes covariantes   ...
    99  !  *********************************************************************
     10  USE comgeom_mod_h
    1011  USE parallel_lmdz
    1112  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    2526
    2627
    27   INCLUDE "comgeom.h"
    2828  !
    2929  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3dmem/divergf_loc.f90

    r5272 r5281  
    88  !          x et y  etant des composantes covariantes   ...
    99  !  *********************************************************************
     10  USE comgeom_mod_h
    1011  USE parallel_lmdz
    1112  USE mod_filtreg_p
     
    2627
    2728
    28   INCLUDE "comgeom.h"
    2929  !
    3030  !    ..........          variables en arguments    ...................
  • LMDZ6/trunk/libf/dyn3dmem/divgrad2_loc.f90

    r5280 r5281  
    1010  !     divgra     est  un argument  de sortie pour le s-prg
    1111  !
     12  USE comgeom2_mod_h
    1213  USE comdissipn_mod_h
    1314  USE parallel_lmdz
     
    2223
    2324
    24   INCLUDE "comgeom2.h"
    2525
    2626  !    .......    variables en arguments   .......
  • LMDZ6/trunk/libf/dyn3dmem/dynetat0_loc.f90

    r5272 r5281  
    66! Purpose: Initial state reading.
    77!-------------------------------------------------------------------------------
     8  USE comgeom_mod_h
    89  USE parallel_lmdz
    910  USE infotrac,    ONLY: nqtot, tracers, niso, iqIsoPha, iH2O, isoName, &
     
    3031
    3132
    32   include "comgeom.h"
    3333  include "description.h"
    3434  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/dynredem_loc.f90

    r5272 r5281  
    44! Write the NetCDF restart file (initialization).
    55!-------------------------------------------------------------------------------
     6  USE comgeom_mod_h
    67  USE IOIPSL
    78  USE parallel_lmdz
     
    2324
    2425  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    25 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     26  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    2627          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    27 IMPLICIT NONE
    28 
    29 
    30   include "comgeom.h"
     28  USE comgeom_mod_h
     29  IMPLICIT NONE
     30
    3131  include "description.h"
    3232  include "iniprint.h"
     
    3434! Arguments:
    3535  CHARACTER(LEN=*), INTENT(IN) :: fichnom          !--- FILE NAME
    36   INTEGER,          INTENT(IN) :: iday_end         !--- 
     36  INTEGER,          INTENT(IN) :: iday_end         !---
    3737  REAL,             INTENT(IN) :: phis(ijb_u:ije_u)!--- GROUND GEOPOTENTIAL
    3838!===============================================================================
     
    7979  tab_cntrl(19) = preff
    8080
    81 !    .....    parameters for zoom    ......   
     81!    .....    parameters for zoom    ......
    8282  tab_cntrl(20) = clon
    8383  tab_cntrl(21) = clat
     
    178178                          err, modname, fil, msg
    179179  USE temps_mod, ONLY: itau_dyn, itaufin
    180  
     180
    181181  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    182182USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    186186
    187187  include "description.h"
    188   include "comgeom.h"
    189188  include "iniprint.h"
    190189!===============================================================================
  • LMDZ6/trunk/libf/dyn3dmem/enercin_loc.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute kinetic energy at sigma levels.
     7  USE comgeom_mod_h
    78  USE parallel_lmdz
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1213
    1314
    14   include "comgeom.h"
    1515!===============================================================================
    1616! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/exner_hyb_loc_m.f90

    r5272 r5281  
    11module exner_hyb_loc_m
    22
    3   IMPLICIT NONE
     3  USE comgeom_mod_h
     4    IMPLICIT NONE
    45
    56contains
     
    1415    !
    1516    !   ************************************************************************
    16     !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des 
     17    !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des
    1718    !    couches .   Pk(l) sera calcule aux milieux  des couches l ,entre les
    1819    !    pressions p(l) et p(l+1) ,definis aux interfaces des llm couches .
     
    2627    !    ( voir note de Fr.Hourdin )  ,
    2728    !
    28     !    on determine successivement , du haut vers le bas des couches, les 
    29     !    coef. alpha(llm),beta(llm) .,.,alpha(l),beta(l),,,alpha(2),beta(2), 
    30     !    puis pk(ij,1). Ensuite ,on calcule,du bas vers le haut des couches, 
     29    !    on determine successivement , du haut vers le bas des couches, les
     30    !    coef. alpha(llm),beta(llm) .,.,alpha(l),beta(l),,,alpha(2),beta(2),
     31    !    puis pk(ij,1). Ensuite ,on calcule,du bas vers le haut des couches,
    3132    !     pk(ij,l)  donne  par la relation (2),  pour l = 2 a l = llm .
    3233    !
     
    4546
    4647
    47     include "comgeom.h"
    4848
    4949    INTEGER  ngrid
  • LMDZ6/trunk/libf/dyn3dmem/exner_milieu_loc_m.f90

    r5272 r5281  
    11module exner_milieu_loc_m
    22
    3   IMPLICIT NONE
     3  USE comgeom_mod_h
     4    IMPLICIT NONE
    45
    56contains
     
    1516    !
    1617    !   ************************************************************************
    17     !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des 
     18    !    Calcule la fonction d'Exner pk = Cp * (p/preff) ** kappa , aux milieux des
    1819    !    couches .   Pk(l) sera calcule aux milieux  des couches l ,entre les
    1920    !    pressions p(l) et p(l+1) ,definis aux interfaces des llm couches .
     
    2324    !
    2425    !     WARNING : CECI est une version speciale de exner_hyb originale
    25     !               Utilise dans la version martienne pour pouvoir 
     26    !               Utilise dans la version martienne pour pouvoir
    2627    !               tourner avec des coordonnees verticales complexe
    27     !              => Il ne verifie PAS la condition la proportionalite en 
     28    !              => Il ne verifie PAS la condition la proportionalite en
    2829    !              energie totale/ interne / potentielle (F.Forget 2001)
    2930    !    ( voir note de Fr.Hourdin )  ,
     
    3334    USE comconst_mod, ONLY: cpp, kappa, r, jmp1
    3435    USE comvert_mod, ONLY: preff
    35    
     36
    3637    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    3738USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    4142
    4243
    43     include "comgeom.h"
    4444
    4545    INTEGER  ngrid
  • LMDZ6/trunk/libf/dyn3dmem/flumass_loc.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute mass flux at s levels.
     7  USE comgeom_mod_h
    78  USE parallel_lmdz
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1213
    1314
    14   include "comgeom.h"
    1515!===============================================================================
    1616! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/friction_loc.f90

    r5272 r5281  
    44!=======================================================================
    55SUBROUTINE friction_loc(ucov,vcov,pdt)
     6  USE comgeom2_mod_h
    67  USE parallel_lmdz
    78  USE control_mod
     
    2627
    2728
    28   include "comgeom2.h"
    2929  include "iniprint.h"
    3030  include "academic.h"
  • LMDZ6/trunk/libf/dyn3dmem/gcm.F90

    r5280 r5281  
    1313!  USE mod_interface_dyn_phys, ONLY: init_interface_dyn_phys
    1414!#endif
     15  USE comgeom_mod_h
    1516  USE comdissnew_mod_h
    1617  USE mod_hallo
     
    6162  !   Declarations:
    6263  !   -------------
    63   include "comgeom.h"
    6464  include "description.h"
    6565  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/gr_u_scal_loc.f90

    r5272 r5281  
    2525  !
    2626  !=======================================================================
     27  USE comgeom_mod_h
    2728  USE parallel_lmdz
    2829  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    3637
    3738
    38   INCLUDE "comgeom.h"
    3939
    4040  !   Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/gr_v_scal_loc.f90

    r5272 r5281  
    2525  !
    2626  !=======================================================================
     27  USE comgeom_mod_h
    2728  USE parallel_lmdz
    2829  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    3637
    3738
    38   INCLUDE "comgeom.h"
    3939
    4040  !   Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/gradiv2_loc.f90

    r5280 r5281  
    1313  !
    1414  !
     15  USE comgeom_mod_h
    1516  USE comdissipn_mod_h
    1617  USE parallel_lmdz
     
    2728
    2829
    29   INCLUDE "comgeom.h"
    3030  !
    3131  ! ........    variables en arguments      ........
  • LMDZ6/trunk/libf/dyn3dmem/groupe_loc.f90

    r5272 r5281  
    11subroutine groupe_loc(pext,pbaru,pbarv,pbarum,pbarvm,wm)
     2  USE comgeom2_mod_h
    23  USE parallel_lmdz
    34  USE Write_field_loc
     
    2324
    2425
    25   include "comgeom2.h"
    2626
    2727  ! integer ngroup
  • LMDZ6/trunk/libf/dyn3dmem/groupeun_loc.f90

    r5272 r5281  
    11SUBROUTINE groupeun_loc(jjmax,llmax,sb,se,jjb,jje,q)
     2  USE comgeom2_mod_h
    23  USE parallel_lmdz
    34  USE Write_Field_p
     
    1011
    1112
    12   include "comgeom2.h"
    1313
    1414  INTEGER :: jjmax,llmax,sb,se,jjb,jje
     
    138138SUBROUTINE init_groupeun_loc(airen_tab, aires_tab)
    139139
     140  USE comgeom2_mod_h
    140141  USE parallel_lmdz
    141142  USE comconst_mod, ONLY: ngroup
     
    147148
    148149
    149   include "comgeom2.h"
    150150
    151151  ! INTEGER ngroup
  • LMDZ6/trunk/libf/dyn3dmem/guide_loc_mod.f90

    r5279 r5281  
    787787  SUBROUTINE guide_zonave_u(typ,vsize,field)
    788788
     789    USE comgeom_mod_h
    789790    USE comconst_mod, ONLY: pi
    790791
    791792    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    792 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     793    USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    793794          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    794795IMPLICIT NONE
     
    796797
    797798
    798     INCLUDE "comgeom.h"
    799799
    800800    ! input/output variables
     
    862862  SUBROUTINE guide_zonave_v(typ,hsize,vsize,field)
    863863
     864    USE comgeom_mod_h
    864865    USE comconst_mod, ONLY: pi
    865866
     
    871872
    872873
    873     INCLUDE "comgeom.h"
    874874
    875875    ! input/output variables
     
    932932!=======================================================================
    933933  SUBROUTINE guide_interp(psi,teta)
    934     use exner_hyb_loc_m, only: exner_hyb_loc
     934    USE comgeom2_mod_h
     935  use exner_hyb_loc_m, only: exner_hyb_loc
    935936    use exner_milieu_loc_m, only: exner_milieu_loc
    936937  USE parallel_lmdz
     
    946947
    947948
    948   include "comgeom2.h"
    949949
    950950  REAL, DIMENSION (iip1,jjb_u:jje_u),     INTENT(IN) :: psi ! Psol gcm
     
    14311431
    14321432    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1433 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     1433    USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    14341434          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    1435 implicit none
    1436 
    1437 
    1438 
    1439     include "comgeom2.h"
     1435    USE comgeom2_mod_h
     1436    implicit none
     1437
    14401438
    14411439! input arguments :
     
    22022200
    22032201    USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2204 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     2202    USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    22052203          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     2204    USE comgeom2_mod_h
    22062205IMPLICIT NONE
    22072206
    22082207
    22092208
    2210     INCLUDE "comgeom2.h"
    22112209
    22122210    ! Variables entree
     
    24242422
    24252423subroutine dump2du(var,varname)
    2426 use parallel_lmdz
     2424     use parallel_lmdz
    24272425use mod_hallo
    24282426USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    24602458subroutine dumpall
    24612459     USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    2462 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     2460     USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    24632461          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
     2462     USE comgeom_mod_h
    24642463implicit none
    24652464
    24662465
    2467      include "comgeom.h"
    24682466     call barrier
    24692467     call dump2du(alpha_u(ijb_u:ije_u),'  alpha_u couche 1')
  • LMDZ6/trunk/libf/dyn3dmem/iniacademic_loc.f90

    r5272 r5281  
    44SUBROUTINE iniacademic_loc(vcov,ucov,teta,q,masse,ps,phis,time_0)
    55
     6  USE comgeom_mod_h
    67  USE filtreg_mod, ONLY: inifilr
    78  USE infotrac,    ONLY: nqtot, niso, iqIsoPha, tracers, isoName, addPhase
     
    3738
    3839
    39   include "comgeom.h"
    4040  include "academic.h"
    4141  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/initdynav_loc.f90

    r5272 r5281  
    55
    66  ! This routine needs IOIPSL
    7    USE IOIPSL
     7   USE comgeom_mod_h
     8  USE IOIPSL
    89
    910   USE parallel_lmdz
     
    4950
    5051
    51   include "comgeom.h"
    5252  include "description.h"
    5353  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/initfluxsto_p.f90

    r5272 r5281  
    77
    88  ! This routine needs IOIPSL
    9    USE IOIPSL
     9   USE comgeom_mod_h
     10  USE IOIPSL
    1011
    1112   USE parallel_lmdz
     
    5051
    5152
    52   include "comgeom.h"
    5353  include "description.h"
    5454  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/inithist_loc.f90

    r5272 r5281  
    55
    66  ! This routine needs IOIPSL
    7    USE IOIPSL
     7   USE comgeom_mod_h
     8  USE IOIPSL
    89
    910   USE parallel_lmdz
     
    4748
    4849
    49   include "comgeom.h"
    5050  include "description.h"
    5151  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/integrd_loc.f90

    r5272 r5281  
    55        (  nq,vcovm1,ucovm1,tetam1,psm1,massem1, &
    66        dv,du,dteta,dq,dp,vcov,ucov,teta,q,ps0,masse,phis) !,finvmaold)
     7  USE comgeom_mod_h
    78  USE parallel_lmdz
    89  USE control_mod
     
    3940
    4041
    41   include "comgeom.h"
    4242  include "iniprint.h"
    4343
  • LMDZ6/trunk/libf/dyn3dmem/laplacien_gam_loc.f90

    r5272 r5281  
    1111  !  divgra     est  un argument  de sortie pour le s-prog
    1212  !
     13  USE comgeom_mod_h
    1314  USE parallel_lmdz
    1415  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222
    2323  !
  • LMDZ6/trunk/libf/dyn3dmem/laplacien_loc.f90

    r5272 r5281  
    99  !  divgra     est  un argument  de sortie pour le s-prog
    1010  !
     11  USE comgeom_mod_h
    1112  USE parallel_lmdz
    1213  USE mod_filtreg_p
     
    1819
    1920
    20   INCLUDE "comgeom.h"
    2121
    2222  !
  • LMDZ6/trunk/libf/dyn3dmem/laplacien_rot_loc.f90

    r5272 r5281  
    1010  !  rotout           est  un argument  de sortie pour le s-prog
    1111  !
     12  USE comgeom_mod_h
    1213  USE parallel_lmdz
    1314  USE mod_filtreg_p
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222
    2323  !
  • LMDZ6/trunk/libf/dyn3dmem/laplacien_rotgam_loc.f90

    r5272 r5281  
    99  !  divgra     est  un argument  de sortie pour le s-prog
    1010  !
     11  USE comgeom_mod_h
    1112  USE parallel_lmdz
    1213  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1718
    1819
    19   INCLUDE "comgeom.h"
    2020
    2121  !
  • LMDZ6/trunk/libf/dyn3dmem/leapfrog_loc.f90

    r5280 r5281  
    22        masse0,phis0,q0,time_0)
    33
    4    USE comdissnew_mod_h
     4   USE comgeom_mod_h
     5  USE comdissnew_mod_h
    56   USE misc_mod
    67   USE parallel_lmdz
     
    7677  !   Declarations:
    7778  !   -------------
    78   include "comgeom.h"
    7979  include "description.h"
    8080  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/massbar_loc.f90

    r5272 r5281  
    66! Purpose: Compute air mass mean along X and Y in each cell.
    77! See iniconst for more details.
     8  USE comgeom_mod_h
    89  USE parallel_lmdz
    910  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1314
    1415
    15   include "comgeom.h"
    1616!===============================================================================
    1717! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/massbarxy_loc.f90

    r5277 r5281  
    66! Purpose: Compute air mass mean along X and Y in each cell.
    77! See iniconst for more details.
     8  USE comgeom_mod_h
    89  USE parallel_lmdz
    910  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1314
    1415
    15   include "comgeom.h"
    1616!===============================================================================
    1717! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/massdair_loc.f90

    r5272 r5281  
    11SUBROUTINE massdair_loc( p, masse )
     2  USE comgeom_mod_h
    23  USE parallel_lmdz
    34  !
     
    2122
    2223
    23   include "comgeom.h"
    2424  !
    2525  !  .....   arguments  ....
  • LMDZ6/trunk/libf/dyn3dmem/mod_xios_dyn3dmem.f90

    r5272 r5281  
    3737
    3838
     39     USE comgeom_mod_h
    3940     USE comvert_mod, ONLY: presnivs
    4041     USE parallel_lmdz
     
    4748
    4849
    49      INCLUDE 'comgeom.h'
    5050
    5151     TYPE(xios_duration) :: tstep_xios
  • LMDZ6/trunk/libf/dyn3dmem/nxgrad_gam_loc.f90

    r5272 r5281  
    99  !   x  et y    sont des arguments de sortie pour le s-prog
    1010  !
     11  USE comgeom_mod_h
    1112  USE parallel_lmdz
    1213
     
    1819
    1920
    20   INCLUDE "comgeom.h"
    2121  INTEGER :: klevel
    2222  REAL :: rot( ijb_v:ije_v,klevel )
  • LMDZ6/trunk/libf/dyn3dmem/nxgrad_loc.f90

    r5272 r5281  
    99  !   x  et y    sont des arguments de sortie pour le s-prog
    1010  !
     11  USE comgeom_mod_h
    1112  USE parallel_lmdz
    1213  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1718
    1819
    19   INCLUDE "comgeom.h"
    2020  INTEGER :: klevel
    2121  REAL :: rot( ijb_v:ije_v,klevel ),x( ijb_u:ije_u,klevel )
  • LMDZ6/trunk/libf/dyn3dmem/rotat_nfil_loc.f90

    r5272 r5281  
    1010  !        rot          est  un argument  de sortie pour le s-prog
    1111  !
     12  USE comgeom_mod_h
    1213  USE parallel_lmdz
    1314  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1819
    1920
    20   INCLUDE "comgeom.h"
    2121  !
    2222  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3dmem/rotat_p.f90

    r5272 r5281  
    1010  !        rot          est  un argument  de sortie pour le s-prog
    1111  !
     12  USE comgeom_mod_h
    1213  USE parallel_lmdz
    1314  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
     
    1819
    1920
    20   INCLUDE "comgeom.h"
    2121  !
    2222  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3dmem/rotatf_loc.f90

    r5272 r5281  
    1010  !        rot          est  un argument  de sortie pour le s-prog
    1111  !
     12  USE comgeom_mod_h
    1213  USE parallel_lmdz
    1314  USE mod_filtreg_p
     
    1920
    2021
    21   INCLUDE "comgeom.h"
    2222  !
    2323  !   .....  variables en arguments  ......
  • LMDZ6/trunk/libf/dyn3dmem/sw_case_williamson91_6_loc.f90

    r5272 r5281  
    2626  !
    2727  !=======================================================================
     28  USE comgeom_mod_h
    2829  USE parallel_lmdz
    2930  USE comconst_mod, ONLY: cpp, omeg, rad
     
    4041
    4142
    42   include "comgeom.h"
    4343  include "iniprint.h"
    4444
  • LMDZ6/trunk/libf/dyn3dmem/top_bound_loc.f90

    r5280 r5281  
    33!
    44SUBROUTINE top_bound_loc(vcov,ucov,teta,masse,dt)
     5  USE comgeom2_mod_h
    56  USE comdissipn_mod_h
    67  USE parallel_lmdz
     
    1617
    1718
    18   include "comgeom2.h"
    1919
    2020
  • LMDZ6/trunk/libf/dyn3dmem/tourpot_loc.f90

    r5272 r5281  
    55!-------------------------------------------------------------------------------
    66! Purpose: Compute potential vorticity.
     7  USE comgeom_mod_h
    78  USE parallel_lmdz
    89  USE mod_filtreg_p
     
    1314
    1415
    15   include "comgeom.h"
    1616!===============================================================================
    1717! Arguments:
  • LMDZ6/trunk/libf/dyn3dmem/vlsplt_loc.F90

    r5272 r5281  
    417417  !
    418418  !   --------------------------------------------------------------------
     419  USE comgeom_mod_h
    419420  USE parallel_lmdz
    420421  USE infotrac, ONLY : nqtot,tracers, & ! CRisi                 &
     
    428429
    429430
    430   include "comgeom.h"
    431431  !
    432432  !
  • LMDZ6/trunk/libf/dyn3dmem/vlspltqs_loc.F90

    r5272 r5281  
    422422  !
    423423  !   --------------------------------------------------------------------
     424  USE comgeom_mod_h
    424425  USE parallel_lmdz
    425426  USE infotrac, ONLY : nqtot,tracers, & ! CRisi                 &
     
    433434
    434435
    435   include "comgeom.h"
    436436  include "iniprint.h"
    437437  !
  • LMDZ6/trunk/libf/dyn3dmem/writedyn_xios.f90

    r5272 r5281  
    55     &                           masse,ps,phis)
    66
     7      USE comgeom_mod_h
    78      USE lmdz_xios
    89      USE parallel_lmdz
     
    1314      USE temps_mod, ONLY: itau_dyn
    1415      USE mod_xios_dyn3dmem, ONLY : writefield_dyn_u, writefield_dyn_v
    15      
     16
    1617      USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    1718USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    3940
    4041
    41       include "comgeom.h"
    4242      include "description.h"
    4343      include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/writedynav_loc.f90

    r5272 r5281  
    66
    77  ! This routine needs IOIPSL
     8  USE comgeom_mod_h
    89  USE ioipsl
    910
     
    4849
    4950
    50   include "comgeom.h"
    5151  include "description.h"
    5252  include "iniprint.h"
  • LMDZ6/trunk/libf/dyn3dmem/writehist_loc.f90

    r5272 r5281  
    66
    77  ! This routine needs IOIPSL
     8  USE comgeom_mod_h
    89  USE ioipsl
    910
     
    4849
    4950
    50   include "comgeom.h"
    5151  include "description.h"
    5252  include "iniprint.h"
  • LMDZ6/trunk/libf/dynphy_lonlat/calfis.f90

    r5272 r5281  
    2929  !    Auteur :  P. Le Van, F. Hourdin
    3030  !   .........
     31  USE comgeom2_mod_h
    3132  USE infotrac, ONLY: nqtot, tracers
    3233  USE control_mod, ONLY: planet_type, nsplit_phys
     
    9495  PARAMETER( ngridmx = 2+(jjm-1)*iim - 1/jjm   )
    9596
    96   include "comgeom2.h"
    9797  include "iniprint.h"
    9898
  • LMDZ6/trunk/libf/dynphy_lonlat/calfis_loc.F90

    r5272 r5281  
    5151  USE lmdz_cppkeys_wrapper, ONLY: CPPKEY_PHYS
    5252#ifdef CPP_PARA
     53  USE comgeom2_mod_h
    5354  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    5455  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    111112  PARAMETER( ngridmx = 2+(jjm-1)*iim - 1/jjm   )
    112113
    113   include "comgeom2.h"
    114114  include "iniprint.h"
    115115  !    Arguments :
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/ce0l.F90

    r5272 r5281  
    3939#endif
    4040
     41  USE comgeom2_mod_h
    4142  USE comconst_mod, ONLY: cpp, daysec, dtphys, dtvr, g, kappa, omeg, r, rad, &
    4243                          pi, jmp1
     
    5556
    5657
    57   include "comgeom2.h"
    5858  include "iniprint.h"
    5959 
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/etat0dyn_netcdf.F90

    r5280 r5281  
    4545          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    4646  USE comdissnew_mod_h
     47  USE comgeom2_mod_h
    4748IMPLICIT NONE
    4849
     
    5354
    5455
    55   include "comgeom2.h"
    5656  REAL, SAVE :: deg2rad
    5757  INTEGER,            SAVE      :: iml_dyn, jml_dyn, llm_dyn, ttm_dyn, fid_dyn
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/etat0phys_netcdf.f90

    r5273 r5281  
    5757          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    5858  USE dimsoil_mod_h, ONLY: nsoilmx
     59  USE comgeom2_mod_h
    5960  PRIVATE
    6061  PUBLIC :: etat0phys_netcdf
    6162
    6263  include "iniprint.h"
    63   include "comgeom2.h"
    6464  include "clesphys.h"
    6565  REAL, SAVE :: deg2rad
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/iniphysiq_mod.F90

    r5272 r5281  
    3838  USE bands, ONLY : distrib_phys
    3939#endif
    40   USE mod_phys_lmdz_omp_data, ONLY: klon_omp
     40  USE comgeom_mod_h
     41  USE mod_phys_lmdz_omp_data, ONLY: klon_omp
    4142  USE ioipsl_getin_p_mod, ONLY: getin_p
    4243  USE slab_heat_transp_mod, ONLY: ini_slab_transp_geom
     
    5657  include "iniprint.h"
    5758  include "tracstoke.h"
    58   include "comgeom.h"
    5959
    6060  REAL, INTENT (IN) :: prad ! radius of the planet (m)
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/init_ssrf_m.f90

    r5272 r5281  
    33!*******************************************************************************
    44
     5  USE comgeom2_mod_h
    56  USE indice_sol_mod,     ONLY: is_ter, is_oce, is_oce, is_lic, epsfra
    67  USE dimphy,             ONLY: klon, zmasq
     
    2021  PUBLIC :: start_init_subsurf
    2122  include "iniprint.h"
    22   include "comgeom2.h"
    2323
    2424CONTAINS
  • LMDZ6/trunk/libf/dynphy_lonlat/phylmd/limit_netcdf.F90

    r5272 r5281  
    7070!-------------------------------------------------------------------------------
    7171#ifndef CPP_1D
     72  USE comgeom2_mod_h
    7273  USE indice_sol_mod
    7374  USE netcdf,             ONLY: NF90_OPEN,    NF90_CREATE,  NF90_CLOSE,        &
     
    8283  USE lmdz_cppkeys_wrapper, ONLY: nf90_format
    8384  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    84 USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     85  USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
    8586          ip1jmi1, ijp1llm, ijmllm, mvar, jcfil, jcfllm
    86 IMPLICIT NONE
     87  USE comgeom2_mod_h
     88  IMPLICIT NONE
    8789!-------------------------------------------------------------------------------
    8890! Arguments:
     
    9395  REAL, DIMENSION(iip1,jjp1), INTENT(INOUT) :: phis   ! ground geopotential
    9496  LOGICAL,                    INTENT(IN)    :: extrap ! SST extrapolation flag
    95 !-------------------------------------------------------------------------------
    96 ! Local variables:
    97   include "comgeom2.h"
    9897
    9998!--- INPUT NETCDF FILES AND VARIABLES NAMES ------------------------------------
     
    339338
    340339
    341   include "comgeom2.h"
    342340!-----------------------------------------------------------------------------
    343341! Arguments:
  • LMDZ6/trunk/libf/filtrez/filtreg_mod.F90

    r5272 r5281  
    1414  USE mod_filtre_fft_loc, ONLY : Init_filtre_fft_loc=>Init_filtre_fft    !
    1515#endif
    16   USE serre_mod, ONLY: alphax
     16  USE comgeom_mod_h
     17    USE serre_mod, ONLY: alphax
    1718  USE logic_mod, ONLY: fxyhypb, ysinus
    1819  USE comconst_mod, ONLY: maxlatfilter
     
    3233
    3334    !  -------------------------------------------------------------------
    34     include "comgeom.h"
    3535    include "coefils.h"
    3636
  • LMDZ6/trunk/libf/filtrez/inifgn.F90

    r5272 r5281  
    66  !    ...  H.Upadyaya , O.Sharma  ...
    77  !
     8  USE comgeom_mod_h
    89  USE dimensions_mod, ONLY: iim, jjm, llm, ndm
    910USE paramet_mod_h, ONLY: iip1, iip2, iip3, jjp1, llmp1, llmp2, llmm1, kftd, ip1jm, ip1jmp1, &
     
    1314
    1415
    15   include "comgeom.h"
    1616
    1717  !
  • LMDZ6/trunk/libf/phylmd/dyn1d/comgeom2_mod_h.f90

    r5280 r5281  
    1 link ../../dyn3d_common/comgeom2.h
     1link ../../dyn3d_common/comgeom2_mod_h.f90
  • LMDZ6/trunk/libf/phylmd/dyn1d/comgeom_mod_h.f90

    r5280 r5281  
    1 link ../../dyn3d_common/comgeom.h
     1link ../../dyn3d_common/comgeom_mod_h.f90
Note: See TracChangeset for help on using the changeset viewer.