SURFEX  V8_0
Surfex V8_0 release
 All Classes Files Functions Variables
soil.F90
Go to the documentation of this file.
1 !SFX_LIC Copyright 1994-2014 CNRS, Meteo-France and Universite Paul Sabatier
2 !SFX_LIC This is part of the SURFEX software governed by the CeCILL-C licence
3 !SFX_LIC version 1. See LICENSE, CeCILL-C_V1-en.txt and CeCILL-C_V1-fr.txt
4 !SFX_LIC for details. version 1.
5 ! #########
6  SUBROUTINE soil( HC1DRY, HSCOND, HSNOW_ISBA, OGLACIER, &
7  psnowrhom, pveg, &
8  pcgsat, pcgmax, &
9  pc1sat, pc2ref, pacoef, ppcoef, pcv, &
10  ppsn, ppsng, ppsnv, pffg, pffv, pff, &
11  pcg, pc1, pc2, pwgeq, pct, pcs, pfrozen1, &
12  ptg, pwg, pwgi, &
13  phcapsoilz, pconddryz, pcondsldz, &
14  pbcoef, pwsat, pwwilt, &
15  hksat, pcondsat, pffg_nosnow, pffv_nosnow )
16 ! ##########################################################################
17 !
18 !!**** *SOIL*
19 !!
20 !! PURPOSE
21 !! -------
22 !
23 ! Calculates the coefficients related to the soil (i.e., CG, CT,
24 ! C1, C2, WGEQ) and to the snow canopy (i.e., Cs, ps, psng, psnv, and psnz0)
25 !
26 !
27 !!** METHOD
28 !! ------
29 !
30 ! Direct calculation
31 !
32 !! EXTERNAL
33 !! --------
34 !
35 ! None
36 !!
37 !! IMPLICIT ARGUMENTS
38 !! ------------------
39 !!
40 !!
41 !!
42 !! REFERENCE
43 !! ---------
44 !!
45 !! Noilhan and Planton (1989)
46 !! Belair (1995)
47 !!
48 !! AUTHOR
49 !! ------
50 !! S. Belair * Meteo-France *
51 !!
52 !! MODIFICATIONS
53 !! -------------
54 !! Original 13/03/95
55 !! 20/03/96 (Masson) error in the threshold for PCG
56 !! 04/09/98 (Masson) error in C1 normalization
57 !! 16/09/98 (Masson) frozen water in the soil
58 !! 07/10/98 (Masson) new C1 formulation
59 !! 26/11/98 (Boone) C1 option (old vs new formulations)
60 !! 15/03/99 (Boone) Soil ice modifiactions: scale C1sat,
61 !! use surface ice-weighted CG, GB method
62 !! for dry conditions uses ZWWILT for MAX
63 !! 25/03/99 (Boone) Added Johansen (1975)/Peters-Lidard
64 !! option to explicitly compute CG
65 !! 25/05/08 (Decharme) Added flood properties
66 !! 22/06/10 (Chauvin) XWGMIN added as a limit value of ZWG2
67 !! Modification of the formula for PWGEQ
68 !! to solve numerical problem
69 !! 10/10 (Decharme) The previous computation of WGEQ as ( 1.-ZX(JJ)**(PPCOEF(JJ)*8.) )
70 !! can introduced some model explosions for heavy clay soil
71 !! 12/14 (LeMoigne) EBA scheme update
72 !-------------------------------------------------------------------------------
73 !
74 !* 0. DECLARATIONS
75 ! ------------
76 !
77 USE modd_csts, ONLY : xpi, xci, xrholi, xday, xcl, xrholw, xcondi
78 USE modd_isba_par, ONLY : xcondwtr, xwgmin
79 USE modd_surf_par, ONLY : xundef
80 USE modd_deepsoil, ONLY : lphysdomc
81 !
82 !
83 USE yomhook ,ONLY : lhook, dr_hook
84 USE parkind1 ,ONLY : jprb
85 !
86 IMPLICIT NONE
87 !
88 !* 0.1 declarations of arguments
89 !
90 !
91  CHARACTER(LEN=*), INTENT(IN) :: hc1dry ! C1 for dry soil formulation
92 ! ! 'DEF' Default: Giard and Bazile
93 ! ! 'GB93' Giordani 1993, Braud 1993
94 ! ! (discontinuous at WILT)
95 !
96  CHARACTER(LEN=*), INTENT(IN) :: hscond ! thermal conductivity formulation
97 ! ! 'NP89': Noilhan and Planton
98 ! ! (1989: McCumber-Pielke (1981) and
99 ! ! Clapp and Hornberger (1978))
100 ! ! 'PL98' Method of Johansen (1975) as
101 ! ! presented by Peters-Lidard (JAS: 1998)
102 !
103  CHARACTER(LEN=*), INTENT(IN) :: hsnow_isba ! 'DEF' = Default F-R snow scheme
104 ! ! (Douville et al. 1995)
105 ! ! '3-L' = 3-L snow scheme (option)
106 ! ! (Boone and Etchevers 2000)
107 !
108 LOGICAL, INTENT(IN) :: oglacier ! T = Over permanent snow and ice,
109 ! ! initialise WGI=WSAT, Hsnow>=10m
110 ! ! and allow 0.8<SNOWALB<0.85
111 ! ! F = No specific treatment
112 !
113 REAL, DIMENSION(:), INTENT(IN) :: psnowrhom
114 ! Prognostic variables of ISBA at 't-dt'
115 ! PSNOWRHOM = density of snow
116 !
117 REAL, INTENT(IN) :: pcgmax
118 ! Maximum soil heat capacity
119 !
120 REAL, DIMENSION(:), INTENT(IN) :: pveg, pcgsat, pc1sat
121 REAL, DIMENSION(:), INTENT(IN) :: pc2ref, pacoef, ppcoef, pcv
122 ! Soil and vegetation parameters
123 ! PVEG = fraction of vegetation
124 ! PCGSAT = soil thermal coefficient at saturation
125 ! PC1SAT = value of C1 at saturation
126 ! PC2REF = reference value of C2
127 ! PACOEF, PPCOEF = a and p coefficients for
128 ! the wgeq formulation
129 ! PCV = the heat capacity of the vegetation
130 !
131 REAL, DIMENSION(:), INTENT(IN) :: ppsn, ppsng, ppsnv
132 ! PPSN = fraction of the grid covered by snow
133 ! PPSNG = fraction of the bare soil covered
134 ! by snow
135 ! PPSNV = fraction of the vegetation covered
136 ! by snow
137 !
138 REAL, DIMENSION(:), INTENT(IN) :: phcapsoilz, pconddryz, pcondsldz
139 ! PHCAPSOILZ = soil heat capacity [J/(K m3)]
140 ! PCONDDRYZ = soil dry thermal conductivity
141 ! [W/(m K)]
142 ! PCONDSLDZ = soil solids thermal conductivity
143 ! [W/(m K)]
144 !
145 REAL, DIMENSION(:), INTENT(IN) :: pbcoef, pwsat, pwwilt
146 ! PBCOEF = b-parameter (-)
147 ! PWSAT = porosity (m3/m3)
148 ! PWWILT = wilting point volumetric water content(m3/m3)
149 !
150 REAL, DIMENSION(:), INTENT(IN) :: ptg
151 ! PTG = surface temperature (K)
152 !
153 REAL, DIMENSION(:,:), INTENT(IN) :: pwg, pwgi
154 ! PWG = soil liquid water content (m3/m3)
155 ! PWGI = soil frozen water content (m3/m3)
156 !
157 REAL, DIMENSION(:), INTENT(OUT) :: pcg, pc1, pc2, pwgeq, pct
158 REAL, DIMENSION(:), INTENT(OUT) :: pcs, pfrozen1
159 ! soil and snow coefficients
160 ! PCG = heat capacity of the bare soil
161 ! C1, C2 = coefficients for the moisture calculations
162 ! PWGEQ = equilibrium surface volumetric moisture
163 ! PCT = averaged heat capacity of the grid
164 ! PCS = heat capacity of the snow
165 ! PFROZEN1 = fraction of ice in superficial
166 ! soil
167 !
168  CHARACTER(LEN=*), INTENT(IN) :: hksat ! soil hydraulic profil option
169 ! ! 'DEF' = ISBA homogenous soil
170 ! ! 'SGH' = ksat exponential decay
171 !
172 REAL, DIMENSION(:,:), INTENT(IN) :: pcondsat ! hydraulic conductivity at saturation (m/s)
173  ! use in the force restore scheme for
174  ! calculate the exponential decay factor coefficients
175 !
176 REAL, DIMENSION(:), INTENT(IN) :: pffv, pffg, pff, pffg_nosnow, pffv_nosnow
177 ! PFFG = Floodplain fraction over the ground
178 ! PFFV = Floodplain fraction over vegetation
179 ! PFF = Floodplain fraction at the surface
180 !
181 !
182 !* 0.2 declarations of local variables
183 !
184 REAL, DIMENSION(SIZE(PVEG)) :: zlams, &
185 ! conductivity of snow
186 !
187  zcw1max, zx2, zy1, zy2, &
188  zlymy1, zza, zzb, zdelta, &
189  za, zb, &
190 ! temporary variables for the
191 ! calculation of PC1 in the case
192 ! where PWG < PWWILT (i.e., dry soils)
193 !
194  zx, &
195 ! temporary variable for the
196 ! calculation of PWGEQ
197  zwsat, &
198 ! Wsat when ice is present in ground
199  zwsat1, &
200 ! Wsat when ice is present in surface
201 ! ground layer
202  zwwilt, &
203 ! Wwilt when ice is present in ground
204  zc1sat
205 ! C1sat scaled due to soil ice
206 !
207 !
208 ! Thermal conductivity option:
209 ! Johansen (1975) parameters (as presented by Peters-
210 ! Lidard, 1998, JAS). Used to compute CG.
211 !
212 REAL, DIMENSION(SIZE(PVEG)) :: zfrozen2, zunfrozen2, zcondsat, zsatdeg, zkersten, &
213  zcond, zhcap
214 ! ZFROZEN2 = fraction of total soil layer frozen
215 ! ZUNFROZEN2 = unfrozen fraction available to liquid
216 ! ZCONDSAT = saturated conductivity (water)
217 ! ZSATDEG = degree of saturation
218 ! ZKERSTEN = Kersten number
219 ! ZCOND = soil thermal conductivity (explicitly
220 ! includes soil, water and ice)
221 ! ZHCAP = Soil heat capacity
222 !
223 REAL, DIMENSION(SIZE(PVEG)) :: zwg2
224 ! ZWG2 = adjusted root-zone soil water content
225 !
226 REAL, DIMENSION(SIZE(PVEG)) :: zcf !heat capacity of the flood
227 REAL, DIMENSION(SIZE(PVEG)) :: zff !Fraction of floodplain at the surface without snow
228 !
229 INTEGER :: jj
230 REAL(KIND=JPRB) :: zhook_handle
231 !-------------------------------------------------------------------------------
232 !
233 IF (lhook) CALL dr_hook('SOIL',0,zhook_handle)
234 zwwilt(:) = 0.
235 !
236 zfrozen2(:) = 0.
237 zunfrozen2(:)= 0.
238 zcondsat(:) = 0.
239 zsatdeg(:) = 0.
240 zkersten(:) = 0.
241 zcond(:) = 0.
242 zhcap(:) = 0.
243 !
244 zlams(:) = 0.
245 zx(:) = 0.
246 zcw1max(:) = 0.
247 zy1(:) = 0.
248 zx2(:) = 0.
249 zy2(:) = 0.
250 zlymy1(:) = 0.
251 zza(:) = 0.
252 zzb(:) = 0.
253 zdelta(:) = 0.
254 za(:) = 0.
255 zb(:) = 0.
256 !
257 zcf(:) = xundef
258 !
259 pcs(:) = xundef
260 !
261 !-------------------------------------------------------------------------------
262 !
263 !* 1. FROZEN WATER FRACTION IN THE SOIL
264 ! ---------------------------------
265 !
266 pfrozen1(:) = 0.
267 WHERE (pwgi(:,1) + pwg(:,1) .NE. 0.)
268  pfrozen1(:) = pwgi(:,1) / (pwgi(:,1) + pwg(:,1))
269 END WHERE
270 !
271 DO jj=1,SIZE(pwsat)
272 !
273  zwsat(jj) = max(pwsat(jj) - pwgi(jj,2),xwgmin)
274 !
275  zwsat1(jj) = max(pwsat(jj) - pwgi(jj,1),xwgmin)
276 !
277  zwwilt(jj) = pwwilt(jj) * (zwsat1(jj) / pwsat(jj))
278 !
279 ENDDO
280 !-------------------------------------------------------------------------------
281 !
282 !* 2. THE HEAT CAPACITY OF BARE-GROUND
283 ! --------------------------------
284 !
285 IF(hscond == 'NP89')THEN
286 !
287 ! Actually, all the 'C' coefficients in
288 ! ISBA do not represent heat capacities,
289 ! but rather the inverse. So in the
290 ! following formulation, CG is large
291 ! when W2 is small, thus leading to small
292 ! values for the heat capacity. In other
293 ! words, a small amount of energy will
294 ! result in great temperature variations
295 ! (for dry soils).
296 !
297 !
298 ! Now calculate the thermal inertia of the soil weighted
299 ! by soil ice content (including the soil ice thermal inertia):
300 !
301  pcg(:) = (1.-pwgi(:,2)) * pcgsat(:) * ( zwsat(:)/pwg(:,2) ) &
302  **( 0.5*pbcoef(:)/log(10.) ) &
303  + pwgi(:,2) * 2. * sqrt(xpi/(xcondi*xci*xrholi*xday))
304 !
305 !
306 ELSE
307 !
308 ! Method of Johansen (1975) as presented by
309 ! Peters-Lidard (JAS: 1998) for thermal
310 ! Conductivity of soil. Explicit calculation for
311 ! now (as opposed to implicit method of
312 ! Noilhan and Planton 1989). NP89 uses the
313 ! method of McCumber and Pielke (1981)
314 ! with parameters of Clapp and Hornberger (1978).
315 !
316  DO jj=1,SIZE(pwg,1)
317 !
318 ! Total fraction of soil frozen:
319 !
320  zfrozen2(jj) = pwgi(jj,2)/(pwgi(jj,2) + pwg(jj,2))
321 !
322 ! Unfrozen fraction:
323 !
324  zunfrozen2(jj) = (1.0-zfrozen2(jj))*pwsat(jj)
325 !
326 ! Saturated thermal conductivity:
327 !
328  zcondsat(jj) = (pcondsldz(jj)**(1.0-pwsat(jj)))* &
329  (xcondi**(pwsat(jj)-zunfrozen2(jj)))* &
330  (xcondwtr**zunfrozen2(jj))
331 !
332 ! Degree of saturation of soil:
333 !
334  zsatdeg(jj) = max(0.1, (pwgi(jj,2)+pwg(jj,2))/pwsat(jj))
335 !
336 ! Kersten number:
337 !
338  zkersten(jj) = log10(zsatdeg(jj)) + 1.0
339 !
340 ! Put in a smooth transition from thawed to frozen soils:
341 ! simply linearly weight Kersten number by frozen fraction
342 ! in soil:
343 !
344  zkersten(jj) = (1.0-zfrozen2(jj))*zkersten(jj) + &
345  zfrozen2(jj) *zsatdeg(jj)
346 !
347 ! Thermal conductivity of soil:
348 !
349  zcond(jj) = zkersten(jj)*(zcondsat(jj)-pconddryz(jj)) + pconddryz(jj)
350 !
351 ! Heat capacity of soil:
352 !
353  zhcap(jj) = (1.0-pwsat(jj)) * phcapsoilz(jj) + &
354  pwg(jj,2) * xcl * xrholw + &
355  pwgi(jj,2) * xci * xrholi
356 !
357 ! Explicit CG calculation:
358 !
359  pcg(jj) = 2.*sqrt(xpi/zcond(jj)/zhcap(jj)/xday)
360 !
361  ENDDO
362 !
363 ENDIF
364 !
365 ! Cg must be smaller than 2.E-5
366 !
367 pcg(:) = min( pcg(:), pcgmax )
368 !
369 !-------------------------------------------------------------------------------
370 !
371 !* 4. THE HEAT CAPACITY OF THE SNOW AND FLOOD
372 ! ---------------------------------------
373 !
374 WHERE (pff(:) > 0.)
375  zcf(:) = 2.0 * sqrt( xpi/(xcondwtr*xrholw*xcl*xday) )
376 END WHERE
377 !
378 IF(hsnow_isba == 'D95' .OR. (hsnow_isba == 'EBA' .AND. oglacier) )THEN
379 !
380  WHERE (ppsn > 0.)
381  zlams(:) = xcondi * (psnowrhom(:)/xrholw)**1.885 ! first calculate the
382 ! ! conductivity of snow
383  pcs(:) = 2.0 * sqrt( xpi/(zlams(:)*psnowrhom(:)*xci*xday) )
384  END WHERE
385 !
386 !-------------------------------------------------------------------------------
387 !
388 !* 5. GRID-AVERAGED HEAT CAPACITY
389 ! ---------------------------
390 !
391 ! With contribution from the ground, vegetation, flood and snow areas
392 ! for composite (Force-Restore) snow scheme option:
393 !
394  pct(:) = 1. / ( (1.-pveg(:))*(1.-ppsng(:)-pffg(:)) / pcg(:) &
395  + pveg(:) *(1.-ppsnv(:)-pffv(:)) / pcv(:) &
396  + pff(:) / zcf(:) &
397  + ppsn(:) / pcs(:) )
398 
399 !
400 ELSE
401 !
402  DO jj=1,SIZE(pveg)
403 !
404  zff(jj) = pveg(jj)*pffv_nosnow(jj) + (1.-pveg(jj))*pffg_nosnow(jj)
405 !
406 ! With contribution from the ground and vegetation for explicit
407 ! (ISBA-ES) snow scheme option:
408 !
409  pct(jj) = 1. / ( (1.-pveg(jj))*(1.-pffg_nosnow(jj)) / pcg(jj) &
410  + pveg(jj) *(1.-pffv_nosnow(jj)) / pcv(jj) &
411  + zff(jj) / zcf(jj) )
412  ENDDO
413 !
414 ENDIF
415 !
416 !
417 !-------------------------------------------------------------------------------
418 !
419 !* 6. COEFFICIENT C1
420 ! --------------
421 ! Scale the C1SAT coefficient as a function
422 ! of the soil ice content
423 !
424 zc1sat(:) = pc1sat(:)*sqrt(zwsat1(:)/pwsat(:))
425 !
426 !
427 ! The coefficient C1 is calculated two
428 ! different ways depending on the humidity
429 ! of the soil
430 !
431 WHERE (pwg(:,1) > zwwilt(:))
432 ! ! First situation: humid soil
433 ! Then the calculation follows eq. (19)
434 ! of Noilhan and Planton(1989)
435 !
436  pc1(:) = zc1sat(:) * ( zwsat1(:)/pwg(:,1) )**( 0.5*pbcoef(:) + 1 )
437 !
438 END WHERE
439 !
440 !
441 ! Calculate C1 coefficient for dry soil.
442 ! The default option is the continuous
443 ! formulation of Giard and Bazile. The
444 ! alternate approach is a discontinuous
445 ! formulation by Giordani (1993) and
446 ! Braud et al. (1993). This method
447 ! is perhaps more accurate from a physical
448 ! standpoint, as it is an explicit function
449 ! of temperature, whereas the continuous method
450 ! assumes a constant temperature.
451 !
452 IF(hc1dry=='GB93')THEN
453 !
454  DO jj=1,SIZE(pwg,1)
455 !
456  IF (pwg(jj,1) <= zwwilt(jj)) THEN
457 !
458 ! ! Second situation: dry soil
459 ! We use the Gaussian formulation of
460 ! Giordanni (1993) and Braud et al. (1993)
461 !
462 !* maximum of C1 curve (computed with true Wwilt)
463 !
464  zcw1max(jj) = ( 1.19*zwwilt(jj)-5.09 )*ptg(jj) + (-146.4*zwwilt(jj)+1786.)
465 !
466 !* Giordanni (1993) and Braud et al. (1993)
467 !
468  za(jj) = (-1.815e-2*ptg(jj)+6.41)*zwwilt(jj) &
469  + (6.5e-3*ptg(jj)-1.4)
470  zb(jj) = za(jj)*zwwilt(jj)
471  zdelta(jj) = ( zb(jj)*zb(jj) ) / &
472  ( 2.*log( zcw1max(jj) ) )
473 !
474  pc1(jj) = zcw1max(jj)*(1. - 2.*pveg(jj)*( 1.-pveg(jj) )) &
475  *exp( -(pwg(jj,1)-zb(jj))*(pwg(jj,1)-zb(jj)) / &
476  (2.*zdelta(jj)) )
477 !
478  ENDIF
479 !
480  ENDDO
481 !
482 ELSE
483 !
484  DO jj=1,SIZE(pwg,1)
485 !
486  IF (pwg(jj,1) <= zwwilt(jj)) THEN
487 !
488 !* maximum of C1 curve (computed with true Wwilt)
489 !
490  zcw1max(jj) = ( 1.19*zwwilt(jj)-5.09 )*ptg(jj) + (-146.4*zwwilt(jj)+1786.)
491 !
492 !* C1 value at Wg = zero
493 !
494  zy1(jj) = 10.
495 !
496 !* C1 value at Wg = wwilt
497 !
498  zx2(jj) = zwwilt(jj)
499  zy2(jj) = zc1sat(jj)*(zwsat1(jj)/zwwilt(jj))**( 0.5*pbcoef(jj) + 1)
500 !
501 !* correction of maximum of C1 curve for frozen soils
502 !
503  zcw1max(jj) = max(max(zcw1max(jj),zy2(jj)),zy1(jj))
504 !
505 !* Giard-Bazile formulation (resolution of a second order equation)
506 !
507  zlymy1(jj) = log( zcw1max(jj)/zy1(jj))
508  zza(jj) = - log( zy2(jj)/zy1(jj))
509  zzb(jj) = 2. * zx2(jj) * zlymy1(jj)
510  zdelta(jj) = 4. * (zlymy1(jj)+zza(jj)) * zlymy1(jj) * zx2(jj)**2
511 !
512  za(jj) = (-zzb(jj)+sqrt(zdelta(jj))) / (2.*zza(jj))
513 !
514  zb(jj) = za(jj)**2 / zlymy1(jj)
515 !
516 !
517  pc1(jj) = zcw1max(jj) * exp( - (pwg(jj,1)-za(jj))**2 / zb(jj) )
518 !
519  ENDIF
520 !
521  ENDDO
522 !
523 ENDIF
524 !-------------------------------------------------------------------------------
525 !
526 !* 6. COEFFICIENT C2
527 ! --------------
528 ! Including vertical diffusion limiting factor for surface soil ice:
529 !
530 IF(hksat=='SGH' .OR. hksat=='EXP')THEN
531 !
532 ! Adjusted root-zone soil water content
533 !
534  DO jj=1,SIZE(pwg,1)
535  zwg2(jj)=pwg(jj,2)*(pcondsat(jj,2)/pcondsat(jj,1))**(1./(2.*pbcoef(jj)+3))
536  ENDDO
537  zwg2(:)=max(zwg2(:),xwgmin)
538 !
539 ELSE
540 !
541  zwg2(:)=pwg(:,2)
542 !
543 ENDIF
544 !
545 DO jj=1,SIZE(zwsat)
546 !
547 !Including vertical diffusion limiting factor for surface soil ice:
548 !
549  pc2(jj) = (pc2ref(jj)*zwg2(jj) / ( zwsat(jj)-zwg2(jj) + 0.01 )) &
550  *(1.0-(pwgi(jj,1)/(pwsat(jj)-xwgmin)))
551 !
552 !-------------------------------------------------------------------------------
553 !
554 !* 7. EQUILIBRIUM VOLUMETRIC WATER CONTENT WGEQ
555 ! -----------------------------------------
556 !
557  zx(jj) = zwg2(jj)/zwsat(jj)
558 !
559  pwgeq(jj) = zwg2(jj) - zwsat(jj)*pacoef(jj) &
560  * zx(jj)** ppcoef(jj) &
561  *( 1.-exp(ppcoef(jj)*8.*log(zx(jj))))
562 !
563 ENDDO
564 !-------------------------------------------------------------------------------
565 !
566 !* 8. SPECIAL CASE OF POLAR REGIONS
567 ! -----------------------------
568 !
569 IF (lphysdomc) THEN
570  pct(:) = 9.427757e-6 ! corresponds to a density of 350kg/m3 for snow
571 ENDIF
572 IF (lhook) CALL dr_hook('SOIL',1,zhook_handle)
573 !
574 !-------------------------------------------------------------------------------
575 !
576 END SUBROUTINE soil
subroutine soil(HC1DRY, HSCOND, HSNOW_ISBA, OGLACIER, PSNOWRHOM, PVEG, PCGSAT, PCGMAX, PC1SAT, PC2REF, PACOEF, PPCOEF, PCV, PPSN, PPSNG, PPSNV, PFFG, PFFV, PFF, PCG, PC1, PC2, PWGEQ, PCT, PCS, PFROZEN1, PTG, PWG, PWGI, PHCAPSOILZ, PCONDDRYZ, PCONDSLDZ, PBCOEF, PWSAT, PWWILT, HKSAT, PCONDSAT, PFFG_NOSNOW, PFFV_NOSNOW)
Definition: soil.F90:6