Core

main script SCOPE.m

biochemical(biochem_in, Ci_input)

Date: 21 Sep 2012 Update: 20 Feb 2013 Update: Aug 2013: correction of L171: Ci = Ci*1e6 ./ p .* 1E3; Update: 2016-10 - (JAK) major rewrite to accomodate an iterative solution to the Ball-Berry equation

  • also allows for g_m to be specified for C3 plants, but only if Ci_input is provided.

Authors: Joe Berry and Christiaan van der Tol, Ari Kornfeld, contributions of others. Sources:

Farquhar et al. 1980, Collatz et al (1991, 1992).

This function calculates:
  • stomatal resistance of a leaf or needle (s m-1)

  • photosynthesis of a leaf or needle (umol m-2 s-1)

  • fluorescence of a leaf or needle (fraction of fluor. in the dark)

Usage: biochem_out = biochemical(biochem_in) the function was tested for Matlab R2013b

Calculates net assimilation rate A, fluorescence F using biochemical model

Input (units are important): structure ‘biochem_in’ with the following elements: Knparams % [], [], [] parameters for empirical Kn (NPQ) model: Kn = Kno * (1+beta).*x.^alpha./(beta + x.^alpha);

[Kno, Kn_alpha, Kn_beta]

or, better, as individual fields:

Kno Kno - the maximum Kn value (“high light”) Kn_alpha, Kn_beta alpha, beta: curvature parameters

Cs % [ppmV or umol mol] initial estimate of conc. of CO2 in the

…bounary layer of the leaf

Q % [umol photons m-2 s-1]net radiation, PAR fPAR % [0-1] fraction of incident light that is absorbed by the leaf (default = 1, for compatibility) T % [oC or K] leaf temperature eb % [hPa = mbar] intial estimate of the vapour pressure in leaf boundary layer O % [mmol/mol] concentration of O2 (in the boundary

…layer, but no problem to use ambient)

p % [hPa] air pressure Vcmax25 (Vcmo) % [umol/m2/s] maximum carboxylation capacity @ 25 degC BallBerrySlope (m) % [] Ball-Berry coefficient ‘m’ for stomatal regulation BallBerry0 % [] (OPTIONAL) Ball-Berry intercept term ‘b’ (if present, an iterative solution is used)

setting this to zeo disables iteration. Default = 0.01

Type % [‘C3’, ‘C4’] text parameter, either ‘C3’ for C3 or any

…other text for C4

tempcor % [0, 1] boolean (0 or 1) whether or not

…temperature correction to Vcmax has to be applied.

Tparams % [],[],[K],[K],[K] vector of 5 temperature correction parameters, look in spreadsheet of PFTs.

Only if tempcor=1, otherwise use dummy values

…Or replace w/ individual values: slti [] slope of cold temperature decline (C4 only) shti [] slope of high temperature decline in photosynthesis Thl [K] T below which C4 photosynthesis is <= half that predicted by Q10 Thh [K] T above which photosynthesis is <= half that predicted by Q10 Trdm [K] T at which respiration is <= half that predicted by Q10

biochemical_MD12(biochem_in)

[A,Ci,eta] = biochemical_VCM(Cs,Q,T,eb,O,p,Vcmo,m,Type,Rdparam,stress,Tyear,beta,qLs,NPQs) Date: 21 Sep 2012 Update: 28 Jun 2013 Adaptation for use of Farquhar model of C3 photosynthesis (Farquhar et al 1980)

18 Jul 2013 Inclusion of von Caemmerer model of C4 photosynthesis (von Caemmerer 2000, 2013) 15 Aug 2013 Modified computation of CO2-limited electron transport in C4 species for consistency with light-limited value 22 Oct 2013 Included effect of qLs on Jmax and electron transport; value of kNPQs re-scaled in input as NPQs

Authors: Federico Magnani, with contributions from Christiaan van der Tol

This function calculates:
  • CO2 concentration in intercellular spaces (umol/mol == ppmv)

  • leaf net photosynthesis (umol/m2/s) of C3 or C4 species

  • fluorescence yield of a leaf (fraction of reference fluorescence yield in dark-adapted and un-stressed leaf)

