Changeset 1785 for LMDZ5/trunk/libf


Ignore:
Timestamp:
Jul 16, 2013, 11:22:04 AM (11 years ago)
Author:
Ehouarn Millour
Message:

Transformation de l'include indicesol.h en un module indice_sol_mod et modification des appels dans tous les fichiers concernés.
Aucun changement des résultats ni des sorties du modèle vs 1784.
UG

...................................................

Replacement of the indicesol.h include by a module named indice_sol_mod. Modification of the calls in every affected files.
Results and outputs of simulations are unchanged in comparison with rev 1784.
UG

Location:
LMDZ5/trunk/libf
Files:
1 added
1 deleted
62 edited

Legend:

Unmodified
Added
Removed
  • LMDZ5/trunk/libf/dyn3d/ce0l.F90

    r1615 r1785  
    2020  USE comgeomphy
    2121  USE infotrac
     22  USE indice_sol_mod
    2223
    2324#ifdef CPP_IOIPSL
     
    3637#include "dimensions.h"
    3738#include "paramet.h"
    38 #include "indicesol.h"
     39!#include "indicesol.h"
    3940#include "iniprint.h"
    4041#include "temps.h"
  • LMDZ5/trunk/libf/dyn3d/gcm.F

    r1697 r1785  
    1616      USE infotrac
    1717      USE control_mod
     18
     19#ifdef INCA
     20! Only INCA needs these informations (from the Earth's physics)
     21      USE indice_sol_mod
     22#endif
    1823
    1924!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
     
    7782#ifdef INCA
    7883! Only INCA needs these informations (from the Earth's physics)
    79 #include "indicesol.h"
     84!#include "indicesol.h"
    8085#endif
    8186      INTEGER         longcles
  • LMDZ5/trunk/libf/dyn3dmem/ce0l.F90

    r1673 r1785  
    2323  USE infotrac
    2424  USE parallel, ONLY: finalize_parallel
     25  USE indice_sol_mod
    2526
    2627#ifdef CPP_IOIPSL
     
    3940#include "dimensions.h"
    4041#include "paramet.h"
    41 #include "indicesol.h"
     42!#include "indicesol.h"
    4243#include "iniprint.h"
    4344#include "temps.h"
  • LMDZ5/trunk/libf/dyn3dmem/gcm.F

    r1749 r1785  
    1919      USE filtreg_mod
    2020      USE control_mod
     21
     22#ifdef INCA
     23! Only INCA needs these informations (from the Earth's physics)
     24      USE indice_sol_mod
     25#endif
    2126
    2227#ifdef CPP_PHYS
     
    7580#ifdef INCA
    7681! Only INCA needs these informations (from the Earth's physics)
    77 #include "indicesol.h"
     82!#include "indicesol.h"
    7883#endif
    7984
  • LMDZ5/trunk/libf/dyn3dpar/ce0l.F90

    r1615 r1785  
    2323  USE infotrac
    2424  USE parallel, ONLY: finalize_parallel
     25  USE indice_sol_mod
    2526
    2627#ifdef CPP_IOIPSL
     
    3940#include "dimensions.h"
    4041#include "paramet.h"
    41 #include "indicesol.h"
     42!#include "indicesol.h"
    4243#include "iniprint.h"
    4344#include "temps.h"
  • LMDZ5/trunk/libf/dyn3dpar/gcm.F

    r1697 r1785  
    1919      USE filtreg_mod
    2020      USE control_mod
     21
     22#ifdef INCA
     23! Only INCA needs these informations (from the Earth's physics)
     24      USE indice_sol_mod
     25#endif
    2126
    2227#ifdef CPP_PHYS
     
    7580#ifdef INCA
    7681! Only INCA needs these informations (from the Earth's physics)
    77 #include "indicesol.h"
     82!#include "indicesol.h"
    7883#endif
    7984
  • LMDZ5/trunk/libf/phy1d/lmdz1d.F

    r1780 r1785  
    22
    33      USE ioipsl, only: ju2ymds, ymds2ju, ioconf_calendar
    4       use phys_state_var_mod
    5       use comgeomphy
    6       use dimphy
    7       use surface_data, only : type_ocean,ok_veget
    8       use pbl_surface_mod, only : ftsoil, pbl_surface_init,
    9      $                            pbl_surface_final
    10       use fonte_neige_mod, only : fonte_neige_init, fonte_neige_final
    11 
    12       use infotrac ! new
    13       use control_mod
     4      USE phys_state_var_mod
     5      USE comgeomphy
     6      USE dimphy
     7      USE surface_data, only : type_ocean,ok_veget
     8      USE pbl_surface_mod, only : pbl_surface_init, pbl_surface_final
     9      USE fonte_neige_mod, only : fonte_neige_init, fonte_neige_final
     10
     11      USE infotrac ! new
     12      USE control_mod
     13      USE indice_sol_mod
    1414
    1515      implicit none
     
    2121#include "clesphys.h"
    2222#include "dimsoil.h"
    23 #include "indicesol.h"
     23!#include "indicesol.h"
    2424
    2525#include "comvert.h"
    2626#include "compar1d.h"
    2727#include "flux_arp.h"
    28 #include "tsoilnudge.h"
    2928#include "fcg_gcssold.h"
    3029!!!#include "fbforcing.h"
     
    8887
    8988        integer :: kmax = llm
    90         integer nlev_max,llm700
    91         parameter (nlev_max = 1000)
     89        integer nlev_max
     90        parameter (nlev_max = 100)
    9291        real timestep, frac, timeit
    9392        real height(nlev_max),tttprof(nlev_max),qtprof(nlev_max),
     
    10099c        integer :: forcing_type
    101100        logical :: forcing_les     = .false.
    102         logical :: forcing_armcu   = .false.
     101        logical :: forcing_armcu  = .false.
    103102        logical :: forcing_rico    = .false.
    104103        logical :: forcing_radconv = .false.
    105104        logical :: forcing_toga    = .false.
    106105        logical :: forcing_twpice  = .false.
    107         logical :: forcing_amma    = .false.
    108106        logical :: forcing_GCM2SCM = .false.
    109107        logical :: forcing_GCSSold = .false.
    110         logical :: forcing_sandu   = .false.
    111         logical :: forcing_astex   = .false.
    112         logical :: forcing_fire    = .false.
    113108        integer :: type_ts_forcing ! 0 = SST constant; 1 = SST read from a file
    114109!                                                            (cf read_tsurf1d.F)
    115110
    116111!vertical advection computation
    117 !       real d_t_z(llm), d_q_z(llm)
    118 !       real d_t_dyn_z(llm), d_q_dyn_z(llm)
    119 !       real zz(llm)
    120 !       real zfact
     112        real d_t_z(llm), d_q_z(llm)
     113        real d_t_dyn_z(llm), d_q_dyn_z(llm)
     114        real zz(llm)
     115        real zfact
    121116
    122117!flag forcings
     
    135130      real :: pzero=1.e5
    136131      real :: play (llm),zlay (llm),sig_s(llm),plev(llm+1)
    137       real :: playd(llm),zlayd(llm),ap_amma(llm+1),bp_amma(llm+1),poub
     132      real :: playd(llm),zlayd(llm)
    138133
    139134!---------------------------------------------------------------------
     
    143138      integer :: iq
    144139      real :: phi(llm)
    145       real :: teta(llm),tetal(llm),temp(llm),u(llm),v(llm),w(llm)
    146140      real :: rlat_rad(1),rlon_rad(1)
     141      real :: teta(llm),temp(llm),u(llm),v(llm)
    147142      real :: omega(llm+1),omega2(llm),rho(llm+1)
    148143      real :: ug(llm),vg(llm),fcoriolis
     
    202197!  Fichiers et d'autres variables
    203198!---------------------------------------------------------------------
    204       real ttt,bow,q1
     199      real ttt
    205200      integer :: ierr,k,l,i,it=1,mxcalc
    206201      integer jjmp1
     
    258253!             initial profiles from RICO files
    259254!             LS convergence imposed from RICO files
    260 !forcing_type = 6 ==> forcing_amma = .true.
    261 !             initial profiles from AMMA nc file
    262 !             LS convergence, omega and surface fluxes imposed from AMMA file 
    263255!forcing_type = 40 ==> forcing_GCSSold = .true.
    264256!             initial profile from GCSS file
    265257!             LS convergence imposed from GCSS file
    266 !forcing_type = 59 ==> forcing_sandu = .true.
    267 !             initial profiles from sanduref file: see prof.inp.001
    268 !             SST varying with time and divergence constante: see ifa_sanduref.txt file
    269 !             Radiation has to be computed interactively
    270 !forcing_type = 60 ==> forcing_astex = .true.
    271 !             initial profiles from file: see prof.inp.001
    272 !             SST,divergence,ug,vg,ufa,vfa varying with time : see ifa_astex.txt file
    273 !             Radiation has to be computed interactively
    274258!forcing_type = 61 ==> forcing_armcu = .true.
    275 !             initial profiles from file: see prof.inp.001
    276 !             sensible and latent heat flux imposed: see ifa_arm_cu_1.txt
    277 !             large scale advective forcing & radiative tendencies applied below 1000m: see ifa_arm_cu_2.txt
    278 !             use geostrophic wind ug=10m/s vg=0m/s. Duration of the case 53100s
    279 !             Radiation to be switched off
     259!             initial profile from arm_cu file
     260!             LS convergence imposed from arm_cu file
    280261!
    281262      if (forcing_type .eq.0) THEN
     
    291272      elseif (forcing_type .eq.5) THEN
    292273       forcing_rico = .true.
    293       elseif (forcing_type .eq.6) THEN
    294        forcing_amma = .true.
    295274      elseif (forcing_type .eq.40) THEN
    296275       forcing_GCSSold = .true.
    297       elseif (forcing_type .eq.59) THEN
    298        forcing_sandu   = .true.
    299       elseif (forcing_type .eq.60) THEN
    300        forcing_astex   = .true.
    301276      elseif (forcing_type .eq.61) THEN
    302277       forcing_armcu = .true.
     
    304279      else
    305280       write (*,*) 'ERROR : unknown forcing_type ', forcing_type
    306        stop 'Forcing_type should be 0,1,2,3,4,5,6 or 40,59,60,61'
     281       stop 'Forcing_type should be 0,1,2,3 or 40'
    307282      ENDIF
    308283      print*,"forcing type=",forcing_type
     
    314289
    315290        type_ts_forcing = 0
    316         if (forcing_toga .or. forcing_sandu .or. forcing_astex)
    317      :    type_ts_forcing = 1
     291        if (forcing_toga) type_ts_forcing = 1
    318292
    319293!---------------------------------------------------------------------
     
    354328c Special case for arm_cu which lasts less than one day : 53100s !! (MPL 20111026)
    355329      IF(forcing_type .EQ. 61) fnday=53100./86400.
    356 c Special case for amma which lasts less than one day : 64800s !! (MPL 20120216)
    357       IF(forcing_type .EQ. 6) fnday=64800./86400.
    358330      annee_ref = anneeref
    359331      mois = 1
     
    365337      day_ini = day
    366338      day_end = day_ini + nday
    367 
    368       IF (forcing_type .eq.2) THEN
    369339! Convert the initial date of Toga-Coare to Julian day
    370340      call ymds2ju
    371341     $ (year_ini_toga,mth_ini_toga,day_ini_toga,heure,day_ju_ini_toga)
    372342
    373       ELSEIF (forcing_type .eq.4) THEN
    374343! Convert the initial date of TWPICE to Julian day
    375344      call ymds2ju
    376345     $ (year_ini_twpi,mth_ini_twpi,day_ini_twpi,heure_ini_twpi
    377346     $ ,day_ju_ini_twpi)
    378       ELSEIF (forcing_type .eq.6) THEN
    379 ! Convert the initial date of AMMA to Julian day
    380       call ymds2ju
    381      $ (year_ini_amma,mth_ini_amma,day_ini_amma,heure_ini_amma
    382      $ ,day_ju_ini_amma)
    383 
    384       ELSEIF (forcing_type .eq.59) THEN
    385 ! Convert the initial date of Sandu case to Julian day
    386       call ymds2ju
    387      $   (year_ini_sandu,mth_ini_sandu,day_ini_sandu,
    388      $    time_ini*3600.,day_ju_ini_sandu)
    389 
    390       ELSEIF (forcing_type .eq.60) THEN
    391 ! Convert the initial date of Astex case to Julian day
    392       call ymds2ju
    393      $   (year_ini_astex,mth_ini_astex,day_ini_astex,
    394      $    time_ini*3600.,day_ju_ini_astex)
    395 
    396       ELSEIF (forcing_type .eq.61) THEN
    397 
    398 ! Convert the initial date of Arm_cu case to Julian day
     347
     348! Convert the initial date of Arm_cu to Julian day
    399349      call ymds2ju
    400350     $ (year_ini_armcu,mth_ini_armcu,day_ini_armcu,heure_ini_armcu
    401351     $ ,day_ju_ini_armcu)
    402       ENDIF
    403352
    404353      daytime = day + time_ini/24. ! 1st day and initial time of the simulation
     
    487436ccc      zlay=-rd*300.*log(play/psurf)/rg ! moved after reading profiles
    488437
    489       IF (forcing_type .eq. 59) THEN
    490 ! pour forcing_sandu, on cherche l'indice le plus proche de 700hpa#3000m
    491438      write(*,*) '***********************'
    492439      do l = 1, llm
    493440       write(*,*) 'l,play(l),presnivs(l): ',l,play(l),presnivs(l)
    494        if (trouve_700 .and. play(l).le.70000) then
    495          llm700=l
    496          print *,'llm700,play=',llm700,play(l)/100.
    497          trouve_700= .false.
    498        endif
    499441      enddo
    500442      write(*,*) '***********************'
    501       ENDIF
    502443
    503444c
     
    575516        agesno  = xagesno
    576517        tsoil(:,:,:)=tsurf
    577 !------ AMMA 2e run avec modele sol et rayonnement actif (MPL 23052012)
    578 !       tsoil(1,1,1)=299.18
    579 !       tsoil(1,2,1)=300.08
    580 !       tsoil(1,3,1)=301.88
    581 !       tsoil(1,4,1)=305.48
    582 !       tsoil(1,5,1)=308.00
    583 !       tsoil(1,6,1)=308.00
    584 !       tsoil(1,7,1)=308.00
    585 !       tsoil(1,8,1)=308.00
    586 !       tsoil(1,9,1)=308.00
    587 !       tsoil(1,10,1)=308.00
    588 !       tsoil(1,11,1)=308.00
    589 !-----------------------------------------------------------------------
    590518        call pbl_surface_init(qsol, fder, snsrf, qsurfsrf,
    591519     &                                    evap, frugs, agesno, tsoil)
     
    821749       endif
    822750
    823        if (forcing_toga .or. forcing_GCSSold .or. forcing_twpice
    824      :    .or.forcing_amma) then
     751       if (forcing_toga .or. forcing_GCSSold .or. forcing_twpice) then
    825752         fcoriolis=0.0 ; ug=0. ; vg=0.
    826753       endif
     
    887814
    888815        teta=temp*(pzero/play)**rkappa
    889 !
    890 !---------------------------------------------------------------------
    891 !   Nudge soil temperature if requested
    892 !---------------------------------------------------------------------
    893 
    894       IF (nudge_tsoil) THEN
    895        ftsoil(1,isoil_nudge,:) = ftsoil(1,isoil_nudge,:)
    896      .  -timestep/tau_soil_nudge*(ftsoil(1,isoil_nudge,:)-Tsoil_nudge)
    897       ENDIF
    898816
    899817!---------------------------------------------------------------------
  • LMDZ5/trunk/libf/phy1d/ocean_forced_mod.F90

    r1607 r1785  
    3131    USE limit_read_mod
    3232    USE mod_grid_phy_lmdz
    33     INCLUDE "indicesol.h"
     33    USE indice_sol_mod
     34!    INCLUDE "indicesol.h"
    3435    INCLUDE "YOMCST.h"
    3536
     
    145146    USE limit_read_mod
    146147    USE fonte_neige_mod,  ONLY : fonte_neige
    147 
    148     INCLUDE "indicesol.h"
     148    USE indice_sol_mod
     149
     150!    INCLUDE "indicesol.h"
    149151    INCLUDE "dimsoil.h"
    150152    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phy1d/pbl_surface_mod.F90

    r1780 r1785  
    2323  USE coef_diff_turb_mod,  ONLY : coef_diff_turb
    2424  USE control_mod
     25  USE indice_sol_mod
    2526
    2627
     
    5758! for the index of the different surfaces and tests the choice of type of ocean.
    5859
    59     INCLUDE "indicesol.h"
    6060    INCLUDE "dimsoil.h"
    6161    INCLUDE "iniprint.h"
     
    250250    IMPLICIT NONE
    251251
    252     INCLUDE "indicesol.h"
    253252    INCLUDE "dimsoil.h"
    254253    INCLUDE "YOMCST.h"
     
    13191318       evap_rst, rugos_rst, agesno_rst, ftsoil_rst)
    13201319
    1321     INCLUDE "indicesol.h"
    13221320    INCLUDE "dimsoil.h"
    13231321
     
    13691367    ! Give default values where new fraction has appread
    13701368
    1371     INCLUDE "indicesol.h"
    13721369    INCLUDE "dimsoil.h"
    13731370    INCLUDE "clesphys.h"
  • LMDZ5/trunk/libf/phy1d/surf_land_bucket_mod.F90

    r1607 r1785  
    2626    USE mod_grid_phy_lmdz
    2727    USE mod_phys_lmdz_para
     28    USE indice_sol_mod
    2829!****************************************************************************************
    2930! Bucket calculations for surface.
    3031!
    3132    INCLUDE "clesphys.h"
    32     INCLUDE "indicesol.h"
     33!    INCLUDE "indicesol.h"
    3334    INCLUDE "dimsoil.h"
    3435    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/calbeta.F90

    r793 r1785  
    66
    77  USE dimphy
     8  USE indice_sol_mod
    89  IMPLICIT none
    910!======================================================================
     
    1314!
    1415! Calculer quelques parametres pour appliquer la couche limite
    15 ! ------------------------------------------------------------
    16   INCLUDE "indicesol.h"
    17  
     16! ------------------------------------------------------------
    1817! Variables d'entrees
    1918!****************************************************************************************
  • LMDZ5/trunk/libf/phylmd/calcul_fluxs_mod.F90

    r1107 r1785  
    1212   
    1313    USE dimphy, ONLY : klon
     14    USE indice_sol_mod
    1415
    1516! Cette routine calcule les fluxs en h et q a l'interface et eventuellement
     
    4950    INCLUDE "YOETHF.h"
    5051    INCLUDE "FCTTRE.h"
    51     INCLUDE "indicesol.h"
    5252    INCLUDE "YOMCST.h"
    5353
  • LMDZ5/trunk/libf/phylmd/calltherm.F90

    r1779 r1785  
    1717     &      ,alp_bl_conv,alp_bl_stat &
    1818!!! fin nrlmd le 10/04/2012
    19      &      ,zqla,ztva )
     19     &                    )
    2020
    2121      USE dimphy
     22      USE indice_sol_mod
    2223      implicit none
    2324#include "dimensions.h"
     
    2627#include "iniprint.h"
    2728
    28 !!! nrlmd le 10/04/2012
    29 #include "indicesol.h"
    30 !!! fin nrlmd le 10/04/2012
    3129
    3230!IM 140508
     
    6361      real zqla(klon,klev)
    6462      real zqta(klon,klev)
    65       real ztv(klon,klev),ztva(klon,klev)
     63      real ztv(klon,klev)
    6664      real zpspsk(klon,klev)
    6765      real ztla(klon,klev)
     
    257255     &      ,alp_bl_conv,alp_bl_stat &
    258256!!! fin nrlmd le 10/04/2012
    259      &      ,ztva )
     257     &                        )
    260258           if (prt_level.gt.10) write(lunout,*)'Apres thermcell_main OK'
    261259         else
  • LMDZ5/trunk/libf/phylmd/carbon_cycle_mod.F90

    r1759 r1785  
    309309    USE phys_cal_mod, ONLY : day_cur
    310310    USE comgeomphy
     311    USE indice_sol_mod
    311312
    312313    IMPLICIT NONE
    313314
    314315    INCLUDE "clesphys.h"
    315     INCLUDE "indicesol.h"
    316316    INCLUDE "iniprint.h"
    317317    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/change_srf_frac_mod.F90

    r1670 r1785  
    2828    USE cpl_mod, ONLY : cpl_receive_frac
    2929    USE ocean_slab_mod, ONLY : ocean_slab_frac
     30    USE indice_sol_mod
    3031
    3132    INCLUDE "iniprint.h"
    32     INCLUDE "indicesol.h"
    3333    INCLUDE "YOMCST.h"
    3434
  • LMDZ5/trunk/libf/phylmd/clcdrag.F90

    r1279 r1785  
    88
    99  USE dimphy
     10  USE indice_sol_mod
     11
    1012  IMPLICIT NONE
    1113! ================================================================= c
     
    1719!
    1820! knon----input-I- nombre de points pour un type de surface
    19 ! nsrf----input-I- indice pour le type de surface; voir indicesol.h
     21! nsrf----input-I- indice pour le type de surface; voir indice_sol_mod.F90
    2022! u1-------input-R- vent zonal au 1er niveau du modele
    2123! v1-------input-R- vent meridien au 1er niveau du modele
     
    4143  INCLUDE "YOMCST.h"
    4244  INCLUDE "YOETHF.h"
    43   INCLUDE "indicesol.h"
    4445  INCLUDE "clesphys.h"
    4546!
  • LMDZ5/trunk/libf/phylmd/cltracrn.F90

    r1409 r1785  
    99  USE dimphy
    1010  USE traclmdz_mod, ONLY : id_rn, id_pb
     11  USE indice_sol_mod
     12
    1113  IMPLICIT NONE
    1214!======================================================================
     
    4446!======================================================================
    4547  include "YOMCST.h"
    46   include "indicesol.h"
    4748!
    4849!Entrees
  • LMDZ5/trunk/libf/phylmd/coef_diff_turb_mod.F90

    r1761 r1785  
    1717 
    1818    USE dimphy
     19    USE indice_sol_mod
    1920!
    2021! Calculate coefficients(ycoefm, ycoefh) for turbulent diffusion in the
     
    5556!****************************************************************************************
    5657    INCLUDE "clesphys.h"
    57     INCLUDE "indicesol.h"
    5858    INCLUDE "iniprint.h"
    5959    INCLUDE "compbl.h"
     
    187187   
    188188    USE dimphy
     189    USE indice_sol_mod
    189190 
    190191!======================================================================
     
    211212    INCLUDE "FCTTRE.h"
    212213    INCLUDE "iniprint.h"
    213     INCLUDE "indicesol.h"
    214214    INCLUDE "compbl.h"
    215215    INCLUDE "YOMCST.h"
     
    479479
    480480    USE dimphy
     481    USE indice_sol_mod
    481482
    482483!======================================================================
     
    523524    REAL zdthmin(knon), zdthdp
    524525
    525     INCLUDE "indicesol.h"
    526526    INCLUDE "YOMCST.h"
    527527!
  • LMDZ5/trunk/libf/phylmd/coefcdrag.F90

    r1061 r1785  
    66                            ts, qsurf, rugos, okri, ri1, &
    77                            cdram, cdrah, cdran, zri1, pref)
     8
     9      USE indice_sol_mod
     10
    811      IMPLICIT none
    912!-------------------------------------------------------------------------
     
    1821! klon----input-I- dimension de la grille physique (= nb_pts_latitude X nb_pts_longitude)
    1922! knon----input-I- nombre de points pour un type de surface
    20 ! nsrf----input-I- indice pour le type de surface; voir indicesol.h
     23! nsrf----input-I- indice pour le type de surface; voir indice_sol_mod.F90
    2124! zxli----input-L- TRUE si calcul des cdrags selon Laurent Li
    2225! speed---input-R- module du vent au 1er niveau du modele
     
    4952      include "YOMCST.h"
    5053      include "YOETHF.h"
    51       include "indicesol.h"
    5254! Quelques constantes :
    5355      REAL, parameter :: RKAR=0.40, CB=5.0, CC=5.0, CD=5.0, cepdu2=(0.1)**2
  • LMDZ5/trunk/libf/phylmd/condsurf.F

    r776 r1785  
    55      USE mod_grid_phy_lmdz
    66      USE mod_phys_lmdz_para
     7      USE indice_sol_mod
    78      IMPLICIT none
    89c
     
    2526cym#include "dimensions.h"
    2627cym#include "dimphy.h"
    27 #include "indicesol.h"
    2828#include "temps.h"
    2929#include "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/cpl_mod.F90

    r1577 r1785  
    101101    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, fco2_ocn_day
    102102    USE surface_data
     103    USE indice_sol_mod
    103104
    104105    INCLUDE "dimensions.h"
    105     INCLUDE "indicesol.h"
    106106    INCLUDE "temps.h"
    107107    INCLUDE "iniprint.h"
     
    295295    USE phys_state_var_mod, ONLY : rlon, rlat
    296296    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl
    297    
    298     INCLUDE "indicesol.h"
     297    USE indice_sol_mod
     298
    299299    INCLUDE "temps.h"
    300300    INCLUDE "iniprint.h"
     
    424424!
    425425    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, fco2_ocn_day
    426     INCLUDE "indicesol.h"
     426    USE indice_sol_mod
    427427
    428428! Input arguments
     
    541541!
    542542    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, co2_send
    543     INCLUDE "indicesol.h"
     543    USE indice_sol_mod
    544544    INCLUDE "dimensions.h"
    545545
     
    732732!
    733733    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl
    734     INCLUDE "indicesol.h"
     734    USE indice_sol_mod
    735735    INCLUDE "dimensions.h"
    736736
     
    10261026    USE surface_data
    10271027    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl
     1028    USE indice_sol_mod
    10281029! Some includes
    10291030!*************************************************************************************
    1030     INCLUDE "indicesol.h"
    10311031    INCLUDE "temps.h"
    10321032    INCLUDE "dimensions.h"
  • LMDZ5/trunk/libf/phylmd/etat0_netcdf.F90

    r1764 r1785  
    2424  USE conf_phys_m,            ONLY: conf_phys
    2525! For parameterization of ozone chemistry:
    26   use regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
    27   use press_coefoz_m, only: press_coefoz
    28   use regr_pr_o3_m, only: regr_pr_o3
     26  USE regr_lat_time_coefoz_m, only: regr_lat_time_coefoz
     27  USE press_coefoz_m, only: press_coefoz
     28  USE regr_pr_o3_m, only: regr_pr_o3
    2929  USE netcdf, ONLY : NF90_OPEN, NF90_NOWRITE, NF90_CLOSE, NF90_NOERR
     30  USE indice_sol_mod
    3031#endif
    3132  IMPLICIT NONE
     
    4748#include "comvert.h"
    4849#include "comconst.h"
    49 #include "indicesol.h"
    5050#include "dimsoil.h"
    5151#include "temps.h"
  • LMDZ5/trunk/libf/phylmd/fonte_neige_mod.F90

    r1504 r1785  
    99!****************************************************************************************
    1010  USE dimphy, ONLY : klon
     11  USE indice_sol_mod
    1112
    1213  IMPLICIT NONE
     
    4445! restart file. The other variables are initialized to zero.
    4546!
    46     INCLUDE "indicesol.h"
    4747!****************************************************************************************
    4848! Input argument
     
    120120       tsurf, precip_rain, precip_snow, &
    121121       snow, qsol, tsurf_new, evap)
     122
     123  USE indice_sol_mod
    122124       
    123125! Routine de traitement de la fonte de la neige dans le cas du traitement
     
    139141!   evap
    140142!
    141   INCLUDE "indicesol.h"
    142143  INCLUDE "dimensions.h"
    143144  INCLUDE "YOETHF.h"
     
    315316       fqfonte_out, ffonte_out)
    316317
     318
     319
    317320! Cumulate ffonte, fqfonte and fqcalving respectively for
    318321! all type of surfaces according to their fraction.
    319322!
    320323! This routine is called from physiq.F before histwrite.
    321 
    322     INCLUDE "indicesol.h"
    323 !****************************************************************************************
     324!****************************************************************************************
     325
     326  USE indice_sol_mod
     327
    324328    REAL, DIMENSION(klon,nbsrf), INTENT(IN) :: pctsrf
    325329
  • LMDZ5/trunk/libf/phylmd/hgardfou.F

    r1782 r1785  
    22! $Id$
    33      SUBROUTINE hgardfou (t,tsol,text)
    4       use dimphy
    5       use phys_state_var_mod
     4      USE dimphy
     5      USE phys_state_var_mod
     6      USE indice_sol_mod
    67      IMPLICIT none
    78c======================================================================
     
    1011#include "dimensions.h"
    1112#include "YOMCST.h"
    12 #include "indicesol.h"
    1313#include "iniprint.h"
    1414      REAL t(klon,klev), tsol(klon,nbsrf)
     
    5757           DO i = 1, jbad
    5858             WRITE(lunout,*)
    59      $       'i,k,temperature,lon,lat,pourc ter,lic,oce,sic =',
     59     $       'i,k,temperature,lon,lat,pourc ter,oce,lic,sic =',
    6060     $       jadrs(i),k,zt(jadrs(i)),rlon(jadrs(i)),rlat(jadrs(i)),
    6161     $       (pctsrf(jadrs(i),nsrf),nsrf=1,nbsrf)
     
    7878           DO i = 1, jbad
    7979             WRITE(lunout,*)
    80      $       'i,k,temperature,lon,lat,pourc ter,lic,oce,sic =',
     80     $       'i,k,temperature,lon,lat,pourc ter,oce,lic,sic =',
    8181     $       jadrs(i),k,zt(jadrs(i)),rlon(jadrs(i)),rlat(jadrs(i)),
    8282     $       (pctsrf(jadrs(i),nsrf),nsrf=1,nbsrf)
     
    104104           DO i = 1, jbad
    105105            WRITE(lunout,*)
    106      $      'i,nsrf,temperature,lon,lat,pourc ter,lic,oce,sic ='
     106     $      'i,nsrf,temperature,lon,lat,pourc ter,oce,lic,sic ='
    107107     $      ,jadrs(i),nsrf,zt(jadrs(i)),rlon(jadrs(i)),rlat(jadrs(i))
    108108     $      ,pctsrf(jadrs(i),nsrf)
     
    125125           DO i = 1, jbad
    126126            WRITE(lunout,*)
    127      $      'i,nsrf,temperature,lon,lat,pourc ter,lic,oce,sic ='
     127     $      'i,nsrf,temperature,lon,lat,pourc ter,oce,lic,sic ='
    128128     $      ,jadrs(i),nsrf,zt(jadrs(i)),rlon(jadrs(i)),rlat(jadrs(i))
    129129     $      ,pctsrf(jadrs(i),nsrf)
  • LMDZ5/trunk/libf/phylmd/hydrol.F

    r766 r1785  
    77     .                  agesno, tsol,qsol,snow,runoff)
    88      USE dimphy
     9      USE indice_sol_mod
     10
    911      IMPLICIT none
    1012c======================================================================
     
    2628cym#include "dimphy.h"
    2729#include "YOMCST.h"
    28 #include "indicesol.h"
    2930c
    3031      REAL chasno ! epaisseur du sol: 0.15 m
  • LMDZ5/trunk/libf/phylmd/init_be.F90

    r1760 r1785  
    77  USE comgeomphy
    88  USE infotrac, ONLY : nbtr
     9  USE indice_sol_mod
    910   
    1011  IMPLICIT NONE
     
    2122  INCLUDE "YOMCST.h"
    2223  INCLUDE "YOECUMF.h"
    23   INCLUDE "indicesol.h"
    2424
    2525!
  • LMDZ5/trunk/libf/phylmd/initphysto.F90

    r1454 r1785  
    99  USE iophy
    1010  USE control_mod
     11  USE indice_sol_mod
    1112 
    1213  IMPLICIT NONE
     
    4647  INCLUDE "description.h"
    4748  INCLUDE "serre.h"
    48   INCLUDE "indicesol.h"
    4949
    5050!   Arguments
  • LMDZ5/trunk/libf/phylmd/initrrnpb.F90

    r1409 r1785  
    66  USE infotrac, ONLY : nbtr
    77  USE traclmdz_mod, ONLY : id_rn, id_pb
     8  USE indice_sol_mod
    89  IMPLICIT NONE
    910!======================================================================
     
    2425! scavtr...output-R- Coefficient de lessivage
    2526!======================================================================
    26   INCLUDE "indicesol.h"
    27 !======================================================================
    28 
     27 
    2928  REAL,DIMENSION(klon,nbsrf),INTENT(IN) :: pctsrf
    3029  REAL,DIMENSION(klon,nbsrf),INTENT(IN) :: ftsol
  • LMDZ5/trunk/libf/phylmd/interfoce_lim.F90

    r793 r1785  
    99  USE mod_grid_phy_lmdz
    1010  USE mod_phys_lmdz_para
     11  USE indice_sol_mod
    1112 
    1213  IMPLICIT NONE
    1314 
    14   INCLUDE "indicesol.h"
    1515  INCLUDE "netcdf.inc"
    1616
  • LMDZ5/trunk/libf/phylmd/limit_netcdf.F90

    r1687 r1785  
    2121!-------------------------------------------------------------------------------
    2222  USE control_mod
     23  USE indice_sol_mod
    2324#ifdef CPP_EARTH
    2425  USE dimphy
     
    5051#include "comgeom2.h"
    5152#include "comconst.h"
    52 #include "indicesol.h"
    5353
    5454!--- INPUT NETCDF FILES NAMES --------------------------------------------------
     
    276276  USE phys_state_var_mod, ONLY : pctsrf
    277277  USE control_mod
    278   use pchsp_95_m, only: pchsp_95
    279   use pchfe_95_m, only: pchfe_95
    280   use arth_m, only: arth
     278  USE pchsp_95_m, only: pchsp_95
     279  USE pchfe_95_m, only: pchfe_95
     280  USE arth_m, only: arth
     281  USE indice_sol_mod
    281282
    282283  IMPLICIT NONE
     
    284285#include "paramet.h"
    285286#include "comgeom2.h"
    286 #include "indicesol.h"
    287287#include "iniprint.h"
    288288!-----------------------------------------------------------------------------
  • LMDZ5/trunk/libf/phylmd/limit_read_mod.F90

    r1577 r1785  
    3838
    3939    USE dimphy
    40     INCLUDE "indicesol.h"
     40    USE indice_sol_mod
    4141
    4242! Input arguments
     
    146146    USE surface_data, ONLY : type_ocean, ok_veget
    147147    USE netcdf
     148    USE indice_sol_mod
    148149
    149150    IMPLICIT NONE
    150151   
    151     INCLUDE "indicesol.h"
    152152    INCLUDE "iniprint.h"
    153153
  • LMDZ5/trunk/libf/phylmd/limit_slab.F90

    r1001 r1785  
    77  USE mod_phys_lmdz_para
    88  USE netcdf
     9  USE indice_sol_mod
    910
    1011  IMPLICIT NONE
    1112
    12   INCLUDE "indicesol.h"
    1313  INCLUDE "temps.h"
    1414  INCLUDE "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/ocean_cpl_mod.F90

    r1146 r1785  
    6262    USE cpl_mod
    6363    USE calcul_fluxs_mod
    64 
    65     INCLUDE "indicesol.h"
     64    USE indice_sol_mod
     65
    6666    INCLUDE "YOMCST.h"
    6767!   
     
    197197    USE cpl_mod
    198198    USE calcul_fluxs_mod
    199 
    200     INCLUDE "indicesol.h"
     199    USE indice_sol_mod
     200
    201201    INCLUDE "YOMCST.h"
    202202
  • LMDZ5/trunk/libf/phylmd/ocean_forced_mod.F90

    r1067 r1785  
    3030    USE calcul_fluxs_mod
    3131    USE limit_read_mod
    32     INCLUDE "indicesol.h"
     32    USE indice_sol_mod
     33
    3334    INCLUDE "YOMCST.h"
    3435
     
    137138    USE limit_read_mod
    138139    USE fonte_neige_mod,  ONLY : fonte_neige
    139 
    140     INCLUDE "indicesol.h"
     140    USE indice_sol_mod
     141
    141142    INCLUDE "dimsoil.h"
    142143    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/ocean_slab_mod.F90

    r1067 r1785  
    1818    USE limit_read_mod
    1919    USE surface_data
    20     INCLUDE "indicesol.h"
     20    USE indice_sol_mod
     21
    2122!    INCLUDE "clesphys.h"
    2223
     
    6061    USE dimphy
    6162    USE calcul_fluxs_mod
    62  
    63     INCLUDE "indicesol.h"
     63    USE indice_sol_mod
     64
    6465    INCLUDE "iniprint.h"
    6566
  • LMDZ5/trunk/libf/phylmd/pbl_surface_mod.F90

    r1761 r1785  
    5656! for the index of the different surfaces and tests the choice of type of ocean.
    5757
    58     INCLUDE "indicesol.h"
     58    USE indice_sol_mod
     59
    5960    INCLUDE "dimsoil.h"
    6061    INCLUDE "iniprint.h"
     
    247248!
    248249    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, co2_send
     250    USE indice_sol_mod
     251
    249252    IMPLICIT NONE
    250253
    251     INCLUDE "indicesol.h"
    252254    INCLUDE "dimsoil.h"
    253255    INCLUDE "YOMCST.h"
     
    13181320       evap_rst, rugos_rst, agesno_rst, ftsoil_rst)
    13191321
    1320     INCLUDE "indicesol.h"
     1322    USE indice_sol_mod
     1323
    13211324    INCLUDE "dimsoil.h"
    13221325
     
    13681371    ! Give default values where new fraction has appread
    13691372
    1370     INCLUDE "indicesol.h"
     1373    USE indice_sol_mod
     1374
    13711375    INCLUDE "dimsoil.h"
    13721376    INCLUDE "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/phyaqua.F

    r1759 r1785  
    1616!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
    1717
    18       use comgeomphy, only : rlatd,rlond
    19       use dimphy, only : klon
    20       use surface_data, only : type_ocean,ok_veget
    21       use pbl_surface_mod, only : pbl_surface_init
     18      USE comgeomphy, only : rlatd,rlond
     19      USE dimphy, only : klon
     20      USE surface_data, only : type_ocean,ok_veget
     21      USE pbl_surface_mod, only : pbl_surface_init
    2222      USE fonte_neige_mod, only : fonte_neige_init
    23       use phys_state_var_mod
    24       use control_mod, only : dayref,nday,iphysiq
     23      USE phys_state_var_mod
     24      USE control_mod, only : dayref,nday,iphysiq
     25      USE indice_sol_mod
    2526
    2627      USE IOIPSL
     
    3334#include "clesphys.h"
    3435#include "dimsoil.h"
    35 #include "indicesol.h"
    3636#include "temps.h"
    3737
  • LMDZ5/trunk/libf/phylmd/phyetat0.F

    r1674 r1785  
    2323      USE carbon_cycle_mod,ONLY :
    2424     &     carbon_cycle_tr, carbon_cycle_cpl, co2_send
     25      USE indice_sol_mod
    2526
    2627      IMPLICIT none
     
    3132#include "dimensions.h"
    3233#include "netcdf.inc"
    33 #include "indicesol.h"
    3434#include "dimsoil.h"
    3535#include "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/phyredem.F

    r1619 r1785  
    1616      USE control_mod
    1717      USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, co2_send
     18      USE indice_sol_mod
    1819
    1920      IMPLICIT none
     
    2324c======================================================================
    2425#include "netcdf.inc"
    25 #include "indicesol.h"
    2626#include "dimsoil.h"
    2727#include "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/phys_local_var_mod.F90

    r1761 r1785  
    191191!======================================================================
    192192SUBROUTINE phys_local_var_init
    193 use dimphy
    194 use infotrac, ONLY : nbtr
     193USE dimphy
     194USE infotrac, ONLY : nbtr
    195195USE aero_mod
     196USE indice_sol_mod
    196197
    197198IMPLICIT NONE
    198 #include "indicesol.h"
    199199      allocate(t_seri(klon,klev),q_seri(klon,klev),ql_seri(klon,klev),qs_seri(klon,klev))
    200200      allocate(u_seri(klon,klev),v_seri(klon,klev))
     
    283283!======================================================================
    284284SUBROUTINE phys_local_var_end
    285 use dimphy
     285USE dimphy
     286USE indice_sol_mod
    286287IMPLICIT NONE
    287 #include "indicesol.h"
    288288      deallocate(t_seri,q_seri,ql_seri,qs_seri)
    289289      deallocate(u_seri,v_seri)
  • LMDZ5/trunk/libf/phylmd/phys_output_mod.F90

    r1764 r1785  
    1111
    1212MODULE phys_output_mod
     13  USE indice_sol_mod
    1314
    1415  IMPLICIT NONE
     
    680681    include "dimensions.h"
    681682    include "temps.h"
    682     include "indicesol.h"
    683683    include "clesphys.h"
    684684    include "thermcell.h"
     
    10971097             CALL histdef2d(iff,clef_stations(iff), &
    10981098                  o_wbilo_srf(nsrf)%flag,o_wbilo_srf(nsrf)%name,"Bilan eau "//clnsurf(nsrf),"kg/(m2*s)")
     1099
     1100
    10991101             if (iflag_pbl>1 .and. lev_files(iff).gt.10 ) then
    11001102                CALL histdef2d(iff,clef_stations(iff), &
     
    11171119
    11181120             endif
     1121
    11191122
    11201123             CALL histdef2d(iff,clef_stations(iff), &
     
    18611864    include "dimensions.h"
    18621865    include "temps.h"
    1863     include "indicesol.h"
    18641866    include "clesphys.h"
    18651867
     
    19151917    include "dimensions.h"
    19161918    include "temps.h"
    1917     include "indicesol.h"
    19181919    include "clesphys.h"
    19191920
  • LMDZ5/trunk/libf/phylmd/phys_state_var_mod.F90

    r1761 r1785  
    361361!======================================================================
    362362SUBROUTINE phys_state_var_init(read_climoz)
    363 use dimphy
     363USE dimphy
    364364USE control_mod
    365 use aero_mod
    366 use infotrac, ONLY : nbtr
     365USE aero_mod
     366USE infotrac, ONLY : nbtr
     367USE indice_sol_mod
    367368IMPLICIT NONE
    368369
     
    375376! climatology and the daylight climatology
    376377
    377 #include "indicesol.h"
    378378      ALLOCATE(rlat(klon), rlon(klon))
    379379      ALLOCATE(pctsrf(klon,nbsrf))
     
    522522!======================================================================
    523523SUBROUTINE phys_state_var_end
    524 use dimphy
    525 use control_mod
     524USE dimphy
     525USE control_mod
     526USE indice_sol_mod
    526527IMPLICIT NONE
    527 #include "indicesol.h"
    528528
    529529      deallocate(rlat, rlon, pctsrf, ftsol, falb1, falb2)
  • LMDZ5/trunk/libf/phylmd/physiq.F

    r1779 r1785  
    4646      USE CHEM_REP, ONLY : Init_chem_rep_xjour
    4747#endif
    48 
     48      USE indice_sol_mod
    4949
    5050!IM stations CFMIP
     
    104104
    105105#include "regdim.h"
    106 #include "indicesol.h"
    107106#include "dimsoil.h"
    108107#include "clesphys.h"
  • LMDZ5/trunk/libf/phylmd/phystokenc.F90

    r1539 r1785  
    1212  USE iophy
    1313  USE control_mod
     14  USE indice_sol_mod
    1415 
    1516  IMPLICIT NONE
     
    2223  INCLUDE "dimensions.h"
    2324  INCLUDE "tracstoke.h"
    24   INCLUDE "indicesol.h"
    2525  INCLUDE "iniprint.h"
    2626!======================================================================
  • LMDZ5/trunk/libf/phylmd/phytrac.F90

    r1759 r1785  
    4545  USE tracreprobus_mod
    4646  USE control_mod
     47  USE indice_sol_mod
    4748
    4849  IMPLICIT NONE
     
    5051  INCLUDE "YOMCST.h"
    5152  INCLUDE "dimensions.h"
    52   INCLUDE "indicesol.h"
    5353  INCLUDE "clesphys.h"
    5454  INCLUDE "temps.h"
  • LMDZ5/trunk/libf/phylmd/read_pstoke.F

    r1403 r1785  
    2121      USE dimphy
    2222      USE control_mod
     23      USE indice_sol_mod
    2324
    2425       IMPLICIT NONE
     
    3435#include "description.h"
    3536#include "serre.h"
    36 #include "indicesol.h"
    3737cccc#include "dimphy.h"
    3838       
  • LMDZ5/trunk/libf/phylmd/read_pstoke0.F

    r1403 r1785  
    1717C******************************************************************************
    1818
    19         use netcdf
     19         USE netcdf
    2020       USE dimphy
    2121       USE control_mod
     22       USE indice_sol_mod
    2223
    2324       IMPLICIT NONE
     
    3334#include "description.h"
    3435#include "serre.h"
    35 #include "indicesol.h"
    3636cccc#include "dimphy.h"
    3737         
  • LMDZ5/trunk/libf/phylmd/screenc.F90

    r793 r1785  
    2222! klon----input-I- dimension de la grille physique (= nb_pts_latitude X nb_pts_longitude)
    2323! knon----input-I- nombre de points pour un type de surface
    24 ! nsrf----input-I- indice pour le type de surface; voir indicesol.h
     24! nsrf----input-I- indice pour le type de surface; voir indice_sol_mod.F90
    2525! zxli----input-L- TRUE si calcul des cdrags selon Laurent Li
    2626! speed---input-R- module du vent au 1er niveau du modele
  • LMDZ5/trunk/libf/phylmd/screenp.F90

    r1107 r1785  
    2222! klon----input-I- dimension de la grille physique (= nb_pts_latitude X nb_pts_longitude)
    2323! knon----input-I- nombre de points pour un type de surface
    24 ! nsrf----input-I- indice pour le type de surface; voir indicesol.h
     24! nsrf----input-I- indice pour le type de surface; voir indice_sol_mod.F90
    2525! speed---input-R- module du vent au 1er niveau du modele
    2626! tair----input-R- temperature de l'air au 1er niveau du modele
  • LMDZ5/trunk/libf/phylmd/soil.F90

    r1575 r1785  
    77  USE dimphy
    88  USE mod_phys_lmdz_para
     9  USE indice_sol_mod
     10
    911  IMPLICIT NONE
    1012
     
    5254  INCLUDE "YOMCST.h"
    5355  INCLUDE "dimsoil.h"
    54   INCLUDE "indicesol.h"
    5556  INCLUDE "comsoil.h"
    5657  INCLUDE "iniprint.h"
  • LMDZ5/trunk/libf/phylmd/stdlevvar.F90

    r793 r1785  
    2323! klon----input-I- dimension de la grille physique (= nb_pts_latitude X nb_pts_longitude)
    2424! knon----input-I- nombre de points pour un type de surface
    25 ! nsrf----input-I- indice pour le type de surface; voir indicesol.h
     25! nsrf----input-I- indice pour le type de surface; voir indice_sol_mod.F90
    2626! zxli----input-L- TRUE si calcul des cdrags selon Laurent Li
    2727! u1------input-R- vent zonal au 1er niveau du modele
  • LMDZ5/trunk/libf/phylmd/stratocu_if.F90

    r878 r1785  
    11  SUBROUTINE stratocu_if(klon,klev,pctsrf,paprs, pplay,t &
    22,seuil_inversion,weak_inversion,dthmin)
    3 implicit none
     3
     4  USE indice_sol_mod
     5
     6IMPLICIT NONE
    47
    58!======================================================================
     
    3942    REAL dthmin(klon), zdthdp
    4043
    41     INCLUDE "indicesol.h"
    4244    INCLUDE "YOMCST.h"
    4345
  • LMDZ5/trunk/libf/phylmd/surf_land_bucket_mod.F90

    r1742 r1785  
    2727    USE mod_grid_phy_lmdz
    2828    USE mod_phys_lmdz_para
     29    USE indice_sol_mod
    2930!****************************************************************************************
    3031! Bucket calculations for surface.
    3132!
    3233    INCLUDE "clesphys.h"
    33     INCLUDE "indicesol.h"
    3434    INCLUDE "dimsoil.h"
    3535    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/surf_land_mod.F90

    r1146 r1785  
    3131    USE surf_land_bucket_mod
    3232    USE calcul_fluxs_mod
     33    USE indice_sol_mod
    3334
    34     INCLUDE "indicesol.h"
    3535    INCLUDE "dimsoil.h"
    3636    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/surf_land_orchidee_mod.F90

    r1454 r1785  
    4444    USE mod_synchro_omp
    4545    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl
     46    USE indice_sol_mod
    4647
    4748!   
     
    9798!   qsurf        air moisture at surface
    9899!
    99     INCLUDE "indicesol.h"
    100100    INCLUDE "temps.h"
    101101    INCLUDE "YOMCST.h"
     
    551551    USE mod_grid_phy_lmdz
    552552    USE mod_surf_para   
    553     INCLUDE "indicesol.h"
     553    USE indice_sol_mod
    554554
    555555#ifdef CPP_MPI
  • LMDZ5/trunk/libf/phylmd/surf_land_orchidee_noopenmp_mod.F90

    r1548 r1785  
    9797!
    9898    USE carbon_cycle_mod, ONLY : carbon_cycle_cpl, fco2_land_inst, fco2_lu_inst
     99    USE indice_sol_mod
    99100    IMPLICIT NONE
    100101
    101     INCLUDE "indicesol.h"
    102102    INCLUDE "temps.h"
    103103    INCLUDE "YOMCST.h"
     
    634634  SUBROUTINE Init_neighbours(knon,neighbours,ktindex,pctsrf)
    635635   
    636     INCLUDE "indicesol.h"
     636    USE indice_sol_mod
     637
    637638    INCLUDE "dimensions.h"
    638639#ifdef CPP_MPI
  • LMDZ5/trunk/libf/phylmd/surf_landice_mod.F90

    r1403 r1785  
    2525    USE calcul_fluxs_mod
    2626    USE phys_output_var_mod
    27 
    28     INCLUDE "indicesol.h"
     27    USE indice_sol_mod
     28
     29!    INCLUDE "indicesol.h"
    2930    INCLUDE "dimsoil.h"
    3031    INCLUDE "YOMCST.h"
  • LMDZ5/trunk/libf/phylmd/surf_ocean_mod.F90

    r1403 r1785  
    2525  USE ocean_slab_mod, ONLY   : ocean_slab_noice
    2626  USE ocean_cpl_mod, ONLY    : ocean_cpl_noice
     27  USE indice_sol_mod
    2728!
    2829! This subroutine will make a call to ocean_XXX_noice according to the ocean mode (force,
    2930! slab or couple). The calculations of albedo and rugosity for the ocean surface are
    3031! done in here because they are identical for the different modes of ocean.
    31 !
    32     INCLUDE "indicesol.h"
     32
     33
    3334    INCLUDE "YOMCST.h"
    3435
  • LMDZ5/trunk/libf/phylmd/surf_seaice_mod.F90

    r1072 r1785  
    2525  USE ocean_forced_mod, ONLY : ocean_forced_ice
    2626  USE ocean_cpl_mod, ONLY    : ocean_cpl_ice
     27  USE indice_sol_mod
    2728
    2829!
     
    3132! in here because it is the same calculation for the different modes of ocean.
    3233!
    33     INCLUDE "indicesol.h"
    3434    INCLUDE "dimsoil.h"
    3535
  • LMDZ5/trunk/libf/phylmd/thermcell_main.F90

    r1779 r1785  
    1919     &                  ,alp_bl_conv,alp_bl_stat &
    2020!!! fin nrlmd le 10/04/2012
    21      &                  ,ztva  )
     21     &                         )
    2222
    2323      USE dimphy
    2424      USE ioipsl
    2525      USE comgeomphy , ONLY:rlond,rlatd
     26      USE indice_sol_mod
    2627      IMPLICIT NONE
    2728
     
    6768#include "iniprint.h"
    6869#include "thermcell.h"
    69 !!! nrlmd le 10/04/2012
    70 #include "indicesol.h"
    71 !!! fin nrlmd le 10/04/2012
    7270
    7371!   arguments:
  • LMDZ5/trunk/libf/phylmd/tracinca_mod.F90

    r1403 r1785  
    4646    USE comgeomphy
    4747    USE control_mod
     48    USE indice_sol_mod
    4849
    4950   
    5051    IMPLICIT NONE
    5152   
    52     INCLUDE "indicesol.h"
    5353    INCLUDE "dimensions.h"
    5454    INCLUDE "paramet.h"
  • LMDZ5/trunk/libf/phylmd/traclmdz_mod.F90

    r1742 r1785  
    9595    USE mod_grid_phy_lmdz
    9696    USE mod_phys_lmdz_para
    97 
    98     INCLUDE "indicesol.h"
     97    USE indice_sol_mod
     98
    9999    INCLUDE "iniprint.h"
    100100! Input variables
     
    346346    USE o3_chem_m, ONLY: o3_chem
    347347    USE carbon_cycle_mod, ONLY : carbon_cycle, carbon_cycle_tr, carbon_cycle_cpl
     348    USE indice_sol_mod
     349
    348350    INCLUDE "YOMCST.h"
    349     INCLUDE "indicesol.h"
    350351
    351352!==========================================================================
Note: See TracChangeset for help on using the changeset viewer.