Changeset 1363


Ignore:
Timestamp:
Apr 16, 2010, 11:50:10 AM (14 years ago)
Author:
Ehouarn Millour
Message:

Added possibility to run in "Shallow Water" mode. SW mode is automatically set if the number of atmospheric layers is 1.
To use SW mode, the model should be compiled without physics (makelmdz_fcm -p nophys) and/or without calls to the physics (i.e. set iflag_phys=0 in gcm.def).

-Updated some definitions and comments in run.def & gcm.def

-Fixed misplaced #ifdef CPP_EARTH in calfis.F + some write(lunout,*)

-Specific initialisation of fields for SW are done in sw_case_williamson91_6 (called by iniacademic, when read_start=.false.)

  • Checked (on Vargas & Brodie) that these changes don't alter usual bench GCM outputs.

EM

Location:
LMDZ4/branches/LMDZ4V5.0-dev
Files:
2 added
10 edited

Legend:

Unmodified
Added
Removed
  • LMDZ4/branches/LMDZ4V5.0-dev/gcm.def

    r1300 r1363  
    2222## coefficient pour gamdissip                                           
    2323coefdis=0.
    24 ## choix du shema d'integration temporelle (Matsuno ou Matsuno-leapfrog)
     24## choix du shema d'integration temporelle (Matsuno:y ou Matsuno-leapfrog:n)
    2525purmats=n
    26 ## avec ou sans physique                                                 
    27 physic=y
    28 ## periode de la physique (en pas)                                       
     26## avec ou sans physique
     27## 0: pas de physique (e.g. en mode Shallow Water)
     28## 1: avec physique (e.g. physique phylmd)
     29## 2: avec rappel newtonien dans la dynamique                                         
     30iflag_phys=1
     31## avec ou sans fichiers de demarrage (start.nc, startphy.nc) ?
     32## (sans fichiers de demarrage, initialisation des champs par iniacademic
     33##  dans la dynamique)
     34read_start=y
     35## periode de la physique (en pas dynamiques, n'a de sens que si iflag_phys=1)                                       
    2936iphysiq=10
    3037##  Avec ou sans strato
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3d/calfis.F

    r1320 r1363  
    9898#include "comvert.h"
    9999#include "comgeom2.h"
     100#include "iniprint.h"
    100101
    101102c    Arguments :
     
    188189        debut = .TRUE.
    189190        IF (ngridmx.NE.2+(jjm-1)*iim) THEN
    190          PRINT*,'STOP dans calfis'
    191          PRINT*,'La dimension ngridmx doit etre egale a 2 + (jjm-1)*iim'
    192          PRINT*,'  ngridmx  jjm   iim   '
    193          PRINT*,ngridmx,jjm,iim
     191         write(lunout,*) 'STOP dans calfis'
     192         write(lunout,*)
     193     &   'La dimension ngridmx doit etre egale a 2 + (jjm-1)*iim'
     194         write(lunout,*) '  ngridmx  jjm   iim   '
     195         write(lunout,*) ngridmx,jjm,iim
    194196         STOP
    195197        ENDIF
     
    315317      CALL gr_dyn_fi(1,iip1,jjp1,ngridmx,pphis,zphis)
    316318      DO l=1,llm
    317         DO ig=1,ngridmx
    318            zphi(ig,l)=zphi(ig,l)-zphis(ig)
    319         ENDDO
     319        DO ig=1,ngridmx
     320           zphi(ig,l)=zphi(ig,l)-zphis(ig)
     321        ENDDO
    320322      ENDDO
    321323
     
    415417            z1(i)   =(rlonu(i)-rlonu(i-1))*pvcov(i,jjm,l)/cv(i,jjm)
    416418            z1bis(i)=(rlonu(i)-rlonu(i-1))*pdvcov(i,jjm,l)/cv(i,jjm)
    417         ENDDO
     419        ENDDO
    418420
    419421         DO i=1,iim
     
    422424            zsin(i)    = SIN(rlonv(i))*z1(i)
    423425            zsinbis(i) = SIN(rlonv(i))*z1bis(i)
    424         ENDDO
     426        ENDDO
    425427
    426428         zufi(ngridmx,l)  = SSUM(iim,zcos,1)/pi
     
    449451
    450452      if (planet_type=="earth") then
    451 
    452       print*,'PHYSIQUE AVEC NSPLIT_PHYS=',nsplit_phys
     453#ifdef CPP_EARTH
     454
     455      write(lunout,*) 'PHYSIQUE AVEC NSPLIT_PHYS=',nsplit_phys
    453456      zdt_split=dtphys/nsplit_phys
    454457      zdufic(:,:)=0.
     
    463466         lafin_split=lafin.and.isplit==nsplit_phys
    464467
    465 #ifdef CPP_EARTH
    466468         CALL physiq (ngridmx,
    467469     .             llm,
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3d/exner_hyb.F

    r524 r1363  
    11!
    2 ! $Header$
     2! $Id $
    33!
    44      SUBROUTINE  exner_hyb ( ngrid, ps, p,alpha,beta, pks, pk, pkf )
     
    5151      REAL SSUM
    5252c
     53
     54      if (llm.eq.1) then
     55        ! Specific behaviour for Shallow Water (1 vertical layer) case
    5356     
     57        ! Sanity checks
     58        if (kappa.ne.1) then
     59          call abort_gcm("exner_hyb",
     60     &    "kappa!=1 , but running in Shallow Water mode!!",42)
     61        endif
     62        if (cpp.ne.r) then
     63        call abort_gcm("exner_hyb",
     64     &    "cpp!=r , but running in Shallow Water mode!!",42)
     65        endif
     66       
     67        ! Compute pks(:),pk(:),pkf(:)
     68       
     69        DO   ij  = 1, ngrid
     70          pks(ij) = (cpp/preff) * ps(ij)
     71          pk(ij,1) = .5*pks(ij)
     72        ENDDO
     73       
     74        CALL SCOPY   ( ngrid * llm, pk, 1, pkf, 1 )
     75        CALL filtreg ( pkf, jmp1, llm, 2, 1, .TRUE., 1 )
     76       
     77        ! our work is done, exit routine
     78        return
     79      endif ! of if (llm.eq.1)
     80
     81     
    5482      unpl2k    = 1.+ 2.* kappa
    5583c
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3d/iniacademic.F

    r1299 r1363  
    4747#include "temps.h"
    4848#include "iniprint.h"
     49#include "logic.h"
    4950
    5051c   Arguments:
     
    8586        time_0=0.
    8687        day_ref=0
    87         annee_ref=0
     88        annee_ref=0
    8889
    8990        im         = iim
     
    106107        ang0       = 0.
    107108
     109        if (llm.eq.1) then
     110          ! specific initializations for the shallow water case
     111          kappa=1
     112        endif
     113       
    108114        CALL iniconst
    109115        CALL inigeom
    110116        CALL inifilr
    111117
    112         ps=0.
    113         phis=0.
     118        if (llm.eq.1) then
     119          ! initialize fields for the shallow water case, if required
     120          if (.not.read_start) then
     121            phis(:)=0.
     122            q(:,:,1)=1.e-10
     123            q(:,:,2)=1.e-15
     124            q(:,:,3:nqtot)=0.
     125            CALL sw_case_williamson91_6(vcov,ucov,teta,masse,ps)
     126          endif
     127        endif
     128
     129        if (iflag_phys.eq.2) then
     130          ! initializations for the academic case
     131          ps(:)=1.e5
     132          phis(:)=0.
    114133c---------------------------------------------------------------------
    115134
    116         taurappel=10.*daysec
     135          taurappel=10.*daysec
    117136
    118137c---------------------------------------------------------------------
     
    120139c   --------------------------------------
    121140
    122         DO l=1,llm
    123          zsig=ap(l)/preff+bp(l)
    124          if (zsig.gt.0.3) then
    125            lsup=l
    126            tetarappell=1./8.*(-log(zsig)-.5)
    127            DO j=1,jjp1
     141          DO l=1,llm
     142            zsig=ap(l)/preff+bp(l)
     143            if (zsig.gt.0.3) then
     144             lsup=l
     145             tetarappell=1./8.*(-log(zsig)-.5)
     146             DO j=1,jjp1
    128147             ddsin=sin(rlatu(j))-sin(pi/20.)
    129148             tetajl(j,l)=300.*(1+1./18.*(1.-3.*ddsin*ddsin)+tetarappell)
    130            ENDDO
    131           else
     149             ENDDO
     150            else
    132151c   Choix isotherme au-dessus de 300 mbar
    133            do j=1,jjp1
    134              tetajl(j,l)=tetajl(j,lsup)*(0.3/zsig)**kappa
    135            enddo
    136           endif ! of if (zsig.gt.0.3)
    137         ENDDO ! of DO l=1,llm
    138 
    139         do l=1,llm
    140            do j=1,jjp1
     152             do j=1,jjp1
     153               tetajl(j,l)=tetajl(j,lsup)*(0.3/zsig)**kappa
     154             enddo
     155            endif ! of if (zsig.gt.0.3)
     156          ENDDO ! of DO l=1,llm
     157
     158          do l=1,llm
     159            do j=1,jjp1
    141160              do i=1,iip1
    142161                 ij=(j-1)*iip1+i
    143162                 tetarappel(ij,l)=tetajl(j,l)
    144163              enddo
    145            enddo
    146         enddo
     164            enddo
     165          enddo
    147166
    148167c       call dump2d(jjp1,llm,tetajl,'TEQ   ')
    149168
    150         ps=1.e5
    151         phis=0.
    152         CALL pression ( ip1jmp1, ap, bp, ps, p       )
    153         CALL exner_hyb( ip1jmp1, ps, p,alpha,beta, pks, pk, pkf )
    154         CALL massdair(p,masse)
     169          CALL pression ( ip1jmp1, ap, bp, ps, p       )
     170          CALL exner_hyb( ip1jmp1, ps, p,alpha,beta, pks, pk, pkf )
     171          CALL massdair(p,masse)
    155172
    156173c  intialisation du vent et de la temperature
    157         teta(:,:)=tetarappel(:,:)
    158         CALL geopot(ip1jmp1,teta,pk,pks,phis,phi)
    159         call ugeostr(phi,ucov)
    160         vcov=0.
    161         q(:,:,1   )=1.e-10
    162         q(:,:,2   )=1.e-15
    163         q(:,:,3:nqtot)=0.
     174          teta(:,:)=tetarappel(:,:)
     175          CALL geopot(ip1jmp1,teta,pk,pks,phis,phi)
     176          call ugeostr(phi,ucov)
     177          vcov=0.
     178          q(:,:,1   )=1.e-10
     179          q(:,:,2   )=1.e-15
     180          q(:,:,3:nqtot)=0.
    164181
    165182
    166183c   perturbation aleatoire sur la temperature
    167         idum  = -1
    168         zz = ran1(idum)
    169         idum  = 0
    170         do l=1,llm
    171            do ij=iip2,ip1jm
     184          idum  = -1
     185          zz = ran1(idum)
     186          idum  = 0
     187          do l=1,llm
     188            do ij=iip2,ip1jm
    172189              teta(ij,l)=teta(ij,l)*(1.+0.005*ran1(idum))
    173            enddo
    174         enddo
    175 
    176         do l=1,llm
    177            do ij=1,ip1jmp1,iip1
     190            enddo
     191          enddo
     192
     193          do l=1,llm
     194            do ij=1,ip1jmp1,iip1
    178195              teta(ij+iim,l)=teta(ij,l)
    179            enddo
    180         enddo
     196            enddo
     197          enddo
    181198
    182199
     
    188205
    189206c   initialisation d'un traceur sur une colonne
    190         j=jjp1*3/4
    191         i=iip1/2
    192         ij=(j-1)*iip1+i
    193         q(ij,:,3)=1.
    194      
     207          j=jjp1*3/4
     208          i=iip1/2
     209          ij=(j-1)*iip1+i
     210          q(ij,:,3)=1.
     211        endif ! of if (iflag_phys.eq.2)
     212       
    195213      else
    196214        write(lunout,*)"iniacademic: planet types other than earth",
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3dpar/calfis_p.F

    r1325 r1363  
    108108#include "comvert.h"
    109109#include "comgeom2.h"
     110#include "iniprint.h"
    110111#ifdef CPP_MPI
    111112      include 'mpif.h'
     
    258259        debut = .TRUE.
    259260        IF (ngridmx.NE.2+(jjm-1)*iim) THEN
    260          PRINT*,'STOP dans calfis'
    261          PRINT*,'La dimension ngridmx doit etre egale a 2 + (jjm-1)*iim'
    262          PRINT*,'  ngridmx  jjm   iim   '
    263          PRINT*,ngridmx,jjm,iim
     261         write(lunout,*) 'STOP dans calfis'
     262         write(lunout,*)
     263     &   'La dimension ngridmx doit etre egale a 2 + (jjm-1)*iim'
     264         write(lunout,*) '  ngridmx  jjm   iim   '
     265         write(lunout,*) ngridmx,jjm,iim
    264266         STOP
    265267        ENDIF
     
    628630#ifdef CPP_EARTH
    629631
    630       print*,'PHYSIQUE AVEC NSPLIT_PHYS=',nsplit_phys
     632!$OMP MASTER
     633      write(lunout,*) 'PHYSIQUE AVEC NSPLIT_PHYS=',nsplit_phys
     634!$OMP END MASTER
    631635      zdt_split=dtphys/nsplit_phys
    632636      zdufic_omp(:,:)=0.
     
    11071111
    11081112#else
    1109       write(*,*) "calfis_p: for now can only work with parallel physics"
     1113      write(lunout,*)
     1114     & "calfis_p: for now can only work with parallel physics"
    11101115      stop
    11111116#endif
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3dpar/exner_hyb.F

    r774 r1363  
    11!
    2 ! $Header$
     2! $Id $
    33!
    44      SUBROUTINE  exner_hyb ( ngrid, ps, p,alpha,beta, pks, pk, pkf )
     
    5151      REAL SSUM
    5252c
     53
     54      if (llm.eq.1) then
     55        ! Specific behaviour for Shallow Water (1 vertical layer) case
    5356     
     57        ! Sanity checks
     58        if (kappa.ne.1) then
     59          call abort_gcm("exner_hyb",
     60     &    "kappa!=1 , but running in Shallow Water mode!!",42)
     61        endif
     62        if (cpp.ne.r) then
     63        call abort_gcm("exner_hyb",
     64     &    "cpp!=r , but running in Shallow Water mode!!",42)
     65        endif
     66       
     67        ! Compute pks(:),pk(:),pkf(:)
     68       
     69        DO   ij  = 1, ngrid
     70          pks(ij) = (cpp/preff) * ps(ij)
     71          pk(ij,1) = .5*pks(ij)
     72        ENDDO
     73       
     74        CALL SCOPY   ( ngrid * llm, pk, 1, pkf, 1 )
     75        CALL filtreg ( pkf, jmp1, llm, 2, 1, .TRUE., 1 )
     76       
     77        ! our work is done, exit routine
     78        return
     79      endif ! of if (llm.eq.1)
     80
     81     
    5482      unpl2k    = 1.+ 2.* kappa
    5583c
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3dpar/exner_hyb_p.F

    r985 r1363  
     1!
     2! $Id $
     3!
    14      SUBROUTINE  exner_hyb_p ( ngrid, ps, p,alpha,beta, pks, pk, pkf )
    25c
     
    5154      INTEGER ije,ijb,jje,jjb
    5255c
    53 c$OMP BARRIER           
     56c$OMP BARRIER
     57
     58      if (llm.eq.1) then
     59        ! Specific behaviour for Shallow Water (1 vertical layer) case
     60     
     61        ! Sanity checks
     62        if (kappa.ne.1) then
     63          call abort_gcm("exner_hyb",
     64     &    "kappa!=1 , but running in Shallow Water mode!!",42)
     65        endif
     66        if (cpp.ne.r) then
     67        call abort_gcm("exner_hyb",
     68     &    "cpp!=r , but running in Shallow Water mode!!",42)
     69        endif
     70       
     71        ! Compute pks(:),pk(:),pkf(:)
     72        ijb=ij_begin
     73        ije=ij_end
     74!$OMP DO SCHEDULE(STATIC)
     75        DO ij=ijb, ije
     76          pks(ij)=(cpp/preff)*ps(ij)
     77          pk(ij,1) = .5*pks(ij)
     78          pkf(ij,1)=pk(ij,1)
     79        ENDDO
     80!$OMP ENDDO
     81
     82!$OMP MASTER
     83      if (pole_nord) then
     84        DO  ij   = 1, iim
     85          ppn(ij) = aire(   ij   ) * pks(  ij     )
     86        ENDDO
     87        xpn      = SSUM(iim,ppn,1) /apoln
     88 
     89        DO ij   = 1, iip1
     90          pks(   ij     )  =  xpn
     91          pk(ij,1) = .5*pks(ij)
     92          pkf(ij,1)=pk(ij,1)
     93        ENDDO
     94      endif
     95     
     96      if (pole_sud) then
     97        DO  ij   = 1, iim
     98          pps(ij) = aire(ij+ip1jm) * pks(ij+ip1jm )
     99        ENDDO
     100        xps      = SSUM(iim,pps,1) /apols
     101 
     102        DO ij   = 1, iip1
     103          pks( ij+ip1jm )  =  xps
     104          pk(ij+ip1jm,1)=.5*pks(ij+ip1jm)
     105          pkf(ij+ip1jm,1)=pk(ij+ip1jm,1)
     106        ENDDO
     107      endif
     108!$OMP END MASTER
     109
     110        jjb=jj_begin
     111        jje=jj_end
     112        CALL filtreg_p ( pkf,jjb,jje, jmp1, llm, 2, 1, .TRUE., 1 )
     113
     114        ! our work is done, exit routine
     115        return
     116      endif ! of if (llm.eq.1)
     117
     118
    54119      unpl2k    = 1.+ 2.* kappa
    55120c
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3dpar/iniacademic.F

    r1299 r1363  
    88      USE filtreg_mod
    99      USE infotrac, ONLY : nqtot
     10      USE control_mod
     11 
    1012
    1113c%W%    %G%
     
    3133c
    3234c=======================================================================
    33       USE control_mod
    3435      IMPLICIT NONE
    3536c-----------------------------------------------------------------------
     
    4647#include "temps.h"
    4748#include "iniprint.h"
     49#include "logic.h"
    4850
    4951c   Arguments:
     
    5557      REAL vcov(ip1jm,llm),ucov(ip1jmp1,llm) ! vents covariants
    5658      REAL teta(ip1jmp1,llm)                 ! temperature potentielle
    57       REAL q(ip1jmp1,llm,nqtot)              ! champs advectes
     59      REAL q(ip1jmp1,llm,nqtot)               ! champs advectes
    5860      REAL ps(ip1jmp1)                       ! pression  au sol
    5961      REAL masse(ip1jmp1,llm)                ! masse d'air
     
    8486        time_0=0.
    8587        day_ref=0
    86         annee_ref=0
     88        annee_ref=0
    8789
    8890        im         = iim
     
    105107        ang0       = 0.
    106108
     109        if (llm.eq.1) then
     110          ! specific initializations for the shallow water case
     111          kappa=1
     112        endif
     113       
    107114        CALL iniconst
    108115        CALL inigeom
    109116        CALL inifilr
    110117
    111         ps=0.
    112         phis=0.
     118        if (llm.eq.1) then
     119          ! initialize fields for the shallow water case, if required
     120          if (.not.read_start) then
     121            phis(:)=0.
     122            q(:,:,1)=1.e-10
     123            q(:,:,2)=1.e-15
     124            q(:,:,3:nqtot)=0.
     125            CALL sw_case_williamson91_6(vcov,ucov,teta,masse,ps)
     126          endif
     127        endif
     128
     129        if (iflag_phys.eq.2) then
     130          ! initializations for the academic case
     131          ps(:)=1.e5
     132          phis(:)=0.
    113133c---------------------------------------------------------------------
    114134
    115         taurappel=10.*daysec
     135          taurappel=10.*daysec
    116136
    117137c---------------------------------------------------------------------
     
    119139c   --------------------------------------
    120140
    121         DO l=1,llm
    122          zsig=ap(l)/preff+bp(l)
    123          if (zsig.gt.0.3) then
    124            lsup=l
    125            tetarappell=1./8.*(-log(zsig)-.5)
    126            DO j=1,jjp1
     141          DO l=1,llm
     142            zsig=ap(l)/preff+bp(l)
     143            if (zsig.gt.0.3) then
     144             lsup=l
     145             tetarappell=1./8.*(-log(zsig)-.5)
     146             DO j=1,jjp1
    127147             ddsin=sin(rlatu(j))-sin(pi/20.)
    128148             tetajl(j,l)=300.*(1+1./18.*(1.-3.*ddsin*ddsin)+tetarappell)
    129            ENDDO
    130           else
     149             ENDDO
     150            else
    131151c   Choix isotherme au-dessus de 300 mbar
    132            do j=1,jjp1
    133              tetajl(j,l)=tetajl(j,lsup)*(0.3/zsig)**kappa
    134            enddo
    135           endif ! of if (zsig.gt.0.3)
    136         ENDDO ! of DO l=1,llm
    137 
    138         do l=1,llm
    139            do j=1,jjp1
     152             do j=1,jjp1
     153               tetajl(j,l)=tetajl(j,lsup)*(0.3/zsig)**kappa
     154             enddo
     155            endif ! of if (zsig.gt.0.3)
     156          ENDDO ! of DO l=1,llm
     157
     158          do l=1,llm
     159            do j=1,jjp1
    140160              do i=1,iip1
    141161                 ij=(j-1)*iip1+i
    142162                 tetarappel(ij,l)=tetajl(j,l)
    143163              enddo
    144            enddo
    145         enddo
     164            enddo
     165          enddo
    146166
    147167c       call dump2d(jjp1,llm,tetajl,'TEQ   ')
    148168
    149         ps=1.e5
    150         phis=0.
    151         CALL pression ( ip1jmp1, ap, bp, ps, p       )
    152         CALL exner_hyb( ip1jmp1, ps, p,alpha,beta, pks, pk, pkf )
    153         CALL massdair(p,masse)
     169          CALL pression ( ip1jmp1, ap, bp, ps, p       )
     170          CALL exner_hyb( ip1jmp1, ps, p,alpha,beta, pks, pk, pkf )
     171          CALL massdair(p,masse)
    154172
    155173c  intialisation du vent et de la temperature
    156         teta(:,:)=tetarappel(:,:)
    157         CALL geopot(ip1jmp1,teta,pk,pks,phis,phi)
    158         call ugeostr(phi,ucov)
    159         vcov=0.
    160         q(:,:,1   )=1.e-10
    161         q(:,:,2   )=1.e-15
    162         q(:,:,3:nqtot)=0.
     174          teta(:,:)=tetarappel(:,:)
     175          CALL geopot(ip1jmp1,teta,pk,pks,phis,phi)
     176          call ugeostr(phi,ucov)
     177          vcov=0.
     178          q(:,:,1   )=1.e-10
     179          q(:,:,2   )=1.e-15
     180          q(:,:,3:nqtot)=0.
    163181
    164182
    165183c   perturbation aleatoire sur la temperature
    166         idum  = -1
    167         zz = ran1(idum)
    168         idum  = 0
    169         do l=1,llm
    170            do ij=iip2,ip1jm
     184          idum  = -1
     185          zz = ran1(idum)
     186          idum  = 0
     187          do l=1,llm
     188            do ij=iip2,ip1jm
    171189              teta(ij,l)=teta(ij,l)*(1.+0.005*ran1(idum))
    172            enddo
    173         enddo
    174 
    175         do l=1,llm
    176            do ij=1,ip1jmp1,iip1
     190            enddo
     191          enddo
     192
     193          do l=1,llm
     194            do ij=1,ip1jmp1,iip1
    177195              teta(ij+iim,l)=teta(ij,l)
    178            enddo
    179         enddo
     196            enddo
     197          enddo
    180198
    181199
     
    187205
    188206c   initialisation d'un traceur sur une colonne
    189         j=jjp1*3/4
    190         i=iip1/2
    191         ij=(j-1)*iip1+i
    192         q(ij,:,3)=1.
    193      
     207          j=jjp1*3/4
     208          i=iip1/2
     209          ij=(j-1)*iip1+i
     210          q(ij,:,3)=1.
     211        endif ! of if (iflag_phys.eq.2)
     212       
    194213      else
    195214        write(lunout,*)"iniacademic: planet types other than earth",
  • LMDZ4/branches/LMDZ4V5.0-dev/libf/dyn3dpar/leapfrog_p.F

    r1357 r1363  
    13541354                call Gather_Field(ucov,ip1jmp1,llm,0)
    13551355                call Gather_Field(teta,ip1jmp1,llm,0)
     1356                call Gather_Field(pk,ip1jmp1,llm,0)
    13561357                call Gather_Field(phi,ip1jmp1,llm,0)
    13571358                do iq=1,nqtot
     
    15591560                call Gather_Field(ucov,ip1jmp1,llm,0)
    15601561                call Gather_Field(teta,ip1jmp1,llm,0)
     1562                call Gather_Field(pk,ip1jmp1,llm,0)
    15611563                call Gather_Field(phi,ip1jmp1,llm,0)
    15621564                do iq=1,nqtot
     
    16241626                call Gather_Field(phis,ip1jmp1,1,0)
    16251627                if (mpi_rank==0) then
    1626                  CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
     1628                 CALL writehist(itau,vcov,ucov,teta,phi,q,masse,ps,phis)
    16271629                endif
    16281630!                CALL writehist_p(histid, histvid, itau,vcov ,
  • LMDZ4/branches/LMDZ4V5.0-dev/run.def

    r1300 r1363  
    2020## periode de sortie des variables de controle (en pas)
    2121iconser=240
    22 ## periode d'ecriture du fichier histoire (en jour)
    23 iecri=1
     22## sorties instantanees dans la dynamique (fichiers dyn_hist.nc and co.)
     23ok_dyn_ins=n
     24## periode d'ecriture des sorties instantanees dans la dynamique
     25## (en pas dynamiques)
     26iecri=960
     27## sorties de valeurs moyennes dans la dynamique (fichiers dyn_hist_ave.nc and co.)
     28ok_dyn_ave=n
     29## periode de stockage des moyennes dans la dynamique et dans dynzon
     30periodav=30
    2431## flag de sortie dynzon
    2532ok_dynzon=n
    26 ## periode de stockage fichier dynzon (en jour)
    27 periodav=30
    2833## activation du calcul d equilibrage de charge
    29 adjust=0
     34adjust=n
    3035## activation du filtre fft
    3136use_filtre_fft=n
Note: See TracChangeset for help on using the changeset viewer.