ARTS  2.0.49
rte.cc File Reference

Functions to solve radiative transfer tasks. More...

#include <cmath>
#include <stdexcept>
#include "auto_md.h"
#include "check_input.h"
#include "logic.h"
#include "math_funcs.h"
#include "montecarlo.h"
#include "physics_funcs.h"
#include "ppath.h"
#include "rte.h"
#include "special_interp.h"
#include "lin_alg.h"

Go to the source code of this file.

Functions

void apply_y_unit (MatrixView iy, const String &y_unit, ConstVectorView f_grid, const ArrayOfIndex &i_pol)
 apply_y_unit More...
 
void apply_y_unit2 (Tensor3View J, ConstMatrixView iy, const String &y_unit, ConstVectorView f_grid, const ArrayOfIndex &i_pol)
 apply_y_unit2 More...
 
void ext2trans (MatrixView trans_mat, ConstMatrixView ext_mat_av, const Numeric &l_step)
 ext2trans More...
 
void get_ppath_atmvars (Vector &ppath_p, Vector &ppath_t, Matrix &ppath_vmr, Vector &ppath_wind_u, Vector &ppath_wind_v, Vector &ppath_wind_w, const Ppath &ppath, const Index &atmosphere_dim, ConstVectorView p_grid, ConstTensor3View t_field, ConstTensor4View vmr_field, ConstTensor3View wind_u_field, ConstTensor3View wind_v_field, ConstTensor3View wind_w_field)
 get_ppath_atmvars More...
 
void get_ppath_pnd (Matrix &ppath_pnd, const Ppath &ppath, const Index &atmosphere_dim, const ArrayOfIndex &cloudbox_limits, ConstTensor4View pnd_field)
 get_ppath_pnd More...
 
void get_ppath_rtvars (Workspace &ws, Tensor3 &ppath_abs_scalar, Matrix &ppath_tau, Vector &total_tau, Matrix &ppath_emission, const Agenda &abs_scalar_gas_agenda, const Agenda &emission_agenda, const Ppath &ppath, ConstVectorView ppath_p, ConstVectorView ppath_t, ConstMatrixView ppath_vmr, ConstVectorView ppath_wind_u, ConstVectorView ppath_wind_v, ConstVectorView ppath_wind_w, ConstVectorView f_grid, const Index &atmosphere_dim, const Index &emission_do)
 get_ppath_rtvars More...
 
void get_ppath_cloudrtvars (Workspace &ws, Tensor3 &ppath_asp_abs_vec, Tensor4 &ppath_asp_ext_mat, Tensor3 &ppath_pnd_abs_vec, Tensor4 &ppath_pnd_ext_mat, Tensor4 &ppath_transmission, Tensor3 &total_transmission, Matrix &ppath_emission, Array< ArrayOfSingleScatteringData > &scat_data, const Agenda &abs_scalar_gas_agenda, const Agenda &emission_agenda, const Agenda &opt_prop_gas_agenda, const Ppath &ppath, ConstVectorView ppath_p, ConstVectorView ppath_t, ConstMatrixView ppath_vmr, ConstVectorView ppath_wind_u, ConstVectorView ppath_wind_v, ConstVectorView ppath_wind_w, ConstMatrixView ppath_pnd, const Index &use_mean_scat_data, const ArrayOfSingleScatteringData &scat_data_raw, const Index &stokes_dim, ConstVectorView f_grid, const Index &atmosphere_dim, const Index &emission_do, const Verbosity &verbosity)
 get_ppath_cloudrtvars More...
 
Range get_rowindex_for_mblock (const Sparse &sensor_response, const Index &imblock)
 get_rowindex_for_mblock More...
 
void iy_transmission_for_scalar_tau (Tensor3 &iy_transmission, const Index &stokes_dim, ConstVectorView tau)
 iy_transmission_for_scalar_tau More...
 
void iy_transmission_mult (Tensor3 &iy_trans_new, ConstTensor3View iy_transmission, ConstTensor3View trans)
 iy_transmission_mult More...
 
void iy_transmission_mult_scalar_tau (Tensor3 &iy_trans_new, ConstTensor3View iy_transmission, ConstVectorView tau)
 iy_transmission_mult_scalar_tau More...
 
void mirror_los (Vector &los_mirrored, ConstVectorView los, const Index &atmosphere_dim)
 mirror_los More...
 