Usage: function [A,Cs,eb,f,rcw] = biochemical(C,Cs,Q,T,ea,eb,O,p,Vcmo,gcparam,Type,tempcor,ra,Tparams,Rdparam,stressfactor,Tyear,beta,qLs,NPQs) the function was tested for Matlab 7.2.0.232 (R2006a)

Input (units are important; when not otherwise specified, mol refers to mol C): Cs % [umol/mol] CO2 concentration at leaf surface Q % [uE/m2/s] photochemically active radiation absorbed by the leaf T % [oC or K] leaf temperature eb % [hPa] vapour pressure in leaf boundary layer O % [mmol/mol] ambient O2 concentration p % [Pa] air pressure Vcmo % [umol/m2/s] maximum carboxylation capacity m % [mol/mol] Ball-Berry coefficient ‘m’ for stomatal regulation Type % [] text parameter, either ‘C3’ for C3 or any other text for C4 Rdparam % [mol/mol] respiration at reference temperature as fraction of Vcmax stress % [] optional input: stress factor to reduce Vcmax (for example soil moisture, leaf age). Default value = 1 (no stress). Tyear % [oC] mean annual temperature beta % [] fraction of photons partitioned to PSII (0.507 for C3, 0.4 for C4; Yin et al. 2006; Yin and Struik 2012) qLs % [] fraction of functional reaction centres (Porcar-Castell 2011) NPQs % [s-1] rate constant of sustained thermal dissipation, normalized to (kf+kD) (=kNPQs’; Porcar-Castell 2011)

Note: always use the prescribed units. Temperature can be either oC or K Note: input can be single numbers, vectors, or n-dimensional matrices Note: For consistency reasons, in C4 photosynthesis electron transport rates under CO2-limited conditions are computed by inverting the equation

applied for light-limited conditions(Ubierna et al 2013). A discontinuity would result when computing J from ATP requirements of Vp and Vco, as a fixed electron transport partitioning is assumed for light-limited conditions

BSM(soilpar, spec, emp)

Spectral parameters

calc_brdf(options, directional, spectral, angles, rad, atmo, soil, leafopt, canopy, meteo, profiles, thermal)
ebal(iter, options, spectral, rad, gap, leafopt, angles, meteo, soil, canopy, leafbio, xyt, k, profiles)

function ebal.m calculates the energy balance of a vegetated surface

authors: Christiaan van der Tol (tol@itc.nl)

Joris Timmermans (j_timmermans@itc.nl)

date 26 Nov 2007 (CvdT) updates 29 Jan 2008 (JT & CvdT) converted into a function

