Ignore:
Timestamp:
Jul 24, 2017, 5:06:29 PM (7 years ago)
Author:
aslmd
Message:

MESOSCALE. makemeso module_initialize_les module_initialize_real reverted back to r1723 because commit r1724 was based on corrupted versions.

Location:
trunk/MESOSCALE/LMD_MM_MARS/SRC
Files:
2 edited

Legend:

Unmodified
Added
Removed
  • trunk/MESOSCALE/LMD_MM_MARS/SRC/LES/modif_mars/module_initialize_les.F

    r1724 r1746  
    8686
    8787   INTEGER, PARAMETER :: nl_max = 1000
    88    REAL, DIMENSION(nl_max) :: zk, p_in, theta, Tz, rho, u, v, qv, pd_in
     88   REAL, DIMENSION(nl_max) :: zk, p_in, theta, rho, u, v, qv, pd_in
    8989   INTEGER :: nl_in
    9090
     
    116116 ! for mode 3
    117117 REAL, DIMENSION(nl_max) :: profdustq,profdustn
    118  REAL, DIMENSION(nl_max) :: hrsw,hrlw,hrdyn
    119  REAL, DIMENSION(nl_max) :: trac
    120  REAL, DIMENSION(nl_max) :: prescribed_sw,prescribed_lw,prescribed_dyn
    121  REAL, DIMENSION(nl_max) :: venus_hrdyn
    122  REAL, DIMENSION(nl_max) :: altitude
     118 REAL, DIMENSION(nl_max) :: prescribed_sw,prescribed_lw
    123119!!MARS
    124120
     
    127123      !INTEGER :: hypsometric_opt = 2 ! Wee et al. 2012 correction
    128124
     125character(len=10) :: planet
    129126
    130127#ifdef DM_PARALLEL
    131128#    include <data_calls.inc>
    132129#endif
     130 
     131   call init_planet_constants
    133132
    134133   SELECT CASE ( model_data_order )
     
    173172
    174173
    175    stretch_grid = .false.
     174   !stretch_grid = .false.
    176175!  FOR LES, set stretch to false
    177    !stretch_grid = .true.
     176   stretch_grid = .true.
    178177   delt = 3.
    179178!   z_scale = .50
    180179!   z_scale = .10
    181180!   z_scale = .25
    182 !   z_scale = .1
     181!   z_scale = .15
    183182   pi = 2.*asin(1.0)
    184183   write(6,*) ' pi is ',pi
     
    303302   grid%rdx = 1./config_flags%dx
    304303   grid%rdy = 1./config_flags%dy
     304
    305305!  get the sounding from the ascii sounding file, first get dry sounding and
    306306!  calculate base state
     
    310310  write(6,*) ' getting dry sounding for base state '
    311311
    312   CALL get_sounding( zk, p_in, pd_in, theta, Tz, rho, u, v, qv, dry_sounding, nl_max, nl_in )
     312  CALL get_sounding( zk, p_in, pd_in, theta, rho, u, v, qv, dry_sounding, nl_max, nl_in )
    313313  ENDIF
    314314  CALL wrf_dm_bcast_real( zk , nl_max )
     
    316316  CALL wrf_dm_bcast_real( pd_in , nl_max )
    317317  CALL wrf_dm_bcast_real( theta , nl_max )
    318   CALL wrf_dm_bcast_real( Tz , nl_max )
    319318  CALL wrf_dm_bcast_real( rho , nl_max )
    320319  CALL wrf_dm_bcast_real( u , nl_max )
     
    385384  ENDDO
    386385
    387   xs=ide/2 -25
    388   !xs=ids   -3
    389   !xe=xs + 6
    390   xe=xs + 25
    391   !ys=jde/2 -3
    392   ys=jde/2 -25
    393   !ye=ys + 6
    394   ye=ys + 25
    395   mtn_ht = 1000
     386  xs=ide/2 -3
     387  xs=ids   -3
     388  xe=xs + 6
     389  ys=jde/2 -3
     390  ye=ys + 6
     391  mtn_ht = 500
    396392#ifdef MTN
    397393  DO j=max(ys,jds),min(ye,jde-1)
    398394  DO i=max(xs,ids),min(xe,ide-1)
    399      grid%ht(i,j) = alt_input + mtn_ht * 0.25 * &
     395     grid%ht(i,j) = mtn_ht * 0.25 * &
    400396               ( 1. + COS ( 2*pi/(xe-xs) * ( i-xs ) + pi ) ) * &
    401397               ( 1. + COS ( 2*pi/(ye-ys) * ( j-ys ) + pi ) )
     
    438434      p_level = grid%znu(k)*(p_surf - grid%p_top) + grid%p_top
    439435      grid%pb(i,k,j) = p_level
    440       grid%t_init(i,k,j) = interp_0_log( theta, p_in, p_level, nl_in ) - t0
    441       grid%tz_init(i,k,j) = interp_0_log( Tz, p_in, p_level, nl_in )
     436      grid%t_init(i,k,j) = interp_0( theta, p_in, p_level, nl_in ) - t0
    442437      grid%alb(i,k,j) = (r_d/p1000mb)*(grid%t_init(i,k,j)+t0)*(grid%pb(i,k,j)/p1000mb)**cvpm
    443438    ENDDO
     
    463458  ENDDO
    464459  ENDDO
     460
    465461  IF ( wrf_dm_on_monitor() ) THEN
    466462    write(6,*) ' ptop is ',grid%p_top
     
    472468  write(6,*) ' getting moist sounding for full state '
    473469  dry_sounding = .false.
    474   CALL get_sounding( zk, p_in, pd_in, theta, Tz, rho, u, v, qv, dry_sounding, nl_max, nl_in )
     470  CALL get_sounding( zk, p_in, pd_in, theta, rho, u, v, qv, dry_sounding, nl_max, nl_in )
    475471
    476472  DO J = jts, min(jde-1,jte)
     
    495491      p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    496492
    497       moist(i,k,j,P_QV) = interp_0_log( qv, pd_in, p_level, nl_in )
    498       grid%t_1(i,k,j)          = interp_0_log( theta, pd_in, p_level, nl_in ) - t0
     493      moist(i,k,j,P_QV) = interp_0( qv, pd_in, p_level, nl_in )
     494      grid%t_1(i,k,j)          = interp_0( theta, pd_in, p_level, nl_in ) - t0
    499495      grid%t_2(i,k,j)          = grid%t_1(i,k,j)
    500496     
     
    698694    DO K = 1, kte-1
    699695      p_level = grid%znu(k)*(p_surf - grid%p_top) + grid%p_top
    700       grid%v_1(i,k,j) = interp_0_log( v, p_in, p_level, nl_in )
     696      grid%v_1(i,k,j) = interp_0( v, p_in, p_level, nl_in )
    701697      grid%v_2(i,k,j) = grid%v_1(i,k,j)
    702698    ENDDO
     
    722718    DO K = 1, kte-1
    723719      p_level = grid%znu(k)*(p_surf - grid%p_top) + grid%p_top
    724       grid%u_1(i,k,j) = interp_0_log( u, p_in, p_level, nl_in )
     720      grid%u_1(i,k,j) = interp_0( u, p_in, p_level, nl_in )
    725721      grid%u_2(i,k,j) = grid%u_1(i,k,j)
    726722    ENDDO
     
    851847      DO k=1,kte-1
    852848         p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    853          scalar(its:ite,k,jts:jte,2) = interp_0_log( qv, pd_in, p_level, nl_in )
     849         scalar(its:ite,k,jts:jte,2) = interp_0( qv, pd_in, p_level, nl_in )
    854850         scalar(its:ite,k,jts:jte,3) = 0.
    855851           !! water ice is set to 0 (was put into water vapor when building prof from MCD)
     
    866862      DO k=1,kte-1
    867863         p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    868          scalar(its:ite,k,jts:jte,4) = interp_0_log( profdustq, pd_in, p_level, nl_in )
    869          scalar(its:ite,k,jts:jte,5) = interp_0_log( profdustn, pd_in, p_level, nl_in )
     864         scalar(its:ite,k,jts:jte,4) = interp_0( profdustq, pd_in, p_level, nl_in )
     865         scalar(its:ite,k,jts:jte,5) = interp_0( profdustn, pd_in, p_level, nl_in )
    870866      ENDDO
    871867      print *, "DUST Q", scalar(its,:,jts,4)
     
    886882       DO i = its, ite
    887883         !!! we use Q2 as a vehicle for heating rates! sick!
    888          grid%m_q2(i,k,j) = interp_0_log( profdustq, pd_in, p_level, nl_in ) &
    889                           + interp_0_log( profdustn, pd_in, p_level, nl_in )
     884         grid%m_q2(i,k,j) = interp_0( profdustq, pd_in, p_level, nl_in ) &
     885                          + interp_0( profdustn, pd_in, p_level, nl_in )
    890886       ENDDO
    891887       ENDDO
     
    893889       !print*,k,grid%m_q2(1,k,1)
    894890    ENDDO
    895 
     891    print*,'planet',planet   
    896892    IF (planet.eq."prescribed") Then
    897       call read_hr(hrsw,hrlw,hrdyn,nl_in)
     893      call read_hr(profdustq,profdustn,nl_in)
    898894      open(unit=17,file="prescribed_sw.txt",action="write")
    899895      open(unit=18,file="prescribed_lw.txt",action="write")
    900       open(unit=19,file="prescribed_dyn.txt",action="write")
    901896      DO k=1,kte!-1
    902897        p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    903         prescribed_sw(k) = interp_0_log( hrsw, pd_in, p_level, nl_in )
    904         prescribed_lw(k) = interp_0_log( hrlw, pd_in, p_level, nl_in )
    905         prescribed_dyn(k) = interp_0_log( hrdyn, pd_in, p_level, nl_in )
     898        prescribed_sw(k) = interp_0( profdustq, pd_in, p_level, nl_in )
     899        prescribed_lw(k) = interp_0( profdustn, pd_in, p_level, nl_in )
    906900        write (17,*) prescribed_sw(k)
    907901        write (18,*) prescribed_lw(k)
    908         write (19,*) prescribed_dyn(k)
    909902      ENDDO
    910       close(unit=19)
     903      close(unit=17)
    911904      close(unit=18)
    912       close(unit=17)
    913905    ENDIF
    914    
    915     IF (planet.eq."venus") Then
    916       call read_hr(hrsw,hrlw,hrdyn,nl_in)
    917       open(unit=20,file="venus_hrdyn.txt",action="write")
    918       DO k=1,kte!-1
    919         p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    920         venus_hrdyn(k) = interp_0_log( hrdyn, pd_in, p_level, nl_in )
    921         write (20,*) venus_hrdyn(k)
    922       ENDDO
    923       close(unit=20)
    924     ENDIF
    925 
    926     open(unit=21,file="altitude.txt",action="write")
    927     DO k=1,kte!-1
    928       p_level = grid%znu(k)*(pd_surf - grid%p_top) + grid%p_top
    929       altitude(k) = interp_0_log( zk, pd_in, p_level, nl_in )
    930       write (21,*) altitude(k)
    931     ENDDO
    932     close(unit=21)
    933906
    934907!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
     
    968941!---------------------------------------------------------------------------
    969942
    970       subroutine get_sounding( zk, p, p_dry, theta, Tz, rho, &
     943      subroutine get_sounding( zk, p, p_dry, theta, rho, &
    971944                               u, v, qv, dry, nl_max, nl_in )
    972945      implicit none
     
    974947      integer nl_max, nl_in
    975948      real zk(nl_max), p(nl_max), theta(nl_max), rho(nl_max), &
    976            u(nl_max), v(nl_max), qv(nl_max), p_dry(nl_max),Tz(nl_max)
     949           u(nl_max), v(nl_max), qv(nl_max), p_dry(nl_max)
    977950      logical dry
    978951
     
    11391112          v(k) = v_input(k)
    11401113          qv(k) = qv_input(k)
    1141           Tz(k) = t_therm(k)
    11421114
    11431115        enddo
     
    12261198      implicit none
    12271199      integer n
    1228       real pdustq(n+1),pdustn(n+1)
     1200      real pdustq(n),pdustn(n)
    12291201      logical end_of_file
    12301202
     
    12511223      end subroutine read_dust
    12521224!!cccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
    1253       subroutine read_hr(hr_sw,hr_lw,hr_dyn,n)
     1225      subroutine read_hr(hr_sw,hr_lw,n)
    12541226      implicit none
    12551227      integer n
    1256       real hr_sw(n+1),hr_lw(n+1),hr_dyn(n+1)
     1228      real hr_sw(n),hr_lw(n)
    12571229      logical end_of_file
    12581230
     
    12671239      do while (.not. end_of_file)
    12681240
    1269         read(11,*,end=103) hr_sw(k+1),hr_lw(k+1),hr_dyn(k+1)
    1270         write(*,*) k,hr_sw(k+1),hr_lw(k+1),hr_dyn(k+1)
     1241        read(11,*,end=103) hr_sw(k+1),hr_lw(k+1)
     1242        write(*,*) k,hr_sw(k+1),hr_lw(k+1)
    12711243        k = k+1
    1272         go to 114
     1244        go to 113
    12731245 103    end_of_file = .true.
    12741246 114    continue
  • trunk/MESOSCALE/LMD_MM_MARS/SRC/WRFV2/dyn_em/module_initialize_real.F

    r1724 r1746  
    2121   USE module_soil_pre
    2222   USE module_date_time
    23    use module_init_utilities
    2423#ifdef DM_PARALLEL
    2524   USE module_dm
     
    119118      REAL :: max_dz
    120119
    121       INTEGER , PARAMETER :: nl_max = 1000
    122       INTEGER :: nl_in
     120!      INTEGER , PARAMETER :: nl_max = 1000
    123121!      REAL , DIMENSION(nl_max) :: grid%em_dn
    124       REAL, DIMENSION(nl_max) :: pd_in
    125       REAL, DIMENSION(nl_max) :: profdustq,profdustn
     122
    126123integer::oops1,oops2
    127124
     
    152149      !LOGICAL :: interp_theta = .false. ! Wee et al. 2012 correction
    153150      REAL :: pfu, pfd, phm
    154       REAL :: tpot
     151
    155152
    156153#ifdef DM_PARALLEL
     
    10831080!!END DO
    10841081
    1085 IF ( planet == "mars" ) then
     1082
    10861083!--get vertical size of the GCM input array and allocate new stuff
    1087   sizegcm=SIZE(grid%em_rh_gc(1,:,1))
    1088   ALLOCATE(sig(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
    1089   !ALLOCATE(ap(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
    1090   ALLOCATE(bp(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
    1091 
    1092   DO j = jts , MIN ( jde-1 , jte )
    1093   DO i = its , MIN (ide-1 , ite )
     1084sizegcm=SIZE(grid%em_rh_gc(1,:,1))
     1085ALLOCATE(sig(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
     1086!ALLOCATE(ap(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
     1087ALLOCATE(bp(MIN(ite,ide-1)-its+1,sizegcm, MIN(jte,jde-1)-jts+1))
     1088
     1089DO j = jts , MIN ( jde-1 , jte )
     1090DO i = its , MIN (ide-1 , ite )
    10941091
    10951092!!! Define old sigma levels for each column
    1096           sig(i,:,j)=grid%em_p_gc(i,:,j)/grid%em_psfc_gc(i,j)
     1093        sig(i,:,j)=grid%em_p_gc(i,:,j)/grid%em_psfc_gc(i,j)
    10971094
    10981095!!! Compute new sigma levels from old sigma levels with GCM (low-res) and WRF (hi-res) surface pressure
    10991096!!!                        (dimlevs,sigma_gcm, ps_gcm,                ps_hr,         sigma_hr)
    1100           CALL build_sigma_hr(sizegcm,sig(i,:,j),grid%em_psfc_gc(i,j),grid%psfc(i,j),bp(i,:,j))
     1097        CALL build_sigma_hr(sizegcm,sig(i,:,j),grid%em_psfc_gc(i,j),grid%psfc(i,j),bp(i,:,j))
    11011098
    11021099!!! Calculate new pressure levels
    1103           grid%em_pd_gc(i,:,j)=bp(i,:,j)*grid%psfc(i,j)
    1104 
    1105   END DO
    1106   END DO
    1107 
    1108   DEALLOCATE(sig)
    1109   DEALLOCATE(bp)
     1100        grid%em_pd_gc(i,:,j)=bp(i,:,j)*grid%psfc(i,j)
     1101
     1102END DO
     1103END DO
     1104
     1105DEALLOCATE(sig)
     1106DEALLOCATE(bp)
    11101107
    11111108!!****MARS who knows...
    1112   grid%em_rh_gc(:,:,:)=0.
     1109grid%em_rh_gc(:,:,:)=0.
    11131110
    11141111
     
    11161113!grid%em_pd_gc=grid%em_p_gc
    11171114!!****MARS
    1118 ELSE ! VENUS
     1115
    11191116
    11201117
     
    11231120         !!  dry top pressure (constant).
    11241121         !
    1125            CALL p_dts ( grid%em_mu0 , grid%em_intq_gc , grid%psfc , grid%p_top , &
    1126                         ids , ide , jds , jde , 1   , num_metgrid_levels , &
    1127                         ims , ime , jms , jme , 1   , num_metgrid_levels , &
    1128                         its , ite , jts , jte , 1   , num_metgrid_levels )
    1129 ENDIF
    1130 IF ( planet == "mars" ) then
     1122         !CALL p_dts ( grid%em_mu0 , grid%em_intq_gc , grid%psfc , grid%p_top , &
     1123         !             ids , ide , jds , jde , 1   , num_metgrid_levels , &
     1124         !             ims , ime , jms , jme , 1   , num_metgrid_levels , &
     1125         !             its , ite , jts , jte , 1   , num_metgrid_levels )
     1126
    11311127!!****MARS
    1132   DO j = jts , MIN ( jde-1 , jte )
    1133   DO i = its , MIN (ide-1 , ite )
    1134 
    1135      grid%em_mu0(i,j) = grid%psfc(i,j) - grid%p_top
    1136 
    1137   END DO
    1138   END DO
     1128DO j = jts , MIN ( jde-1 , jte )
     1129DO i = its , MIN (ide-1 , ite )
     1130
     1131   grid%em_mu0(i,j) = grid%psfc(i,j) - grid%p_top
     1132
     1133END DO
     1134END DO
    11391135!!****MARS
    1140 ELSE ! VENUS
     1136
    11411137   
    11421138         !!  Compute the dry, hydrostatic surface pressure.
    11431139         !
    1144            CALL p_dhs ( grid%em_pdhs , grid%ht , p00 , t00 , a , &
    1145                         ids , ide , jds , jde , kds , kde , &
    1146                         ims , ime , jms , jme , kms , kme , &
    1147                         its , ite , jts , jte , kts , kte )
    1148 ENDIF
     1140         !CALL p_dhs ( grid%em_pdhs , grid%ht , p00 , t00 , a , &
     1141         !             ids , ide , jds , jde , kds , kde , &
     1142         !             ims , ime , jms , jme , kms , kme , &
     1143         !             its , ite , jts , jte , kts , kte )
    11491144!!****MARS: voir remarques dans la routine
    11501145!!****MARS: dry hydrostatic pressure comes from the GCM ...
     
    22992294IF (( i .EQ. its ) .AND. ( j .EQ. jts )) print *, temp, k
    23002295!!! MODIF WRFV3.1 - parameter tiso
    2301                IF (planet .eq. "mars" ) THEN
    2302                  grid%em_t_init(i,k,j) = temp*(p00/grid%em_pb(i,k,j))**(r_d/cp) - t0
    2303                ELSE
    2304                  grid%em_t_init(i,k,j) = (temp**nu + nu*(TT00**nu)*log((p00/grid%em_pb(i,k,j))**rcp))**(1/nu) -t0
    2305                ENDIF
     2296               grid%em_t_init(i,k,j) = temp*(p00/grid%em_pb(i,k,j))**(r_d/cp) - t0
    23062297               grid%em_alb(i,k,j) = (r_d/p1000mb)*(grid%em_t_init(i,k,j)+t0)*(grid%em_pb(i,k,j)/p1000mb)**cvpm
    23072298            END DO
     
    26102601!!NB: q2 is used for other purpose ...
    26112602
     2603
    26122604!      END IF
    26132605
     
    27882780temp1 = MAX(tiso,t00+A*LOG(grid%em_pb(i,k,j)/p00))
    27892781temp2 = MAX(tiso,t00+A*LOG(           pb_int/p00))
    2790 IF (planet .eq. "mars" ) THEN
    2791   grid%em_t_init(i,k,j) = temp1*(p00/grid%em_pb(i,k,j))**(r_d/cp) - t0
    2792   t_init_int(i,k,j)     = temp2*(p00/pb_int           )**(r_d/cp) - t0
    2793 ELSE
    2794 ENDIF
     2782grid%em_t_init(i,k,j) = temp1*(p00/grid%em_pb(i,k,j))**(r_d/cp) - t0
     2783t_init_int(i,k,j)     = temp2*(p00/pb_int           )**(r_d/cp) - t0
    27952784               grid%em_alb(i,k,j) = (r_d/p1000mb)*(grid%em_t_init(i,k,j)+t0)*(grid%em_pb(i,k,j)/p1000mb)**cvpm
    27962785            END DO
     
    49804969!            temp =             t00 + A*LOG(pb/p00)
    49814970temp = MAX ( tiso, t00 + A*LOG(pb/p00) )
    4982            IF (planet .eq. "mars" ) THEN
    4983               t_init = temp*(p00/pb)**(r_d/cp) - t0
    4984             ELSE
    4985               t_init = (temp**nu + nu*(TT00**nu)*log((p00/pb)**(rcp)))**(1/nu) - t0
    4986             ENDIF
     4971            t_init = temp*(p00/pb)**(r_d/cp) - t0
    49874972            alb(k) = (r_d/p1000mb)*(t_init+t0)*(pb/p1000mb)**cvpm
    49884973         END DO
     
    50205005!            temp =             t00 + A*LOG(pb/p00)
    50215006temp = MAX ( tiso, t00 + A*LOG(pb/p00) )
    5022            IF (planet .eq. "mars" ) THEN
    5023               t_init = temp*(p00/pb)**(r_d/cp) - t0
    5024             ELSE
    5025               t_init = (temp**nu + nu*(TT00**nu)*log((p00/pb)**(rcp)))**(1/nu) -t0
    5026             ENDIF
     5007            t_init = temp*(p00/pb)**(r_d/cp) - t0
    50275008            alb(k) = (r_d/p1000mb)*(t_init+t0)*(pb/p1000mb)**cvpm
    50285009            znw(k+1) = znw(k) - dz*g / ( mub*alb(k) )
     
    50445025!                  temp =             t00 + A*LOG(pb/p00)
    50455026temp = MAX ( tiso, t00 + A*LOG(pb/p00) )
    5046            IF (planet .eq. "mars" ) THEN
    5047               t_init = temp*(p00/pb)**(r_d/cp) - t0
    5048             ELSE
    5049               t_init = (temp**nu + nu*(TT00**nu)*log((p00/pb)**(rcp)))**(1/nu) -t0
    5050             ENDIF
     5027                  t_init = temp*(p00/pb)**(r_d/cp) - t0
    50515028                  alb(k) = (r_d/p1000mb)*(t_init+t0)*(pb/p1000mb)**cvpm
    50525029                  znw(k+1) = znw(k) - dz*g / ( mub*alb(k) )
     
    50755052!               temp =             t00 + A*LOG(pb/p00)
    50765053temp = MAX ( tiso, t00 + A*LOG(pb/p00) )
    5077            IF (planet .eq. "mars" ) THEN
    5078               t_init = temp*(p00/pb)**(r_d/cp) - t0
    5079             ELSE
    5080               t_init = (temp**nu + nu*(TT00**nu)*log((p00/pb)**(rcp)))**(1/nu) -t0
    5081             ENDIF
     5054               t_init = temp*(p00/pb)**(r_d/cp) - t0
    50825055               alb(k) = (r_d/p1000mb)*(t_init+t0)*(pb/p1000mb)**cvpm
    50835056            END DO
     
    57475720      end subroutine build_sigma_hr
    57485721
     5722
     5723
     5724
     5725
    57495726END MODULE module_initialize
    57505727
Note: See TracChangeset for help on using the changeset viewer.