void rte_step_std (VectorView stokes_vec, MatrixView trans_mat, ConstMatrixView ext_mat_av, ConstVectorView abs_vec_av, ConstVectorView sca_vec_av, const Numeric &l_step, const Numeric &rte_planck_value)
 rte_step_std More...
 
void surface_calc (Matrix &iy, const Tensor3 &I, const Matrix &surface_los, const Tensor4 &surface_rmatrix, const Matrix &surface_emission)
 surface_calc More...
 
void trans_step_std (VectorView stokes_vec, MatrixView trans_mat, ConstMatrixView ext_mat_av, const Numeric &l_step)
 trans_step_std More...
 

Variables

const Numeric BOLTZMAN_CONST
 
const Numeric PLANCK_CONST
 
const Numeric SPEED_OF_LIGHT
 
const Numeric PI
 
const Numeric DEG2RAD
 
const Numeric RAD2DEG
 

Detailed Description

Functions to solve radiative transfer tasks.

Author
Patrick Eriksson Patri.nosp@m.ck.E.nosp@m.rikss.nosp@m.on@r.nosp@m.ss.ch.nosp@m.alme.nosp@m.rs.se
Date
2002-05-29

Definition in file rte.cc.

Function Documentation

◆ apply_y_unit()

void apply_y_unit ( MatrixView  iy,
const String y_unit,
ConstVectorView  f_grid,
const ArrayOfIndex i_pol 
)

apply_y_unit

Performs conversion from radiance to other units.

Use apply_y_unit_jac for conversion of jacobian data.

Parameters
iyIn/Out: Tensor3 with data to be converted, where column dimension corresponds to Stokes dimensionality and row dimension corresponds to frequency.
y_unitAs the WSV.
f_gridAs the WSV.
i_polPolarisation indexes. See documentation of y_pol.
Author
Patrick Eriksson
Date
2010-04-07

Definition at line 82 of file rte.cc.

References invplanck(), invrayjean(), ConstMatrixView::ncols(), Array< base >::nelem(), ConstVectorView::nelem(), ConstMatrixView::nrows(), ns, and SPEED_OF_LIGHT.

Referenced by iyb_calc(), and y_unitApply().

◆ apply_y_unit2()

void apply_y_unit2 ( Tensor3View  J,
ConstMatrixView  iy,
const String y_unit,
ConstVectorView  f_grid,
const ArrayOfIndex i_pol 
)

apply_y_unit2

Largely as apply_y_unit but operates on jacobian data.

The associated spectrum data iy must be in radiance. That is, the spectrum can only be converted to Tb after the jacobian data.

iy* must be a single spectrum, and is accordingly here a matrix (and not a Tensor3 as for apply_y_unit).

Parameters
JIn/Out: Tensor3 with data to be converted, where column dimension corresponds to Stokes dimensionality and row dimension corresponds to frequency.
iyAssociated radiance data.
y_unitAs the WSV.
f_gridAs the WSV.
Author
Patrick Eriksson
Date
2010-04-10

Definition at line 184 of file rte.cc.

References dinvplanckdI(), invrayjean(), ConstMatrixView::ncols(), ConstTensor3View::ncols(), Array< base >::nelem(), ConstVectorView::nelem(), ConstTensor3View::npages(), ConstMatrixView::nrows(), ConstTensor3View::nrows(), ns, and SPEED_OF_LIGHT.

Referenced by iyb_calc(), and y_unitApply().

◆ ext2trans()

void ext2trans ( MatrixView  trans_mat,
ConstMatrixView  ext_mat_av,
const Numeric l_step 
)

ext2trans

Converts an extinction matrix to a transmission matrix

The function performs the calculations differently depending on the conditions to improve the speed. There are three cases:

  1. Scalar absorption.
  2. The matrix ext_mat_av is diagonal.
  3. The total general case.
Parameters
trans_matInput/Output: Transmission matrix of slab.
ext_matInput: Averaged extinction matrix.
l_stepInput: The length of the RTE step.
Author
Claudia Emde and Patrick Eriksson,
Date
2010-10-15

Definition at line 301 of file rte.cc.

References is_diagonal(), is_singular(), is_size(), matrix_exp(), ConstMatrixView::nrows(), and q.

Referenced by get_ppath_cloudrtvars(), and trans_step_std().

◆ get_ppath_atmvars()