11 Feb 2008 (JT & CvdT) improved soil heat flux and temperature calculation 14 Feb 2008 (JT) changed h in to hc (as h=Avogadro`s constant) 31 Jul 2008 (CvdT) Included Pntot in output 19 Sep 2008 (CvdT) Converted F0 and F1 from units per aPAR into units per iPAR 07 Nov 2008 (CvdT) Changed layout 18 Sep 2012 (CvdT) Changed Oc, Cc, ec

Feb 2012 (WV) introduced structures for variables Sep 2013 (JV, CvT) introduced additional biochemical model

parent: master.m (script) uses:

RTMt_sb.m, RTMt_planck.m (optional), RTMf.m (optional) resistances.m heatfluxes.m biochemical.m soil_respiration.m

Table of contents of the function

  1. Initialisations for the iteration loop

    intial values are attributed to variables

  2. Energy balance iteration loop

    iteration between thermal RTM and surface fluxes

  3. Write warnings whenever the energy balance did not close

  4. Calculate vertical profiles (optional)

  5. Calculate spectrally integrated energy, water and CO2 fluxes

The energy balance iteration loop works as follows:

RTMo More or less the classic SAIL model for Radiative

Transfer of sun and sky light (no emission by the vegetation)

While continue Here an iteration loop starts to close the energy

balance, i.e. to match the micro-meteorological model and the radiative transfer model

RTMt_sb A numerical Radiative Transfer Model for thermal

radiation emitted by the vegetation

resistances Calculates aerodynamic and boundary layer resistances

of vegetation and soil (the micro-meteorological model)

biochemical Calculates photosynthesis, fluorescence and stomatal

resistance of leaves (or biochemical_MD12: alternative)

heatfluxes Calculates sensible and latent heat flux of soil and

vegetation Next soil heat flux is calculated, the energy balance is evaluated, and soil and leaf temperatures adjusted to force energy balance closure

end {while continue}

meanleaf Integrates the fluxes over all leaf inclinations

azimuth angles and layers, integrates over the spectrum

usage:

[iter,fluxes,rad,profiles,thermal] …
= ebal(iter,options,spectral,rad,gap,leafopt, …

angles,meteo,soil,canopy,leafbio)

The input and output are structures. These structures are further specified in a readme file.

Input:

iter numerical parameters used in the iteration for energy balance closure options calculation options spectral spectral resolutions and wavelengths rad incident radiation gap probabilities of direct light penetration and viewing leafopt leaf optical properties angles viewing and observation angles soil soil properties canopy canopy properties leafbio leaf biochemical parameters

Output:

iter numerical parameters used in the iteration for energy balance closure fluxes energy balance, turbulent, and CO2 fluxes rad radiation spectra profiles vertical profiles of fluxes thermal temperatures, aerodynamic resistances and friction velocity

fluspect_B_CX(spectral, leafbio, optipar)

function [leafopt] = fluspect(spectral,leafbio,optipar) calculates reflectance and transmittance spectra of a leaf using FLUSPECT, plus four excitation-fluorescence matrices

Authors: Wout Verhoef, Christiaan van der Tol (tol@itc.nl), Joris Timmermans, Date: 2007 Update from PROSPECT to FLUSPECT: January 2011 (CvdT)

Nov 2012 (CvdT) Output EF-matrices separately for PSI and PSII

31 Jan 2013 (WV) Adapt to SCOPE v_1.40, using structures for I/O 30 May 2013 (WV) Repair bug in s for non-conservative scattering 24 Nov 2013 (WV) Simplified doubling routine 25 Nov 2013 (WV) Restored piece of code that takes final refl and

tran outputs as a basis for the doubling routine

03 Dec 2013 (WV) Major upgrade. Border interfaces are removed before

the fluorescence calculation and later added again

23 Dec 2013 (WV) Correct a problem with N = 1 when calculating k

and s; a test on a = Inf was included

01 Apr 2014 (WV) Add carotenoid concentration (Cca and Kca) 19 Jan 2015 (WV) First beta version for simulation of PRI effect 17 Mar 2017 (CT) Added Anthocyanins (following Prospect-D)

usage: [leafopt] = fluspect_b(spectral,leafbio,optipar)

inputs: Cab = leafbio.Cab; Cca = leafbio.Cca; V2Z = leafbio.V2Z; % Violaxanthin - Zeaxanthin transition status

[0-1]

Cw = leafbio.Cw; Cdm = leafbio.Cdm; Cs = leafbio.Cs; Cant = leafbio.Cant; N = leafbio.N; fqe = leafbio.fqe;

nr = optipar.nr; Kdm = optipar.Kdm; Kab = optipar.Kab; Kca = optipar.Kca; KcaV = optipar.KcaV; KcaZ = optipar.KcaZ; Kw = optipar.Kw; Ks = optipar.Ks; phiI = optipar.phiI; phiII = optipar.phiII;

outputs: refl reflectance tran transmittance Mb backward scattering fluorescence matrix, I for PSI and II for PSII Mf forward scattering fluorescence matrix, I for PSI and II for PSII

fluspect_B_CX_PSI_PSII_combined(spectral, leafbio, optipar)

function [leafopt] = fluspect(spectral,leafbio,optipar) calculates reflectance and transmittance spectra of a leaf using FLUSPECT, plus four excitation-fluorescence matrices

Authors: Wout Verhoef, Christiaan van der Tol (tol@itc.nl), Joris Timmermans, Date: 2007 Update from PROSPECT to FLUSPECT: January 2011 (CvdT)

Nov 2012 (CvdT) Output EF-matrices separately for PSI and PSII

31 Jan 2013 (WV) Adapt to SCOPE v_1.40, using structures for I/O 30 May 2013 (WV) Repair bug in s for non-conservative scattering 24 Nov 2013 (WV) Simplified doubling routine 25 Nov 2013 (WV) Restored piece of code that takes final refl and

tran outputs as a basis for the doubling routine

03 Dec 2013 (WV) Major upgrade. Border interfaces are removed before

the fluorescence calculation and later added again

23 Dec 2013 (WV) Correct a problem with N = 1 when calculating k

and s; a test on a = Inf was included

01 Apr 2014 (WV) Add carotenoid concentration (Cca and Kca) 19 Jan 2015 (WV) First beta version for simulation of PRI effect 17 Mar 2017 (CT) Added Anthocyanins according to Prospect-D

usage: [leafopt] = fluspect_b(spectral,leafbio,optipar)

inputs: Cab = leafbio.Cab; Cca = leafbio.Cca; V2Z = leafbio.V2Z; % Violaxanthin - Zeaxanthin transition status

[0-1]

Cw = leafbio.Cw; Cdm = leafbio.Cdm; Cs = leafbio.Cs; Cant = leafbio.Cant; N = leafbio.N; fqe = leafbio.fqe;

nr = optipar.nr; Kdm = optipar.Kdm; Kab = optipar.Kab; Kca = optipar.Kca; KcaV = optipar.KcaV; KcaZ = optipar.KcaZ; Kw = optipar.Kw; Ks = optipar.Ks; phi = optipar.phi; outputs: refl reflectance tran transmittance Mb backward scattering fluorescence matrix, I for PSI and II for PSII Mf forward scattering fluorescence matrix, I for PSI and II for PSII

heatfluxes(ra, rs, Tc, ea, Ta, e_to_q, PSI, Ca, Ci)
resistances(resist_in)

function resistances calculates aerodynamic and boundary resistances for soil and vegetation

Date: 01 Feb 2008 Authors: Anne Verhoef (a.verhoef@reading.ac.uk)

Christiaan van der Tol (tol@itc.nl) Joris Timmermans (j_timmermans@itc.nl)

Source: Wallace and Verhoef (2000) ‘Modelling interactions in

mixed-plant communities: light, water and carbon dioxide’, in: Bruce Marshall, Jeremy A. Roberts (ed), ‘Leaf Development and Canopy Growth’, Sheffield Academic Press, UK. ISBN 0849397693

ustar: Tennekes, H. (1973) ‘The logaritmic wind profile’, J. Atmospheric Science, 30, 234-238 Psih: Paulson, C.A. (1970), The mathematical representation of wind speed and temperature in the unstable atmospheric surface layer. J. Applied Meteorol. 9, 857-861

Note: Equation numbers refer to equation numbers in Wallace and Verhoef (2000)

Usage:

[resist_out] = resistances(resist_in)

The input and output are structures. These structures are further specified in a readme file.

Input:

resist_in aerodynamic resistance parameters and wind speed

The strucutre resist_in contains the following elements: u = windspeed L = stability LAI = Leaf Area Index

RTMf(spectral, rad, soil, leafopt, canopy, gap, angles, profiles)

function ‘RTMf’ calculates the spectrum of fluorescent radiance in the observer’s direction in addition to the total TOC spectral hemispherical upward Fs flux

Authors: Wout Verhoef and Christiaan van der Tol (c.vandertol@utwente.nl) Date: 12 Dec 2007 Update: 26 Aug 2008 CvdT Small correction to matrices

07 Nov 2008 CvdT Changed layout

Update: 19 Mar 2009 CvdT Major corrections: lines 95-96,

101-107, and 119-120.

Update: 7 Apr 2009 WV & CvdT Major correction: lines 89-90, azimuth

dependence was not there in previous verions (implicit assumption of azimuth(solar-viewing) = 0). This has been corrected

Update: May-June 2012 WV & CvdT Add calculation of hemispherical Fs

fluxes

Update: Jan-Feb 2013 WV Inputs and outputs via structures for

SCOPE Version 1.40

Update: Jan 2015 CvdT Added two contributions to SIF radiance cuased by rescattering of hemispherical SIF fluxes Update: Jan 2015 JAK (from SCOPE 1.53): Improved speed by factor of 9+! (by vectorizing the summation over the 60 layers) Update: Jan 2015 WV Rearranged some arrays to smoothen the vectorizations; adjusted some internal names

The inputs and outputs are structures. These structures are further specified in a readme file.

Input:

spectral information about wavelengths and resolutions rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients.

soil soil properties leafopt leaf optical properties canopy canopy properties (such as LAI and height) gap probabilities of direct light penetration and viewing angles viewing and observation angles profiles vertical profiles of fluxes

Output:
rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients. Here, fluorescence fluxes are added

0.0 globals

RTMo(spectral, atmo, soil, leafopt, canopy, angles, meteo, rad, options)

function RTMo

calculates the spectra of hemisperical and directional observed visible and thermal radiation (fluxes E and radiances L), as well as the single and bi-directional gap probabilities

the function does not require any non-standard Matlab functions. No changes to the code have to be made to operate the function for a particular canopy. All necessary parameters and variables are input or global and need to be specified elsewhere.

Authors: Wout Verhoef (verhoef@nlr.nl)

Christiaan van der Tol (tol@itc.nl) Joris Timmermans (j_timmermans@itc.nl)

updates: 10 Sep 2007 (CvdT) - calculation of Rn

5 Nov 2007 - included observation direction

12 Nov 2007 - included abs. PAR spectrum output
  • improved calculation efficiency

13 Nov 2007 - written readme lines 11 Feb 2008 (WV&JT) - changed Volscat

(JT) - small change in calculation Po,Ps,Pso
  • introduced parameter ‘lazitab’

  • changed nomenclature

  • Appendix IV: cosine rule

04 Aug 2008 (JT) - Corrections for Hotspot effect in the probabilities 05 Nov 2008 (CvdT) - Changed layout 04 Jan 2011 (JT & CvdT) - Included Pso function (Appendix IV)

  • removed the analytical function (for checking)

02 Oct 2012 (CvdT) - included incident PAR in output

Jan/Feb 2013 (WV) - Major revision towards SCOPE version 1.40:
  • Parameters passed using structures

  • Improved interface with MODTRAN atmospheric data

  • Now also calculates 4-stream reflectances rso, rdo, rsd and rdd analytically

Apri 2013 (CvT) - improvements in variable names

and descriptions

Table of contents of the function

  1. Preparations

0.1 parameters 0.2 initialisations

  1. Geometric quantities

1.1 general geometric quantities 1.2 geometric factors associated with extinction and scattering 1.3 geometric factors to be used later with rho and tau 1.4 solar irradiance factor for all leaf orientations 1.5 probabilities Ps, Po, Pso

  1. Calculation of upward and downward fluxes

  2. Outgoing fluxes, hemispherical and in viewing direction, spectrum

4. Net fluxes, spectral and total, and incoming fluxes A1 functions J1 and J2 (introduced for stable solutions) A2 function volscat A3 function e2phot A4 function Pso

references:

{1} Verhoef (1998), ‘Theory of radiative transfer models applied in

optical remote sensing of vegetation canopies’. PhD Thesis Univ. Wageninegn

{2} Verhoef, W., Jia, L., Xiao, Q. and Su, Z. (2007) Unified optical -

thermal four - stream radiative transfer theory for homogeneous vegetation canopies. IEEE Transactions on geoscience and remote sensing, 45,6.

{3} Verhoef (1985), ‘Earth Observation Modeling based on Layer Scattering

Matrices’, Remote sensing of Environment, 17:167-175

Usage: function [rad,gap,profiles] = RTMo(spectral,atmo,soil,leafopt,canopy,angles,meteo,rad,options)

The input and output are structures. These structures are further specified in a readme file.

Input:

spectral information about wavelengths and resolutions atmo MODTRAN atmospheric parameters soil soil properties leafopt leaf optical properties canopy canopy properties (such as LAI and height) angles viewing and observation angles meteo has the meteorological variables. Is only used to correct

the total irradiance if a specific value is provided instead of the usual Modtran output.

rad initialization of the structure of the output ‘rad’ options simulation options. Here, the option

‘calc_vert_profiles’ is used, a boolean that tells whether or not to output data of 60 layers separately.

Output:

gap probabilities of direct light penetration and viewing rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients.

profiles vertical profiles of radiation variables such as absorbed

PAR.

RTMt_planck(spectral, rad, soil, leafopt, canopy, gap, angles, Tcu, Tch, Tsu, Tsh, obsdir)

function ‘RTMt_planck’ calculates the spectrum of outgoing thermal radiation in hemispherical and viewing direction

Authors: Wout Verhoef and Christiaan van der Tol (tol@itc.nl) Date: 5 November 2007 Update: 14 Nov 2007

16 Nov 2007 CvdT improved calculation of net radiation 17 Dec 2007 JT simplified, removed net radiation 07 Nov 2008 CvdT changed layout 16 Mar 2009 CvdT removed calculation of Tbright 12 Apr 2013 CvdT introduced structures

Table of contents of the function:
  1. preparations

0.0 globals 0.1 initialisations 0.2 parameters 0.3 geometric factors of Observer 0.4 geometric factors associated with extinction and scattering 0.5 geometric factors to be used later with rho and tau 0.6 fo for all leaf angle/azumith classes

1 calculation of upward and downward fluxes 2 outgoing fluxes, hemispherical and in viewing direction A1 function planck (external function is now used)

Usage:

function rad = RTMt_planck(spectral,rad,soil,leafopt,canopy,gap,angles,Tcu,Tch,Tsu,Tsh,obsdir)

Input:

Symbol Description Unit Dimension —— ———– —- ——— Tcu temperature sunlit leaves C [13,36,nl] Tch temperature shaded leaves C [nl] Tsu temperature sunlit soil C [1] Tsu temperature shaded soil C [1] rad a structure containing soil a structure containing soil reflectance canopy a structure containing LAI and leaf inclination

RTMz(spectral, rad, soil, leafopt, canopy, gap, angles, profiles)

function ‘RTMz’ calculates the small modification of TOC outgoing radiance due to the conversion of Violaxanthin into Zeaxanthin in leaves

Author: Christiaan van der Tol (c.vandertol@utwente.nl) Date: 08 Dec 2016

The inputs and outputs are structures. These structures are further specified in a readme file.

Input:

spectral information about wavelengths and resolutions rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients.

soil soil properties leafopt leaf optical properties canopy canopy properties (such as LAI and height) gap probabilities of direct light penetration and viewing angles viewing and observation angles profiles vertical profiles of fluxes

Output:
rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients. Here, fluorescence fluxes are added

0.0 globals

RTMt_sb(spectral, rad, soil, leafopt, canopy, gap, angles, Tcu, Tch, Tsu, Tsh, obsdir)

function ‘RTMt_sb’ calculates total outgoing radiation in hemispherical direction and total absorbed radiation per leaf and soil component. Radiation is integrated over the whole thermal spectrum with Stefan-Boltzman’s equation. This function is a simplified version of ‘RTMt_planck’, and is less time consuming since it does not do the calculation for each wavelength separately.

Authors: Wout Verhoef and Christiaan van der Tol (tol@itc.nl) date: 5 Nov 2007 update: 13 Nov 2007

16 Nov 2007 CvdT improved calculation of net radiation 27 Mar 2008 JT added directional calculation of radiation 24 Apr 2008 JT Introduced dx as thickness of layer (see parameters) 31 Oct 2008 JT introduced optional directional calculation 31 Oct 2008 JT changed initialisation of F1 and F2 -> zeros 07 Nov 2008 CvdT changed layout 16 Mar 2009 CvdT removed Tbright calculation

Feb 2013 WV introduces structures for version 1.40

Table of contents of the function
0 preparations

0.0 globals 0.1 initialisations 0.2 parameters 0.3 geometric factors of Observer 0.4 geometric factors associated with extinction and scattering 0.5 geometric factors to be used later with rho and tau 0.6 fo for all leaf angle/azumith classes

1 calculation of upward and downward fluxes 2 total net fluxes Appendix A. Stefan-Boltzmann

usage: [rad] = RTMt_sb(options,spectral,rad,soil,leafopt,canopy,gap,angles,Tcu,Tch,Tsu,Tsh)

Most input and output are structures. These structures are further specified in a readme file. The temperatures Tcu, Tch, Tsu and Tsh are variables.

Input:

options calculation options spectral information about wavelengths and resolutions rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients

soil soil properties leafopt leaf optical properties canopy canopy properties (such as LAI and height) gap probabilities of direct light penetration and viewing angles viewing and observation angles Tcu Temperature of sunlit leaves (oC), [13x36x60] Tch Temperature of shaded leaves (oC), [13x36x60] Tsu Temperature of sunlit soil (oC), [1] Tsh Temperature of shaded soil (oC), [1]

Output:
rad a large number of radiative fluxes: spectrally distributed

and integrated, and canopy radiative transfer coefficients. Here, thermal fluxes are added

0.0 globals