Changeset 2133


Ignore:
Timestamp:
Apr 30, 2019, 10:34:11 AM (6 years ago)
Author:
jvatant
Message:

Fic a bug in r2131 the writediagfi cannot be called
in RT routines because of the iradia it goes crazy with outputs freq ...
--JVO

Location:
trunk
Files:
15 edited

Legend:

Unmodified
Added
Removed
  • trunk/LMDZ.GENERIC/README

    r2131 r2133  
    14791479
    14801480== 29/04/2019 == JVO
    1481 + Add diagnostics of optical thickness, in 1D, if 'diagdtau' key is activated, it
     1481+ Add diagnostics of optical thickness, if 'diagdtau' key is activated, it
    14821482 outputs dtaui/v(altitude) in diagfi.nc for every narrowband (could be done with one var
    14831483 but would require to be able to have writediag in 5D)
  • trunk/LMDZ.GENERIC/libf/phystd/callcorrk.F90

    r2051 r2133  
    1212          fluxabs_sw,fluxtop_dn,                               &
    1313          OLR_nu,OSR_nu,                                       &
     14          int_dtaui,int_dtauv,                                 &
    1415          tau_col,cloudfrac,totcloudfrac,                      &
    1516          clearsky,firstcall,lastcall)
     
    9495      REAL,INTENT(OUT) :: albedo_equivalent(ngrid)       ! Spectrally Integrated Albedo. For Diagnostic. By MT2015
    9596      REAL,INTENT(OUT) :: totcloudfrac(ngrid)            ! Column Fraction of clouds (%).
     97      REAL,INTENT(OUT) :: int_dtaui(ngrid,nlayer,L_NSPECTI) ! VI optical thickness of layers within narrowbands for diags ().
     98      REAL,INTENT(OUT) :: int_dtauv(ngrid,nlayer,L_NSPECTV) ! IR optical thickness of layers within narrowbands for diags ().
    9699     
    97100     
     
    925928             *glat(ig)/(cpp*scalep*(plevrad(3)-plevrad(2)))
    926929
     930      !  Optical thickness diagnostics (added by JVO)
     931      if (diagdtau) then
     932        do l=1,L_NLAYRAD
     933          do nw=1,L_NSPECTV
     934            int_dtauv(ig,l,nw) = 0.0d0
     935             DO k=1,L_NGAUSS
     936              int_dtauv(ig,l,nw)= int_dtauv(ig,l,nw) + dtauv(l,nw,k)*gweight(k)
     937             ENDDO
     938          enddo
     939          do nw=1,L_NSPECTI
     940           int_dtaui(ig,l,nw) = 0.0d0
     941             DO k=1,L_NGAUSS
     942              int_dtaui(ig,l,nw)= int_dtaui(ig,l,nw) + dtaui(l,nw,k)*gweight(k)
     943             ENDDO
     944          enddo
     945        enddo
     946      endif       
     947
    927948
    928949!-----------------------------------------------------------------------   
  • trunk/LMDZ.GENERIC/libf/phystd/inifis_mod.F90

    r2131 r2133  
    331331     call getin_p("diagdtau",diagdtau)
    332332     write(*,*)" diagdtau = ",diagdtau
    333      ! sanity check
    334      if (diagdtau.and.(ngrid.ne.1)) then
    335        print*,"Diagnostic optical thickness can be output in 1D only !"
    336        print*,"Start again with diagdtau=.false."
    337        stop
    338      endif
    339333
    340334     write(*,*)"Operate in kastprof mode?"
  • trunk/LMDZ.GENERIC/libf/phystd/optci.F90

    r2131 r2133  
    1111  use radinc_h, only: L_LEVELS, L_NLAYRAD, L_NSPECTI, L_NGAUSS, &
    1212                      L_NLEVRAD, L_REFVAR, naerkind
    13   use radcommon_h, only: gasi,tlimit,wrefVAR,Cmk,tgasref,pfgasref,wnoi,scalep,indi,glat_ig,gweight
     13  use radcommon_h, only: gasi,tlimit,wrefVAR,Cmk,tgasref,pfgasref,wnoi,scalep,indi,glat_ig
    1414  use gases_h, only: gfrac, ngasmx, igas_N2, igas_He, igas_H2O, igas_H2
    1515  use comcstfi_mod, only: g, r, mugaz
    16   use callkeys_mod, only: kastprof,continuum,graybody,H2Ocont_simple,diagdtau
     16  use callkeys_mod, only: kastprof,continuum,graybody,H2Ocont_simple
    1717  implicit none
    1818
     
    2525  !     and COSBAR. For each level it calculates TAU.
    2626  !     
    27   !     TAUI(L,LW) is the cumulative optical depth at level L (or alternatively
     27  !     TAUCUMI(L,LW) is the cumulative optical depth at level L (or alternatively
    2828  !     at the *bottom* of layer L), LW is the spectral wavelength interval.
    2929  !     
     
    8383  real*8 dz(L_LEVELS)
    8484  !real*8 rho !! see test below
    85 
    86   ! variables for diags of optical depth
    87   real *8 INT_DTAU(L_NLAYRAD,L_NSPECTI)
    88   character*2 str2
    8985
    9086  integer igas, jgas
     
    454450!  call abort
    455451
    456 
    457   !  Optical thickness for 1D diagnostics (added by JVO)
    458   if (diagdtau) then ! diagtau can be true only if 1D
    459     do l=1,L_NLAYRAD
    460        do nw=1,L_NSPECTI
    461         INT_DTAU(L,NW) = 0.0d+0
    462           DO NG=1,L_NGAUSS
    463              INT_DTAU(L,NW)= INT_DTAU(L,NW) + dtaui(L,nw,ng)*gweight(NG)
    464           enddo
    465        enddo
    466     enddo
    467     do nw=1,L_NSPECTI
    468       write(str2,'(i2.2)') nw
    469       call writediagfi(1,'dtaui'//str2,'Layer optical thickness in IR band '//str2,'',1,int_dtau(L_NLAYRAD:1:-1,nw))
    470     enddo
    471   endif
    472  
    473  
    474 
    475452end subroutine optci
    476453
  • trunk/LMDZ.GENERIC/libf/phystd/optcv.F90

    r2131 r2133  
    1010
    1111  use radinc_h, only: L_NLAYRAD, L_NLEVRAD, L_LEVELS, L_NSPECTV, L_NGAUSS, L_REFVAR, NAERKIND
    12   use radcommon_h, only: gasv, tlimit, wrefVAR, Cmk, tgasref, pfgasref,wnov,scalep,indv,glat_ig,gweight
     12  use radcommon_h, only: gasv, tlimit, wrefVAR, Cmk, tgasref, pfgasref,wnov,scalep,indv,glat_ig
    1313  use gases_h, only: gfrac, ngasmx, igas_H2, igas_H2O, igas_He, igas_N2
    1414  use comcstfi_mod, only: g, r, mugaz
    15   use callkeys_mod, only: kastprof,continuum,graybody,H2Ocont_simple,callgasvis,diagdtau
     15  use callkeys_mod, only: kastprof,continuum,graybody,H2Ocont_simple,callgasvis
    1616
    1717  implicit none
     
    9292  real*8 dz(L_LEVELS)
    9393
    94   ! variables for diags of optical depth
    95   real*8 INT_DTAU(L_NLAYRAD,L_NSPECTV)
    96   character*2 str2
    9794
    9895  integer igas, jgas
     
    379376
    380377
    381   !  Optical thickness for 1D diagnostics (added by JVO)
    382   if (diagdtau) then ! diagtau can be true only if 1D
    383     do l=1,L_NLAYRAD
    384        do nw=1,L_NSPECTV
    385         INT_DTAU(L,NW) = 0.0d+0
    386           DO NG=1,L_NGAUSS
    387              INT_DTAU(L,NW)= INT_DTAU(L,NW) + dtauv(L,nw,ng)*gweight(NG)
    388           enddo
    389        enddo
    390     enddo
    391     do nw=1,L_NSPECTV
    392       write(str2,'(i2.2)') nw
    393       call writediagfi(1,'dtauv'//str2,'Layer optical thickness in VI band '//str2,'',1,int_dtau(L_NLAYRAD:1:-1,nw))
    394     enddo
    395   endif
    396378
    397379
  • trunk/LMDZ.GENERIC/libf/phystd/phys_state_var_mod.F90

    r1883 r2133  
    6464      !real,dimension(:),allocatable,save :: sensibFlux      ! Turbulent flux given by the atmosphere to the surface (W.m-2).
    6565!$OMP THREADPRIVATE(OLR_nu,OSR_nu,zdtlw,zdtsw)
     66
     67      real,dimension(:,:,:),allocatable,save :: int_dtauv   ! VI optical thickness of layers within narrowbands for diags ().
     68      real,dimension(:,:,:),allocatable,save :: int_dtaui   ! IR optical thickness of layers within narrowbands for diags ().
     69!$OMP THREADPRIVATE(int_dtaui,int_dtauv)
    6670
    6771      real,allocatable,dimension(:),save :: tau_col ! Total Aerosol Optical Depth.
     
    146150        ALLOCATE(OLR_nu(klon,L_NSPECTI))
    147151        ALLOCATE(OSR_nu(klon,L_NSPECTV))
     152        ALLOCATE(int_dtaui(klon,klev,L_NSPECTI))
     153        ALLOCATE(int_dtauv(klon,klev,L_NSPECTV))
    148154        ALLOCATE(sensibFlux(klon))
    149155        ALLOCATE(zdtlw(klon,klev))
     
    217223        DEALLOCATE(OLR_nu)
    218224        DEALLOCATE(OSR_nu)
     225        DEALLOCATE(int_dtaui)
     226        DEALLOCATE(int_dtauv)
    219227        DEALLOCATE(sensibFlux)
    220228        DEALLOCATE(zdtlw)
  • trunk/LMDZ.GENERIC/libf/phystd/physiq_mod.F90

    r2132 r2133  
    412412      real tau_col1(ngrid)                                                   ! For aerosol optical depth diagnostic.
    413413      real OLR_nu1(ngrid,L_NSPECTI), OSR_nu1(ngrid,L_NSPECTV)                ! For Outgoing Radiation diagnostics.
     414      real int_dtaui1(ngrid,nlayer,L_NSPECTI),int_dtauv1(ngrid,nlayer,L_NSPECTV) ! For optical thickness diagnostics.
    414415      real tf, ntf
    415416
     
    435436#endif
    436437
     438      ! Misc
     439      character*2 :: str2
    437440!==================================================================================================
    438441
     
    901904                              fluxsurfabs_sw,fluxtop_lw,                          &
    902905                              fluxabs_sw,fluxtop_dn,OLR_nu,OSR_nu,                &
     906                              int_dtaui,int_dtauv,                                &
    903907                              tau_col,cloudfrac,totcloudfrac,                     &
    904908                              clearsky,firstcall,lastcall)     
     
    915919                                 fluxsurfabs_sw1,fluxtop_lw1,                        &
    916920                                 fluxabs_sw1,fluxtop_dn,OLR_nu1,OSR_nu1,             &
     921                                 int_dtaui1,int_dtauv1,                              &
    917922                                 tau_col1,cloudfrac,totcloudfrac,                    &
    918923                                 clearsky,firstcall,lastcall)
     
    936941                     OSR_nu(ig,1:L_NSPECTV) = ntf*OSR_nu1(ig,1:L_NSPECTV) + tf*OSR_nu(ig,1:L_NSPECTV)                       
    937942                     OLR_nu(ig,1:L_NSPECTI) = ntf*OLR_nu1(ig,1:L_NSPECTI) + tf*OLR_nu(ig,1:L_NSPECTI)                       
     943                     int_dtauv(ig,:,1:L_NSPECTV) = ntf*int_dtauv1(ig,:,1:L_NSPECTV) + tf*int_dtauv(ig,:,1:L_NSPECTV)                       
     944                     int_dtaui(ig,:,1:L_NSPECTI) = ntf*int_dtaui1(ig,:,1:L_NSPECTI) + tf*int_dtaui(ig,:,1:L_NSPECTI)                       
    938945                  enddo                               
    939946
     
    21862193      endif ! end of 'enertest'
    21872194
     2195        ! Diagnostics of optical thickness
     2196        if (diagdtau) then               
     2197          do nw=1,L_NSPECTV
     2198            write(str2,'(i2.2)') nw
     2199            call writediagfi(ngrid,'dtauv'//str2,'Layer optical thickness in VI band '//str2,'',1,int_dtauv(:,nlayer:1:-1,nw))
     2200          enddo
     2201          do nw=1,L_NSPECTI
     2202            write(str2,'(i2.2)') nw
     2203            call writediagfi(ngrid,'dtaui'//str2,'Layer optical thickness in IR band '//str2,'',1,int_dtaui(:,nlayer:1:-1,nw))
     2204          enddo
     2205        endif
     2206
    21882207
    21892208        ! Temporary inclusions for heating diagnostics.
  • trunk/LMDZ.GENERIC/libf/phystd/radcommon_h.F90

    r2033 r2133  
    11module radcommon_h
    2       use radinc_h, only: L_NSPECTI, L_NSPECTV, L_NGAUSS, NTstar, NTstop, &
     2      use radinc_h, only: L_NSPECTI, L_NSPECTV, NTstar, NTstop, &
    33                          naerkind, nsizemax
    44      implicit none
  • trunk/LMDZ.TITAN/README

    r2131 r2133  
    15591559
    15601560== 29/04/2019 == JVO
    1561 + Add diagnostics of optical thickness, in 1D, if 'diagdtau' key is activated, it
     1561+ Add diagnostics of optical thickness, if 'diagdtau' key is activated, it
    15621562 outputs dtaui/v(altitude) in diagfi.nc for every narrowband (could be done with one var
    15631563 but would require to be able to have writediag in 5D)
  • trunk/LMDZ.TITAN/libf/phytitan/callcorrk.F90

    r2050 r2133  
    66          fluxabs_sw,fluxtop_dn,                               &
    77          OLR_nu,OSR_nu,                                       &
     8          int_dtaui,int_dtauv,                                 &
    89          lastcall)
    910
     
    1617      use comcstfi_mod, only: pi, mugaz, cpp
    1718      use callkeys_mod, only: diurnal,tracer,seashaze,corrk_recombin,   &
    18                               strictboundcorrk,specOLR
     19                              strictboundcorrk,specOLR,diagdtau
    1920      use geometry_mod, only: latitude
    2021
     
    7475      REAL,INTENT(OUT) :: OSR_nu(ngrid,L_NSPECTV)        ! Outgoing SW radition in each band (Normalized to the band width (W/m2/cm-1).
    7576      REAL,INTENT(OUT) :: albedo_equivalent(ngrid)       ! Spectrally Integrated Albedo. For Diagnostic. By MT2015
     77      REAL,INTENT(OUT) :: int_dtaui(ngrid,nlayer,L_NSPECTI) ! VI optical thickness of layers within narrowbands for diags ().
     78      REAL,INTENT(OUT) :: int_dtauv(ngrid,nlayer,L_NSPECTV) ! IR optical thickness of layers within narrowbands for diags ().
    7679     
    7780     
     
    534537
    535538
     539      !  Optical thickness diagnostics (added by JVO)
     540      if (diagdtau) then
     541        do l=1,L_NLAYRAD
     542          do nw=1,L_NSPECTV
     543            int_dtauv(ig,l,nw) = 0.0d0
     544             DO k=1,L_NGAUSS
     545              int_dtauv(ig,l,nw)= int_dtauv(ig,l,nw) + dtauv(l,nw,k)*gweight(k)
     546             ENDDO
     547          enddo
     548          do nw=1,L_NSPECTI
     549           int_dtaui(ig,l,nw) = 0.0d0
     550             DO k=1,L_NGAUSS
     551              int_dtaui(ig,l,nw)= int_dtaui(ig,l,nw) + dtaui(l,nw,k)*gweight(k)
     552             ENDDO
     553          enddo
     554        enddo
     555      endif       
     556
     557
    536558!-----------------------------------------------------------------------   
    537559      end do ! End of big loop over every GCM column.
    538560!-----------------------------------------------------------------------
    539 
    540561
    541562
  • trunk/LMDZ.TITAN/libf/phytitan/inifis_mod.F90

    r2131 r2133  
    341341     call getin_p("diagdtau",diagdtau)
    342342     write(*,*)" diagdtau = ",diagdtau
    343      ! sanity check
    344      if (diagdtau.and.(ngrid.ne.1)) then
    345        print*,"Diagnostic optical thickness can be output in 1D only !"
    346        print*,"Start again with diagdtau=.false."
    347        stop
    348      endif
    349 
    350343
    351344     write(*,*)"Uniform absorption in radiative transfer?"
  • trunk/LMDZ.TITAN/libf/phytitan/optci.F90

    r2131 r2133  
    44  use radinc_h
    55  use radcommon_h, only: gasi,gasi_recomb,tlimit,Cmk,gzlat_ig, &
    6                          tgasref,pfgasref,wnoi,scalep,indi,gweight
     6                         tgasref,pfgasref,wnoi,scalep,indi
    77  use gases_h
    88  use comcstfi_mod, only: r
    9   use callkeys_mod, only: continuum,graybody,corrk_recombin,diagdtau,      &
     9  use callkeys_mod, only: continuum,graybody,corrk_recombin,               &
    1010                          callclouds,callmufi,seashaze,uncoupl_optic_haze
    1111  use tracer_h, only : nmicro,nice
     12  use MMP_OPTICS
    1213
    1314  implicit none
     
    5960  real*8 SSA_T(L_LEVELS,L_NSPECTI)
    6061  real*8 ASF_T(L_LEVELS,L_NSPECTI)
    61   real*8 INT_DTAU(L_NLAYRAD,L_NSPECTI)
    62 
    63   CHARACTER*2  str2
    6462  ! ==========================
    6563
     
    409407  ! ascending ray with angle theta = 0.
    410408
    411 
    412   !  Optical thickness for 1D diagnostics (added by JVO)
    413   if (diagdtau) then ! diagtau can be true only if 1D
    414     do l=1,L_NLAYRAD
    415        do nw=1,L_NSPECTI
    416         INT_DTAU(L,NW) = 0.0d+0
    417           DO NG=1,L_NGAUSS
    418              INT_DTAU(L,NW)= INT_DTAU(L,NW) + dtaui(L,nw,ng)*gweight(NG)
    419           enddo
    420        enddo
    421     enddo
    422     do nw=1,L_NSPECTI
    423       write(str2,'(i2.2)') nw
    424       call writediagfi(1,'dtaui'//str2,'Layer optical thickness in IR band '//str2,'',1,int_dtau(L_NLAYRAD:1:-1,nw))
    425     enddo
    426   endif
    427  
    428 
    429409  if(firstcall) firstcall = .false.
    430410
  • trunk/LMDZ.TITAN/libf/phytitan/optcv.F90

    r2131 r2133  
    44  use radinc_h
    55  use radcommon_h, only: gasv,gasv_recomb,tlimit,Cmk,gzlat_ig, &
    6                          tgasref,pfgasref,wnov,scalep,indv,gweight
     6                         tgasref,pfgasref,wnov,scalep,indv
    77  use gases_h
    88  use comcstfi_mod, only: r
    9   use callkeys_mod, only: continuum,graybody,callgasvis,corrk_recombin,diagdtau,  &
     9  use callkeys_mod, only: continuum,graybody,callgasvis,corrk_recombin,     &
    1010                          callclouds,callmufi,seashaze,uncoupl_optic_haze
    1111  use tracer_h, only: nmicro,nice
     
    6868  real*8 SSA_T(L_LEVELS,L_NSPECTI)
    6969  real*8 ASF_T(L_LEVELS,L_NSPECTI)
    70   real*8 INT_DTAU(L_NLAYRAD,L_NSPECTI)
    71  
    72   CHARACTER*2  str2
    7370  ! ==========================
    7471
     
    390387
    391388
    392   !  Optical thickness for 1D diagnostics (added by JVO)
    393   if (diagdtau) then ! diagtau can be true only if 1D
    394     do l=1,L_NLAYRAD
    395        do nw=1,L_NSPECTV
    396         INT_DTAU(L,NW) = 0.0d+0
    397           DO NG=1,L_NGAUSS
    398              INT_DTAU(L,NW)= INT_DTAU(L,NW) + dtauv(L,nw,ng)*gweight(NG)
    399           enddo
    400        enddo
    401     enddo
    402     do nw=1,L_NSPECTV
    403       write(str2,'(i2.2)') nw
    404       call writediagfi(1,'dtauv'//str2,'Layer optical thickness in VI band '//str2,'',1,int_dtau(L_NLAYRAD:1:-1,nw))
    405     enddo
    406   endif
    407 
    408 
    409389  if(firstcall) firstcall = .false.
    410390
  • trunk/LMDZ.TITAN/libf/phytitan/physiq_mod.F90

    r2117 r2133  
    252252      real,dimension(:,:),allocatable,save :: zdtsw         ! SW heating tendencies (K/s).
    253253      real,dimension(:),allocatable,save :: sensibFlux      ! Turbulent flux given by the atmosphere to the surface (W.m-2).
    254      
    255 !$OMP THREADPRIVATE(fluxsurf_lw,fluxsurf_sw,fluxsurfabs_sw,fluxtop_lw,fluxabs_sw,fluxtop_dn,fluxdyn,OLR_nu,OSR_nu,&
    256        
    257         !$OMP zdtlw,zdtsw,sensibFlux)
     254      real,dimension(:,:,:),allocatable,save :: int_dtauv   ! VI optical thickness of layers within narrowbands for diags ().
     255      real,dimension(:,:,:),allocatable,save :: int_dtaui   ! IR optical thickness of layers within narrowbands for diags ().
     256     
     257!$OMP THREADPRIVATE(fluxsurf_lw,fluxsurf_sw,fluxsurfabs_sw,fluxtop_lw,fluxabs_sw,fluxtop_dn,fluxdyn,OLR_nu,OSR_nu,&       
     258        !$OMP zdtlw,zdtsw,sensibFlux,int_dtauv,int_dtaui))
    258259
    259260      real zls                       ! Solar longitude (radians).
     
    368369      character(len=10) :: tmp1
    369370      character(len=10) :: tmp2
     371     
     372      character*2 :: str2
    370373
    371374! Local variables for Titan chemistry and microphysics
     
    468471        ALLOCATE(zdtlw(ngrid,nlayer))
    469472        ALLOCATE(zdtsw(ngrid,nlayer))
     473        ALLOCATE(int_dtaui(ngrid,nlayer,L_NSPECTI))
     474        ALLOCATE(int_dtauv(ngrid,nlayer,L_NSPECTV))
    470475 
    471476        ! This is defined in comsaison_h
     
    501506           call sugas_corrk       ! Set up gaseous absorption properties.
    502507         
    503            OLR_nu(:,:) = 0.
    504            OSR_nu(:,:) = 0.
     508           OLR_nu(:,:) = 0.D0
     509           OSR_nu(:,:) = 0.D0
     510           
     511           int_dtaui(:,:,:) = 0.D0
     512           int_dtauv(:,:,:) = 0.D0
    505513           
    506514         endif
     
    855863                              fluxsurfabs_sw,fluxtop_lw,                          &
    856864                              fluxabs_sw,fluxtop_dn,OLR_nu,OSR_nu,                &
    857                               lastcall)
     865                              int_dtaui,int_dtauv,lastcall)
    858866
    859867               ! Radiative flux from the sky absorbed by the surface (W.m-2).
     
    15091517         
    15101518      endif ! end of 'enertest'
     1519
     1520        ! Diagnostics of optical thickness
     1521        if (diagdtau) then               
     1522          do nw=1,L_NSPECTV
     1523            write(str2,'(i2.2)') nw
     1524            call writediagfi(ngrid,'dtauv'//str2,'Layer optical thickness in VI band '//str2,'',1,int_dtauv(:,nlayer:1:-1,nw))
     1525          enddo
     1526          do nw=1,L_NSPECTI
     1527            write(str2,'(i2.2)') nw
     1528            call writediagfi(ngrid,'dtaui'//str2,'Layer optical thickness in IR band '//str2,'',1,int_dtaui(:,nlayer:1:-1,nw))
     1529          enddo
     1530        endif
    15111531
    15121532        ! Temporary inclusions for winds diagnostics.
  • trunk/LMDZ.TITAN/libf/phytitan/radcommon_h.F90

    r2050 r2133  
    11module radcommon_h
    2       use radinc_h, only: L_NSPECTI, L_NSPECTV, L_NGAUSS, NTstar, NTstop
     2      use radinc_h, only: L_NSPECTI, L_NSPECTV, NTstar, NTstop
    33      implicit none
    44
     
    8181
    8282      real*8,save :: PTOP
    83       real*8,save,allocatable :: TAUREF(:)
     83!$OMP THREADPRIVATE(tstellar,planckir,PTOP)
    8484
    8585      real*8,parameter :: UBARI = 0.5D0
    86 
    87 !$OMP THREADPRIVATE(QREFvis,QREFir,omegaREFvis,omegaREFir,&
    88                 !$OMP tstellar,planckir,PTOP)
    8986
    9087!     If the gas optical depth (top to the surface) is less than
Note: See TracChangeset for help on using the changeset viewer.