void get_ppath_atmvars ( Vector ppath_p,
Vector ppath_t,
Matrix ppath_vmr,
Vector ppath_wind_u,
Vector ppath_wind_v,
Vector ppath_wind_w,
const Ppath ppath,
const Index atmosphere_dim,
ConstVectorView  p_grid,
ConstTensor3View  t_field,
ConstTensor4View  vmr_field,
ConstTensor3View  wind_u_field,
ConstTensor3View  wind_v_field,
ConstTensor3View  wind_w_field 
)

get_ppath_atmvars

Determines pressure, temperature, VMR and winds for each propgataion path point.

The output variables are sized inside the function. For VMR the dimensions are [ species, propagation path point ].

Parameters
ppath_pOut: Pressure for each ppath point.
ppath_tOut: Temperature for each ppath point.
ppath_vmrOut: VMR values for each ppath point.
ppath_wind_uOut: U-wind for each ppath point.
ppath_wind_vOut: V-wind for each ppath point.
ppath_wind_wOut: W-wind for each ppath point.
ppathAs the WSV.
atmosphere_dimAs the WSV.
p_gridAs the WSV.
lat_gridAs the WSV.
lon_gridAs the WSV.
t_fieldAs the WSV.
vmr_fieldAs the WSV.
wind_u_fieldAs the WSV.
wind_v_fieldAs the WSV.
wind_w_fieldAs the WSV.
Author
Patrick Eriksson
Date
2009-10-05

Definition at line 383 of file rte.cc.

References Ppath::gp_lat, Ppath::gp_lon, Ppath::gp_p, interp_atmfield_by_itw(), interp_atmfield_gp2itw(), interpweights(), itw2p(), joker, ConstTensor4View::nbooks(), Ppath::np, ConstTensor3View::npages(), ns, Vector::resize(), and Matrix::resize().

Referenced by iyBeerLambertStandardClearsky(), iyBeerLambertStandardCloudbox(), iyEmissionStandardClearsky(), iyEmissionStandardClearskyBasic(), and iyFOS().

◆ get_ppath_cloudrtvars()

void get_ppath_cloudrtvars ( Workspace ws,
Tensor3 ppath_asp_abs_vec,
Tensor4 ppath_asp_ext_mat,
Tensor3 ppath_pnd_abs_vec,
Tensor4 ppath_pnd_ext_mat,
Tensor4 ppath_transmission,
Tensor3 total_transmission,
Matrix ppath_emission,
Array< ArrayOfSingleScatteringData > &  scat_data,
const Agenda abs_scalar_gas_agenda,
const Agenda emission_agenda,
const Agenda opt_prop_gas_agenda,
const Ppath ppath,
ConstVectorView  ppath_p,
ConstVectorView  ppath_t,
ConstMatrixView  ppath_vmr,
ConstVectorView  ppath_wind_u,
ConstVectorView  ppath_wind_v,
ConstVectorView  ppath_wind_w,
ConstMatrixView  ppath_pnd,
const Index use_mean_scat_data,
const ArrayOfSingleScatteringData scat_data_raw,
const Index stokes_dim,
ConstVectorView  f_grid,
const Index atmosphere_dim,
const Index emission_do,
const Verbosity verbosity 
)

get_ppath_cloudrtvars

Determines variables for each step of "standard" RT integration

See code for details about dimensions etc.

Parameters
wsOut: The workspace
ppath_asp_abs_vecOut: Absorption vectors for absorption species
ppath_asp_ext_vecOut: Extinction matrices for absorption species
ppath_pnd_abs_vecOut: Absorption vectors for particles
ppath_pnd_ext_vecOut: Extinction matrices for particles
ppath_transmissionOut: Transmissions of each ppath step
total_transmissionOut: Total transmission of path
ppath_emissionOut: Emission source term at each ppath point
scat_dataOut: Extracted scattering data. Length of array affected by use_mean_scat_data.
abs_scalar_gas_agendaAs the WSV.
emission_agendaAs the WSV.
opt_prop_gas_agendaAs the WSV.
ppath_pPressure for each ppath point.
ppath_tTemperature for each ppath point.
ppath_vmrVMR values for each ppath point.
ppath_wind_uU-wind for each ppath point.
ppath_wind_vV-wind for each ppath point.
ppath_wind_wW-wind for each ppath point.
ppath_pndParticle number densities for each ppath point.
use_mean_scat_dataAs the WSV.
scat_data_rawAs the WSV.
stokes_dimAs the WSV.
f_gridAs the WSV.
atmosphere_dimAs the WSV.
emission_doFlag for calculation of emission. Should be set to 0 for pure transmission calculations.
Author
Patrick Eriksson
Date
2011-07-14

