source: trunk/LMDZ.TITAN.old/libf/phytitan/n_methane.F @ 3303

Last change on this file since 3303 was 1056, checked in by slebonnois, 11 years ago

SL: Titan runs ! see DOC/chantiers/commit_importants.log

File size: 16.1 KB
Line 
1      subroutine n_methane(ngrid,nq,nbin,
2     *                     dt,pl,tl,aerad,
3     *                     q,qprime)
4
5      implicit none
6#include "dimensions.h"
7#include "microtab.h"
8#include "varmuphy.h"
9
10c  Arguments
11c  ---------
12
13      integer ngrid,nq,nbin
14
15      REAL dt              ! physical time step (s)
16      REAL pl(ngrid,nz)    ! pressure at each level (mbar)
17      REAL tl(ngrid,nz)    ! temperature at each level (K)
18      REAL aerad(nbin)     ! Radius array
19
20c    Tracers :
21      REAL q(ngrid,nz,nq)         ! tracer (kg/kg)
22      REAL qprime(ngrid,nz,nbin)  ! tracer (kg/kg)
23
24
25c     Local variables
26c     ---------------
27
28      integer ntyp
29      parameter (ntyp=3)   ! 3 = 1 aerosol + 1 noyau + 1 glace
30
31      real n_aer(nz,nbin,ntyp)
32      real ch4vap(nz)
33
34      integer itrac
35      integer ig,i,j,k,l,n   ! Loop integers
36      integer ilay,iq
37
38c  Treatment
39c  ---------
40
41      DO ig = 1 , NGRID
42
43c     Set up the aerosol array
44        do j = 1, ntyp
45          do k = 1, nbin
46            itrac = (j-1) * nbin + k
47            do l = 1, nz
48              n_aer(l,k,j) = max(q(ig,l,itrac),0.)
49            enddo
50          enddo
51        enddo
52
53c     Set up the methane vapor array
54        do l = 1, nz
55          ch4vap(l) = q(ig,l,nq)
56        enddo
57
58
59
60        call nucleacond(ngrid,nbin,dt,ig,pl,tl,aerad,
61     &                 n_aer,qprime,ch4vap)
62
63
64c       Update q arrays
65        do j = 1, ntyp
66          do k = 1, nbin
67            itrac = (j-1) * nbin + k
68            do l = 1, nz
69              q(ig,l,itrac) = n_aer(l,k,j)
70            enddo
71          enddo
72        enddo
73
74c     Update methane vapor array
75        do l = 1, nz
76          q(ig,l,nq) = ch4vap(l)
77        enddo
78
79      ENDDO
80
81      return
82      END
83
84****************************************************************
85      subroutine nucleacond(ngrid,nbin,dt,ig,
86     &                      pl,tl,aerad,n_aer,qprime,ch4vap)
87*                                                              *
88*     This routine updates species concentrations due          *
89*     to both nucleation and condensation-induced variations.  *
90*     Gain and loss rates associated to each one of these      *
91*     processes are computed separately in other routines.     *
92*                                                              *
93****************************************************************
94
95      implicit none
96#include "dimensions.h"
97#include "microtab.h"
98#include "varmuphy.h"
99
100      integer ng,nalt
101      parameter(ng=1,nalt=llm)
102
103      real lv
104      common/lheat/lv
105
106c  Arguments
107c  ---------
108
109      integer ngrid,nbin
110      integer ig
111      integer ntyp
112      parameter (ntyp=3)
113
114      real dt                    ! Global time step
115      real pl(ngrid,nz),tl(ngrid,nz)
116      real aerad(nbin)
117      real ch4vap(nz)            ! Methane vapor mass mixing ratio (kg/m3)
118      real ch4vap_old
119      real n_aer(nz,nbin,ntyp)  ! number concentrations of particle/each size bin
120      real qprime(ngrid,nz,nbin)  ! tracer (kg/kg)
121      REAL total1(nz),total11(nz),total2(nz),total22(nz)
122      REAL dmsm,mtot
123
124
125c  Local
126c  -----
127
128      integer i,j,k,l,n,iindice,iselec
129
130      real dQc           ! Amount of condensed methane (kg/m3) during timestep
131      real*8 sat_ratio   ! Methane saturation ratio over liquid
132      real*8 sat_ratmix   ! Methane saturation ratio over liquid
133      real*8 pch4        ! Methane partial pressure (Pa)
134      real qsat          ! Methane mass mixing ratio at saturation (kg/kg of air)
135      real qsatmix          ! Methane mass mixing ratio at saturation (kg/kg of air)
136      real*8 rate(nbin)    ! Heterogeneous Nucleation rate (s-1)
137      real*8 elim         
138
139      real nsav(nbin,ntyp)
140      real dn(nbin,ntyp)
141      real rad(nbin)     ! Radius of droplets in each size bin
142      real*8 gr(nbin)      ! Growth rate in each bin
143      real radius        ! Radius of droplets after growth
144      real Qs            ! Mass of condensate required to reach saturation
145      real newsat
146      real vol(nbin)
147
148      real press
149      real sig,temp,seq(nbin)
150      real Ctot,up,dwn,newvap,gltot
151
152      real rho_a,cap
153      real tempref
154      real frac
155      real xtime,xtime_prime
156      real dQc2
157
158c     Variables for latent heat release
159      real lw
160      data lw / 510.e+3/
161      save lw
162
163
164c  Treatment
165c  ---------
166
167c  Treatment
168c  ---------
169      do i = 1, nbin
170        vol(i) = 4./3. * pi * aerad(i)**3.
171      enddo
172
173        do l = 1, nz
174        total1(l)=0. !solide
175        do k = 1, nbin
176        total1(l)=total1(l)+n_aer(l,k,2)*rhoi_ch4
177        enddo
178        total2(l)=ch4vap(l)
179        enddo
180
181c     Start loop over heights
182      DO 100 l = 1, nz
183   
184        iindice=0                ! mettre l'indice à 0
185
186        temp   = tl(ig,l)
187        press  = pl(ig,l)
188        tempref=temp
189
190c       Save the values of the particle arrays before condensation
191        do j = 1, ntyp
192          do i = 1, nbin
193            nsav(i,j) = n_aer(l,i,j)
194          enddo
195        enddo
196
197
198 99     continue   ! DEBUT DE LA BOUCLE CONDITONNELLE
199
200        call ch4sat(temp,press,qsat)
201        qsat=qsat*0.85
202        qsatmix=qsat*0.85
203
204c       Get the partial presure of methane vapor and its saturation ratio
205        pch4       = ch4vap(l) * (Mn2/Mch4) * press
206        sat_ratio  = ch4vap(l) / qsat
207        sat_ratmix = ch4vap(l) / qsatmix
208
209c       Get the rates of nucleation
210        call nuclea(nbin,aerad,pch4,temp,sat_ratio,rate)
211
212c       Get the growth rates of condensation/sublimation
213        up   = ch4vap(l)
214        dwn  = 1.
215        Ctot = ch4vap(l)
216        DO i = 1, nbin
217
218        if (n_aer(l,i,3).eq.0) then
219          rad(i) = aerad(i)
220        else
221          rad(i) = ((n_aer(l,i,2)/n_aer(l,i,3) +
222     &     qprime(ig,l,i)/n_aer(l,i,3)
223     &    +vol(i))*0.75/pi)**(1./3.)
224        endif
225       
226
227*       Equilibrium saturation ratio (due to curvature effect)
228        seq(i) = exp( 2.*sig(temp)*Mch4 / (rhoi_ch4*rgp*temp*rad(i)) )
229
230        call growthrate(dt,temp,press,pch4,
231     &                  sat_ratmix,seq(i),rad(i),gr(i))
232        up = up + dt * gr(i) * 4. * pi * rhoi_ch4 * rad(i) * seq(i)
233     *                 * nsav(i,3)
234        dwn= dwn+ dt * gr(i) * 4. * pi * rhoi_ch4 * rad(i) / qsat
235     *                 * nsav(i,3)
236        Ctot= Ctot + rhoi_ch4 * nsav(i,2)
237
238        ENDDO
239
240        newvap = min(up/dwn,Ctot) 
241        newvap = max(newvap,0.) 
242
243        gltot=0.
244        DO i = 1, nbin
245          gr(i)  = gr(i) * ( newvap/qsat - seq(i) )
246          if(nsav(i,2).le.0. .and. gr(i).le.0.) then
247              n_aer(l,i,2) = 0.
248          else
249          n_aer(l,i,2) = nsav(i,2) + dt * gr(i) * 4. * pi * rad(i)
250     *                               * n_aer(l,i,3)
251          if (n_aer(l,i,2).le.0.) then
252            n_aer(l,i,1) = n_aer(l,i,1) + n_aer(l,i,3)
253            n_aer(l,i,2) = 0.
254            n_aer(l,i,3) = 0.
255          endif
256          gltot=n_aer(l,i,2)*rhoi_ch4+gltot
257          endif
258
259        ENDDO
260   
261c       Determine the mass of exchanged methane
262
263        dQc = 0.
264        DO i = 1, nbin
265          dQc = dQc - rhoi_ch4 * ( n_aer(l,i,2) - nsav(i,2) )
266        ENDDO
267
268
269c       Arrays resetted to their initial value before condensation
270
271        do j = 1, ntyp
272          do i = 1, nbin
273            dn(i,j)      = n_aer(l,i,j) - nsav(i,j)
274            n_aer(l,i,j) = nsav(i,j)
275          enddo
276        enddo
277
278
279c       Update the c arrays.
280c       nucleation & cond/eva tendencies added together.
281
282        do i=1,nbin
283          elim         = dt * rate(i)
284          n_aer(l,i,1) = n_aer(l,i,1) / (1.+elim)
285          n_aer(l,i,3) = n_aer(l,i,3) + elim * n_aer(l,i,1) + dn(i,3)
286          n_aer(l,i,1) = n_aer(l,i,1) + dn(i,1)
287          n_aer(l,i,2) = n_aer(l,i,2) + dn(i,2)
288         if(n_aer(l,i,2).lt.0.) n_aer(l,i,2)=0.
289
290        enddo
291
292        dQc = 0.
293        DO i = 1, nbin    ! dQc <0 si glace produite !!
294          dQc = dQc - rhoi_ch4 * ( n_aer(l,i,2) - nsav(i,2) )
295        ENDDO
296
297
298       ch4vap(l)    = ch4vap(l) + dQc
299
300100   CONTINUE
301
302        do l = 1, nz
303        total11(l)=0.
304        do k = 1, nbin
305          total11(l)=total11(l)+n_aer(l,k,2)*rhoi_ch4
306        enddo
307        total22(l)=ch4vap(l)
308        enddo
309
310
311      return
312      end
313
314
315*******************************************************
316*                                                     *
317      subroutine nuclea(nbin,aerad,pch4,temp,sat,nucrate)
318*   This subroutine computes the nucleation rate      *
319*   as given in Pruppacher & Klett (1978) in the      *
320*   case of water ice forming on a solid substrate.   *
321*     Definition refined by Keese (jgr,1989)          *
322*                                                     *
323*******************************************************
324
325      implicit none
326#include "dimensions.h"
327#include "microtab.h"
328#include "varmuphy.h"
329
330      integer nbin
331      real aerad(nbin)
332
333      real*8 nucrate(nbin)
334      real*8 pch4
335      real   temp
336      real*8 sat
337
338      integer l,i
339      real*8 nch4
340      real sig            ! Water-ice/air surface tension  (N.m)
341      real*8 rstar        ! Radius of the critical germ (m)
342      real*8 gstar        ! # of molecules forming a critical embryo
343      real*8 x            ! Ratio rstar/radius of the nucleating dust particle
344      real fistar         ! Activation energy required to form a critical embryo (J)
345      real*8 zeldov       ! Zeldovitch factor (no dim)
346      real*8 fshape       ! function defined at the end of the file
347      real*8 deltaf
348
349      real nus
350      data nus/1.e+13/       ! Jump frequency of a molecule (s-1)
351      real m0
352      data m0/2.6578e-26/     ! Weight of a methane molecule (kg)
353      real vo1
354c     data vo1/6.254e-29/     ! Volume of a methane molecule (m3)
355      data vo1/3.7649e-5/     ! Volume of a methane molecule (m3)
356
357      real desorp
358      data desorp/0.288e-19/ ! Activation energy for desorption of water on a dust-like substrate (J/molecule)
359      real surfdif
360      data surfdif/0.288e-20/! Estimated activation energy for surface diffusion of water molecules (J/molecule)
361
362      IF (sat .GT. 1.) THEN    ! minimum condition to activate nucleation
363
364        nch4    = pch4 / kbz / temp
365        rstar  = 2. * sig(temp) * vo1 / (rgp*temp*log(sat))
366        gstar  = 4. * nav * pi * (rstar**3) / (3.*vo1)
367c       Loop over size bins
368        do i=1,nbin
369          x      = aerad(i) / rstar
370          x      = aerad(imono) / rstar  ! attention r(5)=monomeres
371
372          fistar = (4./3.*pi) * sig(temp) * (rstar**2.) *
373     &             fshape(mtetach4,x)
374          deltaf = min( max((2.*desorp-surfdif-fistar)/(kbz*temp)
375     &           , -100.), 100.)
376          if (deltaf.eq.-100.) then
377            nucrate(i) = 0.
378          else
379            zeldov = sqrt ( fistar / (3.*pi*kbz*temp*(gstar**2.)) )
380            nucrate(i)  = zeldov * kbz* temp * rstar**2.
381     &                  * 4. * pi * ( nch4*aerad(i) )**2.
382     &                  / ( fshape(mtetach4,x) * nus * m0 )
383     &                  * dexp(deltaf)
384 
385             if(i.gt.imono)  nucrate(i)= zeldov * kbz* temp * rstar**2.
386     &           * 4. * pi * vrat_e**(i-imono)*(nch4*aerad(imono) )**2.
387     &            / (fshape(mtetach4,x) * nus * m0 )
388     &            * dexp(deltaf)
389
390
391          endif
392        enddo
393      ELSE
394        do i=1,nbin
395          nucrate(i) = 0.
396        enddo
397
398      ENDIF
399
400      return
401      end
402
403******************************************************************
404        subroutine ch4sat(t,p,qsat)
405* cette fonction calcule la pression de vapeur saturante du      *
406* methane a une altitude donnee z par l'equation de Thek-Stiel   *
407******************************************************************
408
409        real rgp
410        data rgp/8.3143/
411
412* declaration des variables internes
413* ----------------------------------
414        real p,tc,pc,tr,tb,tbr,phib,ac,hbr,hvb,avb,a,b
415        real qsat
416
417        tc = 190.53
418        pc = 45.96 * 0.986923
419        tr = t / tc
420        tb = 111.63
421        tbr= tb / tc
422        phib = -35. + 36./tbr + 42.*log(tbr)-tbr**6
423        ac   = (0.315*phib + log(pc))/(0.0838*phib-log(tbr))
424        hbr  = tbr * log(pc) / (1.-tbr)
425        hvb  = rgp*tb*(0.4343*log(pc)-0.68859+0.89584*tbr)/(0.37691-
426     s      0.37306*tbr+0.14878/(pc*tbr**2))
427        avb  = hvb / (rgp*tc*(1.-tbr)**(0.375))
428        a    = 5.2691 + 2.0753*avb - 3.1738*hbr
429        b    = 1.042 * ac - 0.46284 * avb
430
431        qsat=pc*exp(avb*(1.14893-1./tr-0.11719*tr-0.03174*tr**2
432     s        -0.375*log(tr))+b*((tr**a-1.)/a+0.04*(1./tr-1.)))
433        qsat=qsat*1e+5/0.986923
434        !  ---> qsat en Pa
435
436        qsat=qsat* 16.0 / (28.0*p)   ! kg/kg
437       
438
439
440        return
441        end
442
443c=======================================================================
444      subroutine growthrate(timestep,temp,press,pch4,sat,seq,r,Cste)
445c
446c     Determination of the droplet growth rate
447c
448c=======================================================================
449
450      IMPLICIT NONE
451#include "dimensions.h"
452#include "microtab.h"
453#include "varmuphy.h"
454
455c-----------------------------------------------------------------------
456c   declarations:
457c   -------------
458
459      common/lheat/Lv
460
461c
462c   arguments:
463c   ----------
464
465      REAL timestep
466      REAL temp    ! temperature in the middle of the layer (K)
467      REAL press    ! pressure in the middle of the layer (K)
468      REAL*8 pch4 ! Methane vapor partial pressure (Pa)
469      REAL*8 sat  ! saturation ratio
470      REAL r    ! crystal radius before condensation (m)
471      REAL seq  ! Equilibrium saturation ratio
472
473c   local:
474c   ------
475
476      REAL psat
477      REAL moln2,molch4
478      REAL To,wch4,tch4,ftm
479
480c     Effective gas molecular radius (m)
481      data moln2/1.75e-10/   ! N2
482c     Effective gas molecular radius (m)
483      data molch4/2.e-10/   ! CH4
484
485      data tch4/190.4/
486      data wch4/1.1e-2/    ! Reid et al (Eq 7-9.4 + Appendix Compound [116])
487
488      REAL k,Lv                 
489      REAL knudsen           ! Knudsen number (gas mean free path/particle radius)
490      REAL a,Dv,lambda,Rk,Rd ! Intermediate computations for growth rate
491      REAL*8 Cste
492
493c-----------------------------------------------------------------------
494c      Ice particle growth rate by diffusion/impegement of molecules
495c                r.dr/dt = (S-Seq) / (Seq*Rk+Rd)
496c        with r the crystal radius, Rk and Rd the resistances due to
497c        latent heat release and to vapor diffusion respectively
498c-----------------------------------------------------------------------
499
500      psat = pch4 / sat
501
502c     - Thermal conductibility of N2
503      k = ( 2.857e-2 * temp - 0.5428  ) * 4.184e-3
504c     - Latent heat of ch4 (J.kg-1)
505      Lv = 510.e+3
506      ftm=1.-temp/tch4
507      if (ftm.le.1.e-3)  ftm=1.e-3
508      Lv=8.314*tch4*(7.08*ftm**0.354+10.95*wch4*ftm**0.456)/16.e-3
509     
510
511c     - Constant to compute gas mean free path
512c     l= (T/P)*a, with a = (  0.707*8.31/(4*pi*molrad**2 * avogadro))
513
514      a = 0.707*rgp/(4 * pi* (moln2*1.e10)**2  * (nav*1.e-20))
515
516c     - Compute Dv, methane vapor diffusion coefficient
517c       accounting for both kinetic and continuum regime of diffusion,
518c       the nature of which depending on the Knudsen number.
519
520      Dv = 1./3. * sqrt( 8*rgp*temp/(pi*Mch4) )* (kbz*1.e20) * temp /
521     &   (pi*press*(moln2*1.e10+molch4*1.e10)**2 * sqrt(1.+Mch4/Mn2) )
522
523      knudsen = temp / press * a / r
524      lambda  = (1.333+0.71/knudsen) / (1.+1./knudsen)
525      Dv      = Dv / (1. + lambda * knudsen)
526
527c     - Compute Rk
528      Rk = Lv**2 * rhoi_ch4 * Mch4 / (k*rgp*temp**2.)
529c     - Compute Rd
530      Rd = rgp * temp *rhoi_ch4 / (Dv*psat*Mch4)
531
532c     - Compute:      rdr/dt = Cste * (S-Seq)
533      Cste = 1. / (seq*Rk+Rd)
534
535      RETURN
536      END
537
538
539*********************************************************
540      real function sig(t)
541*    this function computes the surface tension (N.m)   *
542*   between methane and air as a function of temp.    *
543*********************************************************
544
545      real t
546
547      sig = ( t/4. + 41.) * 1e-3
548
549      return
550      end
551
552*********************************************************
553      real*8 function fshape(cost,rap)
554*        function computing the f(m,x) factor           *
555* related to energy required to form a critical embryo  *
556*********************************************************
557
558      implicit none
559
560      real cost
561      real*8 rap
562      real*8 phi
563      real*8 a,b,c
564
565      phi = sqrt( 1. - 2.*cost*rap + rap**2 )
566
567      a = 1. + ( (1.-cost*rap)/phi )**3
568      b = (rap**3) * (2.-3.*(rap-cost)/phi+((rap-cost)/phi)**3)
569      c = 3. * cost * (rap**2) * ((rap-cost)/phi-1.)
570
571      fshape = 0.5*(a+b+c)
572
573      if (rap.gt.3000.) fshape = ((2.+cost)*(1.-cost)**2)/4.
574
575
576      return
577      end
578
Note: See TracBrowser for help on using the repository browser.