Definition at line 672 of file rte.cc.

References abs_scalar_gas_agendaExecute(), emission_agendaExecute(), ext2trans(), id_mat(), joker, Ppath::l_step, Ppath::los, mirror_los(), mult(), ConstVectorView::nelem(), Ppath::np, opt_prop_gas_agendaExecute(), opt_propCalc(), Tensor4::resize(), Tensor3::resize(), Matrix::resize(), and scat_data_monoCalc().

Referenced by iyBeerLambertStandardCloudbox(), and iyFOS().

◆ get_ppath_pnd()

void get_ppath_pnd ( Matrix ppath_pnd,
const Ppath ppath,
const Index atmosphere_dim,
const ArrayOfIndex cloudbox_limits,
ConstTensor4View  pnd_field 
)

get_ppath_pnd

Determines particle number densities for each propgataion path point.

The output variable is sized inside the function as [ particle type, propagation path point ].

Parameters
ppath_pndOut: PND for each ppath point.
ppathAs the WSV.
atmosphere_dimAs the WSV.
pnd_fieldAs the WSV.
Author
Patrick Eriksson
Date
2011-07-14

Definition at line 479 of file rte.cc.

References Ppath::gp_lat, Ppath::gp_lon, Ppath::gp_p, interp_atmfield_by_itw(), interp_cloudfield_gp2itw(), joker, ConstTensor4View::nbooks(), Ppath::np, and Matrix::resize().

Referenced by iyBeerLambertStandardCloudbox(), and iyFOS().

◆ get_ppath_rtvars()

void get_ppath_rtvars ( Workspace ws,
Tensor3 ppath_abs_scalar,
Matrix ppath_tau,
Vector total_tau,
Matrix ppath_emission,
const Agenda abs_scalar_gas_agenda,
const Agenda emission_agenda,
const Ppath ppath,
ConstVectorView  ppath_p,
ConstVectorView  ppath_t,
ConstMatrixView  ppath_vmr,
ConstVectorView  ppath_wind_u,
ConstVectorView  ppath_wind_v,
ConstVectorView  ppath_wind_w,
ConstVectorView  f_grid,
const Index atmosphere_dim,
const Index emission_do 
)

get_ppath_rtvars

Determines variables for each step of "standard" RT integration

The output variables are sized inside the function. The dimension order is [ frequency, absorption species, ppath point ]

Parameters
wsOut: The workspace
ppath_abs_sclarOut: Absorption coefficients at each ppath point
ppath_tauOut: Optical thickness of each ppath step
total_tauOut: Total optical thickness of path
ppath_emissionOut: Emission source term at each ppath point
abs_scalar_gas_agendaAs the WSV.
emission_agendaAs the WSV.
ppath_pPressure for each ppath point.
ppath_tTemperature for each ppath point.
ppath_vmrVMR values for each ppath point.
ppath_wind_uU-wind for each ppath point.
ppath_wind_vV-wind for each ppath point.
ppath_wind_wW-wind for each ppath point.
f_gridAs the WSV.
atmosphere_dimAs the WSV.
emission_doFlag for calculation of emission. Should be set to 0 for pure transmission calculations.
Author
Patrick Eriksson
Date
2009-10-06

Definition at line 531 of file rte.cc.

References abs_scalar_gas_agendaExecute(), DEG2RAD, emission_agendaExecute(), joker, Ppath::l_step, Ppath::los, ConstVectorView::nelem(), Ppath::np, ConstMatrixView::nrows(), PI, Vector::resize(), Tensor3::resize(), Matrix::resize(), and SPEED_OF_LIGHT.

Referenced by iyBeerLambertStandardClearsky(), iyEmissionStandardClearsky(), and iyEmissionStandardClearskyBasic().

◆ get_rowindex_for_mblock()

Range get_rowindex_for_mblock ( const Sparse sensor_response,
const Index imblock 
)

get_rowindex_for_mblock

Returns the "range" of y corresponding to a measurement block

Returns
The range.
Parameters
sensor_responseAs the WSV.
imblockIndex of the measurement block.
Author
Patrick Eriksson
Date
2009-10-16

Definition at line 861 of file rte.cc.

References Sparse::nrows().

Referenced by jacobianCalcAbsSpeciesPerturbations(), jacobianCalcFreqShiftAndStretchInterp(), jacobianCalcPointingZaInterp(), jacobianCalcPointingZaRecalc(), jacobianCalcPolyfit(), jacobianCalcTemperaturePerturbations(), and yCalc().

◆ iy_transmission_for_scalar_tau()

void iy_transmission_for_scalar_tau ( Tensor3 iy_transmission,
const Index stokes_dim,
ConstVectorView  tau 
)

iy_transmission_for_scalar_tau

Sets iy_transmission to match scalar optical thicknesses.

iy_transmission* is sized by the function.

Parameters
iy_transmissionOut: As the WSV.
stokes_dimAs the WSV.
tauVector with the optical thickness for each frequency.
Author
Patrick Eriksson
Date
2009-10-06

Definition at line 885 of file rte.cc.

References ConstVectorView::nelem(), and Tensor3::resize().

Referenced by iyBeerLambertStandardClearsky(), and iyEmissionStandardClearsky().

◆ iy_transmission_mult()

void iy_transmission_mult ( Tensor3 iy_trans_new,
ConstTensor3View  iy_transmission,
ConstTensor3View  trans 
)

iy_transmission_mult

Multiplicates iy_transmission with (vector) transmissions.

That is, a multiplication of iy_transmission with another variable having same structure and holding transmission values.

The "new path" is assumed to be further away from the sensor than the propagtion path already included in iy_transmission. That is, the operation can be written as:

Ttotal = Told * Tnew

where Told is the transmission corresponding to iy_transmission and Tnew corresponds to tau.

iy_trans_new* is sized by the function.

Parameters
iy_trans_newOut: Updated version of iy_transmission
iy_transmissionAs the WSV.
transA variable matching *iy_transmission.
Author
Patrick Eriksson
Date
2009-10-06

Definition at line 929 of file rte.cc.

References joker, mult(), ConstTensor3View::ncols(), ConstTensor3View::npages(), ConstTensor3View::nrows(), ns, and Tensor3::resize().

Referenced by get_iy_of_background(), iyBeerLambertStandardCloudbox(), and iyFOS().

◆ iy_transmission_mult_scalar_tau()

void iy_transmission_mult_scalar_tau ( Tensor3 iy_trans_new,
ConstTensor3View  iy_transmission,
ConstVectorView  tau 
)

iy_transmission_mult_scalar_tau

Multiplicates iy_transmission with scalar optical thicknesses.

The functions can incorporate the transmission of a clear-sky path. That is, the transmission can be described by a single value The transmission of this path is gives as the optical depth for each frequency.

The "new path" is assumed to be further away from the sensor than the propagtion path already included in iy_transmission. That is, the operation can be written as:

Ttotal = Told * Tnew

where Told is the transmission corresponding to iy_transmission and Tnew corresponds to tau.

iy_trans_new* is sized by the function.

Parameters
iy_trans_newOut: Updated version of iy_transmission
iy_transmissionAs the WSV.
tauVector with the optical thickness for each frequency.
Author
Patrick Eriksson
Date
2009-10-06

Definition at line 981 of file rte.cc.

References joker, ConstTensor3View::ncols(), ConstVectorView::nelem(), ConstTensor3View::npages(), and ConstTensor3View::nrows().

Referenced by iyBeerLambertStandardClearsky(), and iyEmissionStandardClearsky().

◆ mirror_los()

void mirror_los ( Vector los_mirrored,
ConstVectorView  los,
const Index atmosphere_dim 
)

mirror_los

Determines the backward direction for a given line-of-sight.

This function can be used to get the LOS to apply for extracting single scattering properties, if the propagation path LOS is given.

A viewing direction of aa=0 is assumed for 1D. This corresponds to positive za for 2D.

Parameters
los_mirroredOut: The line-of-sight for reversed direction.
losA line-of-sight
atmosphere_dimAs the WSV.
Author
Patrick Eriksson
Date
2011-07-15

Definition at line 1016 of file rte.cc.

References Vector::resize().

Referenced by get_ppath_cloudrtvars(), and iyFOS().

◆ rte_step_std()

void rte_step_std ( VectorView  stokes_vec,
MatrixView  trans_mat,
ConstMatrixView  ext_mat_av,
ConstVectorView  abs_vec_av,
ConstVectorView  sca_vec_av,
const Numeric l_step,
const Numeric rte_planck_value 
)

rte_step_std

Solves monochromatic VRTE for an atmospheric slab with constant conditions.

The function can be used for clearsky and cloudbox calculations.

The function is best explained by considering a homogenous layer. That is, the physical conditions inside the layer are constant. In reality they are not constant, so in practical all coefficients have to be averaged before calling this function. Total extinction and absorption inside the layer are described by ext_mat_av* and abs_vec_av respectively, the blackbdody radiation of the layer is given by rte_planck_value and the propagation path length through the layer is l_step.

There is an additional scattering source term in the VRTE, the scattering integral term. For this function a constant scattering term is assumed. The radiative transfer step is only a part the iterative solution of the scattering problem, for more information consider AUG. In the clearsky case this variable has to be set to 0.

When calling the function, the vector stokes_vec shall contain the Stokes vector for the incoming radiation. The function returns this vector, then containing the outgoing radiation on the other side of the layer.

The function performs the calculations differently depending on the conditions to improve the speed. There are three cases:

  1. Scalar absorption (stokes_dim = 1).
  2. The matrix ext_mat_gas is diagonal (unpolarised absorption).
  3. The total general case.
Parameters
stokes_vecInput/Output: A Stokes vector.
trans_matInput/Output: Transmission matrix of slab.
ext_mat_avInput: Averaged extinction matrix.
abs_vec_avInput: Averaged absorption vector.
sca_vec_avInput: averaged scattering vector.
l_stepInput: The length of the RTE step.
rte_planck_valueInput: Blackbody radiation.
Author
Claudia Emde and Patrick Eriksson,
Date
2002-11-22

Definition at line 1092 of file rte.cc.

References id_mat(), is_diagonal(), is_singular(), is_size(), lubacksub(), ludcmp(), matrix_exp(), mult(), ConstVectorView::nelem(), and q.

Referenced by cloud_ppath_update1D_planeparallel(), cloud_RT_no_background(), and iyFOS().

◆ surface_calc()

void surface_calc ( Matrix iy,
const Tensor3 I,
const Matrix surface_los,
const Tensor4 surface_rmatrix,
const Matrix surface_emission 
)

surface_calc

Weights together downwelling radiation and surface emission.

iy* must have correct size when function is called.

Parameters
iyIn/Out: Radiation matrix, amtching the WSV with the same name.
IInput: Downwelling radiation, with dimensions matching: (surface_los, f_grid, stokes_dim)
surface_losInput: As the WSV with the same name.
surface_rmatrixInput: As the WSV with the same name.
surface_emissionInput: As the WSV with the same name.
Author
Patrick Eriksson
Date
2005-04-07

Definition at line 1245 of file rte.cc.

References joker, mult(), ConstTensor3View::ncols(), ConstMatrixView::nrows(), and ConstTensor3View::nrows().

Referenced by get_iy_of_background().

◆ trans_step_std()

void trans_step_std ( VectorView  stokes_vec,
MatrixView  trans_mat,
ConstMatrixView  ext_mat_av,
const Numeric l_step 
)

trans_step_std

Solves monochromatic (vector) Beer-Lambert for one step

The function can be used for clearsky and cloudbox calculations.

(As rte_step_std, but without emission and scattering source term)

When calling the function, the vector stokes_vec shall contain the Stokes vector for the incoming radiation. The function returns this vector, then containing the outgoing radiation on the other side of the layer.

Transmission calculated by ext2trans.

Parameters
stokes_vecInput/Output: A Stokes vector.
trans_matInput/Output: Transmission matrix of slab.
ext_matInput: Averaged extinction matrix.
l_stepInput: The length of the RTE step.
Author
Claudia Emde and Patrick Eriksson,
Date
2010-10-15

Definition at line 1300 of file rte.cc.

References ext2trans(), and mult().

Variable Documentation

◆ BOLTZMAN_CONST

const Numeric BOLTZMAN_CONST
extern

◆ DEG2RAD

const Numeric DEG2RAD
extern

Referenced by get_ppath_rtvars().

◆ PI

const Numeric PI
extern

Referenced by get_ppath_rtvars().

◆ PLANCK_CONST

const Numeric PLANCK_CONST
extern

◆ RAD2DEG

const Numeric RAD2DEG
extern

◆ SPEED_OF_LIGHT

const Numeric SPEED_OF_LIGHT
extern