Standardised and rationalised the way in which units are written in function documentation

This commit is contained in:
Henry Weller
2019-06-20 10:54:14 +01:00
parent e599162b09
commit 96b69f6f88
188 changed files with 575 additions and 575 deletions

View File

@ -99,5 +99,5 @@
Info << constProp << " will be held constant." << nl
<< " p = " << p[0] << " [Pa]" << nl
<< " T = " << thermo.T()[0] << " [K] " << nl
<< " rho = " << rho[0] << " [kg/m3]" << nl
<< " rho = " << rho[0] << " [kg/m^3]" << nl
<< endl;

View File

@ -37,7 +37,7 @@ Description
where
\vartable
p | pressure [Pa]
\rho | density [kg/m3]
\rho | density [kg/m^3]
\endvartable

View File

@ -260,10 +260,10 @@ public:
//- Kinematic viscosity of mixture for patch [m^2/s]
virtual tmp<scalarField> nu(const label patchi) const;
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
virtual tmp<volScalarField> kappa() const;
//- Thermal diffusivity of mixture for patch [J/m/s/K]
//- Thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> kappa
(
const label patchi
@ -275,26 +275,26 @@ public:
//- Thermal diffusivity for energy of mixture for patch [kg/m/s]
virtual tmp<scalarField> alphahe(const label patchi) const;
//- Effective thermal diffusivity of mixture [J/m/s/K]
//- Effective thermal diffusivity of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField& alphat
) const;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
//- Effective thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
const label patchi
) const;
//- Effective thermal diffusivity of mixture [J/m/s/K]
//- Effective thermal diffusivity of mixture [W/m/K]
virtual tmp<volScalarField> alphaEff
(
const volScalarField& alphat
) const;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
//- Effective thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> alphaEff
(
const scalarField& alphat,

View File

@ -391,10 +391,10 @@ public:
//- Kinematic viscosity of mixture for patch [m^2/s]
virtual tmp<scalarField> nu(const label patchi) const;
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
virtual tmp<volScalarField> kappa() const;
//- Thermal diffusivity of mixture for patch [J/m/s/K]
//- Thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> kappa
(
const label patchi
@ -406,26 +406,26 @@ public:
//- Thermal diffusivity for energy of mixture for patch [kg/m/s]
virtual tmp<scalarField> alphahe(const label patchi) const;
//- Effective thermal diffusivity of mixture [J/m/s/K]
//- Effective thermal diffusivity of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField& alphat
) const;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
//- Effective thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
const label patchi
) const;
//- Effective thermal diffusivity of mixture [J/m/s/K]
//- Effective thermal diffusivity of mixture [W/m/K]
virtual tmp<volScalarField> alphaEff
(
const volScalarField& alphat
) const;
//- Effective thermal diffusivity of mixture for patch [J/m/s/K]
//- Effective thermal diffusivity of mixture for patch [W/m/K]
virtual tmp<scalarField> alphaEff
(
const scalarField& alphat,

View File

@ -155,7 +155,7 @@ alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::calcAlphat
scalarField Tp(Tw.patchInternalField());
// Heat flux [W/m2] - lagging alphatw
// Heat flux [W/m^2] - lagging alphatw
const scalarField qDot
(
(prevAlphat + alphaw)*hew.snGrad()

View File

@ -289,13 +289,13 @@ public:
return dDep_;
}
//- Return the quenching surface heat flux [W/m2]
//- Return the quenching surface heat flux [W/m^2]
const scalarField& qq() const
{
return qq_;
}
//- Return the evaporation surface heat flux [W/m2]
//- Return the evaporation surface heat flux [W/m^2]
tmp<scalarField> qe() const
{
return mDotL_/AbyV_;

View File

@ -61,7 +61,7 @@ class fixedMultiPhaseHeatFluxFvPatchScalarField
{
// Private Data
//- Heat power [W] or flux [W/m2]
//- Heat power [W] or flux [W/m^2]
scalarField q_;
//- Relaxation factor

View File

@ -222,7 +222,7 @@ public:
virtual tmp<volScalarField> nuEff() const;
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
using BasePhaseModel::kappaEff;
//- Return the effective thermal conductivity

View File

@ -186,7 +186,7 @@ public:
virtual tmp<volScalarField> nuEff() const;
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
using BasePhaseModel::kappaEff;
//- Return the effective thermal conductivity

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -118,11 +118,11 @@ public:
//- Thermal diffusivity for enthalpy of mixture for patch [kg/m/s]
virtual tmp<scalarField> alpha(const label patchi) const;
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
virtual tmp<volScalarField> kappa() const;
//- Thermal diffusivity for temperature of mixture
// for patch [J/m/s/K]
// for patch [W/m/K]
virtual tmp<scalarField> kappa(const label patchi) const;
//- Thermal diffusivity for energy of mixture [kg/m/s]
@ -135,18 +135,18 @@ public:
// Turbulence
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
using BasePhaseModel::kappaEff;
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField& alphat
) const;
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,

View File

@ -333,11 +333,11 @@ public:
//- Thermal diffusivity for enthalpy of mixture for patch [kg/m/s]
virtual tmp<scalarField> alpha(const label patchi) const = 0;
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
virtual tmp<volScalarField> kappa() const = 0;
//- Thermal diffusivity for temperature of mixture
// for patch [J/m/s/K]
// for patch [W/m/K]
virtual tmp<scalarField> kappa(const label patchi) const = 0;
//- Thermal diffusivity for energy of mixture [kg/m/s]
@ -347,14 +347,14 @@ public:
virtual tmp<scalarField> alphahe(const label patchi) const = 0;
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField& alphat
) const = 0;
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
@ -391,11 +391,11 @@ public:
virtual tmp<volScalarField> nuEff() const = 0;
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff() const = 0;
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff(const label patchi) const = 0;
//- Effective thermal turbulent diffusivity of mixture [kg/m/s]

View File

@ -63,11 +63,11 @@ Description
\f]
\vartable
\rho_c | Density of continuous phase [kg/m3]
\sigma | Surface tension [N/m]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s3]
d_i | Diameter of daughter bubble i [m]
d_j | Diameter of mother bubble j [m]
\rho_c | Density of continuous phase [kg/m^3]
\sigma | Surface tension [N/m]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s^3]
d_i | Diameter of daughter bubble i [m]
d_j | Diameter of mother bubble j [m]
\endvartable
References:

View File

@ -87,15 +87,15 @@ Description
\vartable
\alpha_c | Void fraction of continuous phase [-]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s3]
d_j | Diameter of mother bubble j [m3]
v_i | Volume of daughter bubble i [m3]
v_j | Volume of mother bubble j [m3]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s^3]
d_j | Diameter of mother bubble j [m^3]
v_i | Volume of daughter bubble i [m^3]
v_j | Volume of mother bubble j [m^3]
\xi | Integration variable [-]
\xi_{min} | Lower bound of integral [-]
c_f | Increase coefficient of surface area [-]
\sigma | Surface tension [N/m]
\rho_c | Density of continuous phase [kg/m3]
\rho_c | Density of continuous phase [kg/m^3]
\eta | Kolmogorov length scale [m]
\Gamma(a,z) | Upper incomplete gamma function
Q(a,z) | Regularized upper incomplete gamma function

View File

@ -45,10 +45,10 @@ Description
\vartable
\sigma | Surface tension [N/m]
v_i | Volume of mother bubble i [m]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s3]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s^3]
\mu_c | Molecular dynamic viscosity of liquid phase [Pa s]
\rho_c | Density of continuous phase [kg/m3]
\rho_d | Density of disperse phase [kg/m3]
\rho_c | Density of continuous phase [kg/m^3]
\rho_d | Density of disperse phase [kg/m^3]
\endvartable
References:

View File

@ -45,12 +45,12 @@ Description
\vartable
\sigma | Surface tension [N/m]
v_i | Volume of droplet i [m3]
v_j | Volume of droplet j [m3]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s3]
v_i | Volume of droplet i [m^3]
v_j | Volume of droplet j [m^3]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s^3]
\alpha_d | Total void fraction of disperse phase [-]
\mu_c | Molecular dynamic viscosity of liquid phase [Pa s]
\rho_c | Density of continuous phase [kg/m3]
\rho_c | Density of continuous phase [kg/m^3]
\endvartable
References:

View File

@ -54,7 +54,7 @@ Description
\vartable
d_i | Diameter of bubble i [m]
d_j | Diameter of bubble j [m]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s3]
\epsilon_c | Turbulent dissipation rate of continuous phase [m2/s^3]
\alpha | Total void fraction of the bubbles [-]
\alpha_{max} | Maximum packing density of the bubbles [-]
u_{crit} | Critical velocity for coalescence [m/s]

View File

@ -58,13 +58,13 @@ Description
d_j | Diameter of bubble j [m]
u_{ij} | Mean approach velocity [m/s]
\xi_{ij} | Bubble size ratio [-]
\rho_d | Density of dispersed phase [kg/m3]
\rho_c | Density of continuous phase [kg/m3]
\rho_d | Density of dispersed phase [kg/m^3]
\rho_c | Density of continuous phase [kg/m^3]
\sigma | Surface tension [N/m]
C_{vm} | Virtual mass coefficient [-]
C_1 | Coefficient [-]
\beta | Coefficient [-]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s3]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s^3]
\endvartable
Reference:

View File

@ -83,21 +83,21 @@ Description
is currently neglected.
\vartable
\theta_{ij}^{T} | Turbulent collision rate [m3/s]
\theta_{ij}^{B} | Buoyancy-driven collision rate [m3/s]
\theta_{ij}^{LS} | Laminar shear collision rate [m3/s]
\lambda_{ij} | Coalescence efficiency [-]
r_{ij} | Equivalent radius [m]
\rho_c | Density of continuous phase [kg/m3]
\sigma | Surface tension [N/m]
h_0 | Initial film thickness [m]
h_f | Critical film thickness [m]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s3]
d_i | Diameter of bubble i [m]
d_j | Diameter of bubble j [m]
u_{ri} | Rise velocity of bubble i [m/s]
S_{ij} | Collision cross sectional area [m2]
g | Gravitational constant [m/s2]
\theta_{ij}^{T} | Turbulent collision rate [m3/s]
\theta_{ij}^{B} | Buoyancy-driven collision rate [m3/s]
\theta_{ij}^{LS}| Laminar shear collision rate [m3/s]
\lambda_{ij} | Coalescence efficiency [-]
r_{ij} | Equivalent radius [m]
\rho_c | Density of continuous phase [kg/m^3]
\sigma | Surface tension [N/m]
h_0 | Initial film thickness [m]
h_f | Critical film thickness [m]
\epsilon_c | Continuous phase turbulent dissipation rate [m2/s^3]
d_i | Diameter of bubble i [m]
d_j | Diameter of bubble j [m]
u_{ri} | Rise velocity of bubble i [m/s]
S_{ij} | Collision cross sectional area [m^2]
g | Gravitational constant [m/s^2]
\endvartable
Reference:

View File

@ -208,14 +208,14 @@ public:
return thermo_->alpha(patchi);
}
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
tmp<scalarField> kappa(const label patchi) const
{
return thermo_->kappa(patchi);
}
//- Thermal diffusivity for temperature of mixture
// for patch [J/m/s/K]
// for patch [W/m/K]
tmp<volScalarField> kappa() const
{
return thermo_->kappa();
@ -234,7 +234,7 @@ public:
}
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
tmp<volScalarField> kappaEff
(
const volScalarField& alphat
@ -244,7 +244,7 @@ public:
}
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
tmp<scalarField> kappaEff
(
const scalarField& alphat,

View File

@ -34,12 +34,12 @@ mixture
}
thermodynamics
{
Cp 1005; // [J/(kg K)]
Cp 1005; // [J/kg/K]
Hf 0;
}
transport
{
mu 1.8e-05; // [kg/(m s)]
mu 1.8e-05; // [kg/m/s]
Pr 0.7;
}
}

View File

@ -35,18 +35,18 @@ mixture
transport
{
kappa 240; // [W/(m K)]
kappa 240; // [W/m/K]
}
thermodynamics
{
Hf 0;
Cp 896; // [J/(kg K)]
Cp 896; // [J/kg/K]
}
equationOfState
{
rho 2712; // [kg/m3]
rho 2712; // [kg/m^3]
}
}

View File

@ -35,18 +35,18 @@ mixture
transport
{
kappa 380; // [W/(m K)]
kappa 380; // [W/m/K]
}
thermodynamics
{
Hf 0;
Cp 385; // [J/(kg K)]
Cp 385; // [J/kg/K]
}
equationOfState
{
rho 8940; // [kg/m3]
rho 8940; // [kg/m^3]
}
}

View File

@ -34,17 +34,17 @@ mixture
}
equationOfState
{
R 3000; // [J/(kg K)]
R 3000; // [J/kg/K]
rho0 1027; // [kg/m^3]
}
thermodynamics
{
Cp 4181; // [J/(kg K)] at T = 293 K
Cp 4181; // [J/kg/K] at T = 293 K
Hf 0;
}
transport
{
mu 1.0e-03; // [kg/(m s)]
mu 1.0e-03; // [kg/m/s]
Pr 0.7;
}
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -54,16 +54,16 @@ namespace physicoChemical
//- Faraday constant: default SI units: [C/mol]
extern const dimensionedScalar F;
//- Stefan-Boltzmann constant: default SI units: [W/m2/K4]
//- Stefan-Boltzmann constant: default SI units: [W/m^2/K^4]
extern const dimensionedScalar sigma;
//- Wien displacement law constant: default SI units: [m.K]
//- Wien displacement law constant: default SI units: [m K]
extern const dimensionedScalar b;
//- First radiation constant: default SI units: [W/m2]
//- First radiation constant: default SI units: [W/m^2]
extern const dimensionedScalar c1;
//- Second radiation constant: default SI units: [m.K]
//- Second radiation constant: default SI units: [m K]
extern const dimensionedScalar c2;
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -43,7 +43,7 @@ namespace thermodynamic
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
//- Universal gas constant (default in [J/(kmol K)])
//- Universal gas constant (default in [J/kmol/K])
extern const scalar RR;
//- Standard pressure (default in [Pa])

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -115,14 +115,14 @@ public:
}
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff() const
{
return this->transport_.kappaEff(alphat());
}
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff(const label patchi) const
{
return this->transport_.kappaEff(alphat(patchi), patchi);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -119,14 +119,14 @@ public:
return this->transport_.alpha(patchi);
}
//- Thermal diffusivity for temperature of mixture [J/m/s/K]
//- Thermal diffusivity for temperature of mixture [W/m/K]
virtual tmp<volScalarField> kappa() const
{
return this->transport_.kappa();
}
//- Thermal diffusivity for temperature of mixture
// for patch [J/m/s/K]
// for patch [W/m/K]
virtual tmp<scalarField> kappa(const label patchi) const
{
return this->transport_.kappa(patchi);
@ -139,14 +139,14 @@ public:
virtual tmp<scalarField> alphat(const label patchi) const;
//- Effective thermal turbulent diffusivity for temperature
// of mixture [J/m/s/K]
// of mixture [W/m/K]
virtual tmp<volScalarField> kappaEff() const
{
return kappa();
}
//- Effective thermal turbulent diffusivity for temperature
// of mixture for patch [J/m/s/K]
// of mixture for patch [W/m/K]
virtual tmp<scalarField> kappaEff(const label patchi) const
{
return kappa(patchi);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -123,7 +123,7 @@ void Foam::externalCoupledTemperatureMixedFvPatchScalarField::transferData
const label patchi = patch().index();
// heat flux [W/m2]
// heat flux [W/m^2]
scalarField qDot(this->patch().size(), 0.0);
typedef compressible::turbulenceModel cmpTurbModelType;
@ -171,7 +171,7 @@ void Foam::externalCoupledTemperatureMixedFvPatchScalarField::transferData
// near wall cell temperature [K]
const scalarField Tc(patchInternalField());
// heat transfer coefficient [W/m2/K]
// heat transfer coefficient [W/m^2/K]
const scalarField htc(qDot/(Tp - Tc + rootVSmall));
if (Pstream::parRun())

View File

@ -141,10 +141,10 @@ private:
//- Heat power [W]
scalar Q_;
//- Heat flux [W/m2]
//- Heat flux [W/m^2]
scalarField q_;
//- Heat transfer coefficient [W/m2K]
//- Heat transfer coefficient [W/m^2K]
scalarField h_;
//- Ambient temperature [K]

View File

@ -43,7 +43,7 @@ Usage
samplePatch <slavePatchName>;
thickness uniform 0.005; // thickness [m]
Qs uniform 100; // heat flux [W/m2]
Qs uniform 100; // heat flux [W/m^2]
qr none;
qrRelaxation 1;
@ -120,7 +120,7 @@ class thermalBaffle1DFvPatchScalarField
//- Baffle thickness [m]
mutable scalarField thickness_;
//- Superficial heat source [W/m2]
//- Superficial heat source [W/m^2]
mutable scalarField Qs_;
//- Solid dictionary

View File

@ -196,7 +196,7 @@ void alphatJayatillekeWallFunctionFvPatchScalarField::updateCoeffs()
const fvPatchScalarField& hew =
turbModel.transport().he().boundaryField()[patchi];
// Heat flux [W/m2] - lagging alphatw
// Heat flux [W/m^2] - lagging alphatw
const scalarField qDot
(
turbModel.transport().alphaEff(alphatw, patchi)*hew.snGrad()

View File

@ -38,7 +38,7 @@ Description
\vartable
p | pressure [Pa]
\rho | density [kg/m3]
\rho | density [kg/m^3]
\mu | laminar viscosity [Pa s]
D | Darcy coefficient
I | inertial coefficient

View File

@ -182,7 +182,7 @@ public:
//- Fuel consumption rate matrix.
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -99,7 +99,7 @@ public:
//- Fuel consumption rate matrix.
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -141,7 +141,7 @@ public:
//- Fuel consumption rate matrix, i.e. source term for fuel equation
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const = 0;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const = 0;
//- Update properties from given dictionary

View File

@ -101,7 +101,7 @@ public:
//- Fuel consumption rate matrix.
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -86,7 +86,7 @@ public:
//- Fuel consumption rate matrix
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -94,7 +94,7 @@ public:
//- Fuel consumption rate matrix
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -113,7 +113,7 @@ public:
//- Fuel consumption rate matrix.
virtual tmp<fvScalarMatrix> R(volScalarField& Y) const;
//- Heat release rate [kg/m/s3]
//- Heat release rate [kg/m/s^3]
virtual tmp<volScalarField> Qdot() const;
//- Update properties from given dictionary

View File

@ -33,7 +33,7 @@ Description
where
\vartable
d | Darcy coefficient [1/m2]
d | Darcy coefficient [1/m^2]
f | Forchheimer coefficient [1/m]
\endvartable
@ -72,13 +72,13 @@ class DarcyForchheimer
{
// Private Data
//- Darcy coeffient XYZ components (user-supplied) [1/m2]
//- Darcy coeffient XYZ components (user-supplied) [1/m^2]
dimensionedVector dXYZ_;
//- Forchheimer coeffient XYZ components (user-supplied) [1/m]
dimensionedVector fXYZ_;
//- Darcy coefficient - converted from dXYZ [1/m2]
//- Darcy coefficient - converted from dXYZ [1/m^2]
List<tensorField> D_;
//- Forchheimer coefficient - converted from fXYZ [1/m]

View File

@ -35,8 +35,8 @@ Description
where
\vartable
\rho | density [kg/m3]
\rho_{l,sat} | saturation liquid density [kg/m3]
\rho | density [kg/m^3]
\rho_{l,sat} | saturation liquid density [kg/m^3]
\psi_l | liquid compressibility
p | pressure [Pa]
p_{sat} | saturation pressure [Pa]

View File

@ -40,7 +40,7 @@ Description
U_c | velocity in cells adjacent to the patch [m/s]
n | patch normal vectors
\phi_p | flux at the patch [m3/s or kg/s]
S_f | patch face area vectors [m2]
S_f | patch face area vectors [m^2]
\endvartable
where

View File

@ -38,7 +38,7 @@ Description
p_{ref} | reference pressure [Pa]
x_{ref} | reference point in Cartesian co-ordinates
\rho | density (assumed uniform)
g | acceleration due to gravity [m/s2]
g | acceleration due to gravity [m/s^2]
\endtable
The values are assigned according to the phase-fraction field:

View File

@ -37,15 +37,15 @@ Description
Usage
\table
Property | Description | Required | Default value
Ap | syringe piston area [m2] | yes |
Ap | syringe piston area [m^2] | yes |
Sp | syringe piston speed [m/s] | yes |
VsI | initial syringe volume [m3] | yes |
VsI | initial syringe volume [m^3] | yes |
tas | start of piston acceleration [s] | yes |
tae | end of piston acceleration [s] | yes |
tds | start of piston deceleration [s] | yes |
tde | end of piston deceleration [s] | yes |
psI | initial syringe pressure [Pa] | yes |
psi | gas compressibility [m2/s2] | yes |
psi | gas compressibility [m2/s^2] | yes |
ams | added (or removed) gas mass [kg] | yes |
\endtable

View File

@ -34,8 +34,8 @@ Description
\f]
where
\vartable
p_p | incompressible pressure at patch [m2/s2]
p_0 | incompressible total pressure [m2/s2]
p_p | incompressible pressure at patch [m2/s^2]
p_0 | incompressible total pressure [m2/s^2]
U | velocity
\endvartable
@ -47,7 +47,7 @@ Description
\vartable
p_p | pressure at patch [Pa]
p_0 | total pressure [Pa]
\rho | density [kg/m3]
\rho | density [kg/m^3]
U | velocity
\endvartable
@ -71,7 +71,7 @@ Description
p_p | pressure at patch [Pa]
p_0 | total pressure [Pa]
\gamma | ratio of specific heats (Cp/Cv)
\psi | compressibility [m2/s2]
\psi | compressibility [m2/s^2]
G | coefficient given by \f$\frac{\gamma}{1-\gamma}\f$
\endvartable

View File

@ -38,13 +38,13 @@ Description
p_{ref} | Reference pressure [Pa]
x_{ref} | Reference point in Cartesian co-ordinates
\rho_{ref} | Density (assumed uniform)
g | Acceleration due to gravity [m/s2]
g | Acceleration due to gravity [m/s^2]
\endtable
Usage
\table
Property | Description | Required | Default value
rhoRef | Uniform density [kg/m3] | yes |
rhoRef | Uniform density [kg/m^3] | yes |
pRef | Reference pressure [Pa] | yes |
pRefPoint | Reference pressure location | no | hRef
value | Initial value | no | pRef

View File

@ -33,8 +33,8 @@ Description
\f]
\vartable
\rho | density [kg/m3]
g | acceleration due to gravity [m/s2]
\rho | density [kg/m^3]
g | acceleration due to gravity [m/s^2]
\zeta | wave amplitude [m]
\endvartable

View File

@ -47,12 +47,12 @@ Description
where
\vartable
\rho | Density [kg/m3]
\rho | Density [kg/m^3]
U | Velocity [m/s]
\rho_{\inf} | Freestream density [kg/m3]
\rho_{\inf} | Freestream density [kg/m^3]
p_{\inf} | Freestream pressure [Pa]
U_{\inf} | Freestream velocity [m/s]
p_k | Kinematic pressure (p/rho)[m2/s2]
p_k | Kinematic pressure (p/rho)[m2/s^2]
p | Pressure [Pa]
p_0 | Total pressure [Pa]
p_{ref} | Reference pressure level [Pa]

View File

@ -53,7 +53,7 @@ Description
where:
\vartable
Q_c | source for cell
V_c | volume of the cell [m3]
V_c | volume of the cell [m^3]
U_c | local cell velocity [m/s]
T_c | local call temperature [K]
T_{ref} | min or max(T) in cell zone depending on the sign of Q_t [K]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -190,7 +190,7 @@ protected:
//- Inverse rotation tensor for flap angle
List<tensor> invR_;
//- Area [m2]
//- Area [m^2]
List<scalar> area_;
//- Rotor local cylindrical co-ordinate system (r, theta, z)

View File

@ -25,7 +25,7 @@ Class
Foam::fv::constantHeatTransfer
Description
Constant heat transfer model. htcConst [W/m2/K] and area/volume [1/m]
Constant heat transfer model. htcConst [W/m^2/K] and area/volume [1/m]
must be provided.
\*---------------------------------------------------------------------------*/
@ -53,7 +53,7 @@ class constantHeatTransfer
{
// Private Data
//- Constant heat transfer coefficient [W/m2/K]
//- Constant heat transfer coefficient [W/m^2/K]
autoPtr<volScalarField> htcConst_;
//- Area per unit volume of heat exchanger [1/m]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -72,7 +72,7 @@ protected:
//- Time index - used for updating htc
label timeIndex_;
//- Heat transfer coefficient [W/m2/k] times area/volume [1/m]
//- Heat transfer coefficient [W/m^2/k] times area/volume [1/m]
volScalarField htc_;
//- Flag to activate semi-implicit coupling

View File

@ -79,7 +79,7 @@ public:
//- Sensible enthalpy transfer [J/kg]
inline tmp<volScalarField::Internal> hsTrans() const;
//- Return sensible enthalpy source term [J/kg/m3/s]
//- Return sensible enthalpy source term [J/kg/m^3/s]
inline tmp<fvScalarMatrix> Sh(volScalarField& hs) const;
@ -90,7 +90,7 @@ public:
volScalarField& Yi
) const;
//- Return total mass transfer [kg/m3]
//- Return total mass transfer [kg/m^3]
inline tmp<volScalarField::Internal> rhoTrans() const;
//- Return tmp total mass source for carrier phase
@ -104,7 +104,7 @@ public:
const label i
) const;
//- Return total mass source term [kg/m3/s]
//- Return total mass source term [kg/m^3/s]
inline tmp<fvScalarMatrix> Srho(volScalarField& rho) const;
};

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -174,7 +174,7 @@ Foam::scalar Foam::COxidationHurtMitchell<CloudType>::calculate
// Kinetic rate of char oxidation [g/(cm^2.s.atm^0.5)]
const scalar Rk = A*exp(-E/(RRcal*T));
// Molar reaction rate per unit surface area [kmol/(m^2.s)]
// Molar reaction rate per unit surface area [kmol/m^2/s]
const scalar qCsLim = mass*Ychar/(WC_*Ap*dt);
const scalar qCs = min(convSI*Rk*Foam::sqrt(ppO2/101325.0), qCsLim);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2014-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -157,7 +157,7 @@ Foam::scalar Foam::COxidationIntrinsicRate<CloudType>::calculate
// Diffusion rate coefficient [m2/s]
const scalar D0 = C1_/d*pow(0.5*(T + Tc), 0.75);
// Apparent density of pyrolysis char [kg/m3]
// Apparent density of pyrolysis char [kg/m^3]
const scalar rhop = 6.0*mass/(constant::mathematical::pi*pow3(d));
// Knusden diffusion coefficient [m2/s]
@ -185,7 +185,7 @@ Foam::scalar Foam::COxidationIntrinsicRate<CloudType>::calculate
// Chemical rate [kmol/m2/s]
const scalar R = eta*d/6.0*rhop*Ag_*ki;
// Particle surface area [m2]
// Particle surface area [m^2]
const scalar Ap = constant::mathematical::pi*sqr(d);
// Change in C mass [kg]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -175,7 +175,7 @@ Foam::scalar Foam::COxidationMurphyShaddix<CloudType>::calculate
<< endl;
}
// Molar reaction rate per unit surface area [kmol/(m^2.s)]
// Molar reaction rate per unit surface area [kmol/m^2/s]
scalar qCsOld = 0;
scalar qCs = 1;

View File

@ -172,7 +172,7 @@ protected:
// References to the carrier gas fields
//- Density [kg/m3]
//- Density [kg/m^3]
const volScalarField& rho_;
//- Velocity [m/s]

View File

@ -256,7 +256,7 @@ public:
// - fully explicit
inline tmp<volScalarField::Internal> Srho() const;
//- Return total mass source term [kg/m3/s]
//- Return total mass source term [kg/m^3/s]
inline tmp<fvScalarMatrix> Srho(volScalarField& rho) const;

View File

@ -256,10 +256,10 @@ public:
//- Radiation flag
inline bool radiation() const;
//- Radiation sum of parcel projected areas [m2]
//- Radiation sum of parcel projected areas [m^2]
inline volScalarField::Internal& radAreaP();
//- Radiation sum of parcel projected areas [m2]
//- Radiation sum of parcel projected areas [m^2]
inline const volScalarField::Internal&
radAreaP() const;
@ -295,7 +295,7 @@ public:
inline const volScalarField::Internal&
hsCoeff() const;
//- Return sensible enthalpy source term [J/kg/m3/s]
//- Return sensible enthalpy source term [J/kg/m^3/s]
inline tmp<fvScalarMatrix> Sh(volScalarField& hs) const;

View File

@ -88,7 +88,7 @@ public:
// Private Data
//- Young's modulus [N/m2]
//- Young's modulus [N/m^2]
demandDrivenEntry<scalar> youngsModulus_;
//- Poisson's ratio

View File

@ -108,10 +108,10 @@ public:
// of parcels issued by this cloud
demandDrivenEntry<label> parcelTypeId_;
//- Minimum density [kg/m3]
//- Minimum density [kg/m^3]
demandDrivenEntry<scalar> rhoMin_;
//- Particle density [kg/m3] (constant)
//- Particle density [kg/m^3] (constant)
demandDrivenEntry<scalar> rho0_;
//- Minimum parcel mass [kg]
@ -183,7 +183,7 @@ public:
// Cached continuous phase properties
//- Density [kg/m3]
//- Density [kg/m^3]
scalar rhoc_;
//- Velocity [m/s]
@ -281,7 +281,7 @@ protected:
//- Velocity of Parcel [m/s]
vector U_;
//- Density [kg/m3]
//- Density [kg/m^3]
scalar rho_;
//- Age [s]

View File

@ -92,7 +92,7 @@ public:
//- Maximum temperature [K]
demandDrivenEntry<scalar> TMax_;
//- Particle specific heat capacity [J/(kg.K)]
//- Particle specific heat capacity [J/kg/K]
demandDrivenEntry<scalar> Cp0_;
//- Particle emissivity [] (radiation)
@ -133,7 +133,7 @@ public:
inline void setTMax(const scalar TMax);
//- Return const access to the particle specific heat capacity
// [J/(kg.K)]
// [J/kg/K]
inline scalar Cp0() const;
//- Return const access to the particle emissivity []
@ -183,7 +183,7 @@ public:
//- Temperature [K]
scalar Tc_;
//- Specific heat capacity [J/(kg.K)]
//- Specific heat capacity [J/kg/K]
scalar Cpc_;
@ -249,7 +249,7 @@ protected:
//- Temperature [K]
scalar T_;
//- Specific heat capacity [J/(kg.K)]
//- Specific heat capacity [J/kg/K]
scalar Cp_;

View File

@ -42,7 +42,7 @@ Description
x, y, z | global cartesian co-ordinates [m]
u, v, w | global cartesian velocity components [m/s]
d | diameter [m]
rho | density [kg/m3]
rho | density [kg/m^3]
mDot | mass flow rate [kg/s]
\endplaintable

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -80,7 +80,7 @@ protected:
//- Diameter [m]
scalar d_;
//- Density [kg/m3]
//- Density [kg/m^3]
scalar rho_;
//- Mass flow rate [kg/s]

View File

@ -82,7 +82,7 @@ class PatchFlowRateInjection
//- Concentration profile of particle volume to carrier volume [-]
const TimeFunction1<scalar> concentration_;
//- Parcels to introduce per unit volume flow rate m3 [n/m3]
//- Parcels to introduce per unit volume flow rate m3 [n/m^3]
const scalar parcelConcentration_;
//- Parcel size distribution model

View File

@ -85,7 +85,7 @@ public:
// Access
//- Return const access to the explicit contribution [kg.m/s2]
//- Return const access to the explicit contribution [kg m/s^2]
inline const vector& Su() const;
//- Return const access to the implicit coefficient [kg/s]

View File

@ -39,7 +39,7 @@ Description
x, y, z = global cartesian co-ordinates [m]
u, v, w = global cartesian velocity components [m/s]
d = diameter [m]
rho = density [kg/m3]
rho = density [kg/m^3]
mDot = mass flow rate [kg/s]
T = temperature [K]
cp = specific heat capacity [J/kg/K]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -193,10 +193,10 @@ void Foam::LiquidEvaporation<CloudType>::calculate
// mass transfer coefficient [m/s]
const scalar kc = Sh*Dab/(d + rootVSmall);
// vapour concentration at surface [kmol/m3] at film temperature
// vapour concentration at surface [kmol/m^3] at film temperature
const scalar Cs = pSat/(RR*Ts);
// vapour concentration in bulk gas [kmol/m3] at film temperature
// vapour concentration in bulk gas [kmol/m^3] at film temperature
const scalar Cinf = Xc[gid]*pc/(RR*Ts);
// molar flux of vapour [kmol/m2/s]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -167,7 +167,7 @@ void Foam::LiquidEvaporationBoil<CloudType>::calculate
// droplet surface pressure assumed to surface vapour pressure
scalar ps = liquids_.pv(pc, Ts, X);
// vapour density at droplet surface [kg/m3]
// vapour density at droplet surface [kg/m^3]
scalar rhos = ps*liquids_.W(X)/(RR*Ts);
// construct carrier phase species volume fractions for cell, celli

View File

@ -39,7 +39,7 @@ Description
x, y, z = global cartesian co-ordinates [m]
u, v, w = global cartesian velocity components [m/s]
d = diameter [m]
rho = density [kg/m3]
rho = density [kg/m^3]
mDot = mass flow rate [kg/s]
T = temperature [K]
cp = specific heat capacity [J/kg/K]

View File

@ -39,7 +39,7 @@ Description
x, y, z = global cartesian co-ordinates [m]
u, v, w = global cartesian velocity components [m/s]
d = diameter [m]
rho = density [kg/m3]
rho = density [kg/m^3]
mDot = mass flow rate [kg/s]
T = temperature [K]
cp = specific heat capacity [J/kg/K]

View File

@ -66,7 +66,7 @@ class constant
//- Emission coefficient / [1/m]
dimensionedScalar e_;
//- Emission contribution / [kg/(m s^3)]
//- Emission contribution / [kg/m/s^3]
dimensionedScalar E_;

View File

@ -61,10 +61,10 @@ class P1
{
// Private Data
//- Incident radiation / [W/m2]
//- Incident radiation / [W/m^2]
volScalarField G_;
//- Total radiative heat flux [W/m2]
//- Total radiative heat flux [W/m^2]
volScalarField qr_;
//- Absorption coefficient

View File

@ -88,16 +88,16 @@ class fvDOM
// Private Data
//- Incident radiation [W/m2]
//- Incident radiation [W/m^2]
volScalarField G_;
//- Total radiative heat flux [W/m2]
//- Total radiative heat flux [W/m^2]
volScalarField qr_;
//- Emitted radiative heat flux [W/m2]
//- Emitted radiative heat flux [W/m^2]
volScalarField qem_;
//- Incidet radiative heat flux [W/m2]
//- Incidet radiative heat flux [W/m^2]
volScalarField qin_;
//- Total absorption coefficient [1/m]

View File

@ -76,7 +76,7 @@ private:
//- Black body
const blackBodyEmission& blackBody_;
//- Total radiative intensity / [W/m2]
//- Total radiative intensity / [W/m^2]
volScalarField I_;
//- Total radiative heat flux on boundary

View File

@ -79,7 +79,7 @@ class viewFactor
//- Coarse mesh
singleCellFvMesh coarseMesh_;
//- Net radiative heat flux [W/m2]
//- Net radiative heat flux [W/m^2]
volScalarField qr_;
//- View factor matrix

View File

@ -123,7 +123,7 @@ public:
// Fields
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual const volScalarField& rho() const;
//- Return const temperature [K]
@ -138,7 +138,7 @@ public:
//- Return the region thermal conductivity [W/m/k]
virtual tmp<volScalarField> kappa() const;
//- Return the total gas mass flux to primary region [kg/m2/s]
//- Return the total gas mass flux to primary region [kg/m^2/s]
virtual const surfaceScalarField& phiGas() const;

View File

@ -186,7 +186,7 @@ public:
// Fields
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual const volScalarField& rho() const = 0;
//- Return const temperature [K]
@ -201,7 +201,7 @@ public:
//- Return the region thermal conductivity [W/m/k]
virtual tmp<volScalarField> kappa() const = 0;
//- Return the total gas mass flux to primary region [kg/m2/s]
//- Return the total gas mass flux to primary region [kg/m^2/s]
virtual const surfaceScalarField& phiGas() const = 0;

View File

@ -221,7 +221,7 @@ void reactingOneDim::updateMesh(const scalarField& mass0)
const scalarField newV(mass0/rho_);
Info<< "Initial/final volumes = " << gSum(regionMesh().V()) << ", "
<< gSum(newV) << " [m3]" << endl;
<< gSum(newV) << " [m^3]" << endl;
// move the mesh
const labelList moveMap = moveMesh(regionMesh().V() - newV, minimumDelta_);

View File

@ -85,7 +85,7 @@ protected:
// Reference to solid thermo properties
//- Density [kg/m3]
//- Density [kg/m^3]
volScalarField rho_;
//- List of solid components
@ -109,23 +109,23 @@ protected:
// Fields
//- Total gas mass flux to the primary region [kg/m2/s]
//- Total gas mass flux to the primary region [kg/m^2/s]
surfaceScalarField phiGas_;
//- Sensible enthalpy gas flux [J/m2/s]
volScalarField phiHsGas_;
//- Heat release rate [J/s/m3]
//- Heat release rate [J/s/m^3]
volScalarField chemistryQdot_;
// Source term fields
//- Coupled region radiative heat flux [W/m2]
//- Coupled region radiative heat flux [W/m^2]
// Requires user to input mapping info for coupled patches
// volScalarField qrCoupled_;
//- In depth radiative heat flux [W/m2]
//- In depth radiative heat flux [W/m^2]
volScalarField qr_;
@ -230,7 +230,7 @@ public:
//- Fields
//- Return const density [Kg/m3]
//- Return const density [Kg/m^3]
const volScalarField& rho() const;
//- Return const temperature [K]
@ -245,7 +245,7 @@ public:
//- Return the region thermal conductivity [W/m/k]
virtual tmp<volScalarField> kappa() const;
//- Return the total gas mass flux to primary region [kg/m2/s]
//- Return the total gas mass flux to primary region [kg/m^2/s]
virtual const surfaceScalarField& phiGas() const;

View File

@ -172,7 +172,7 @@ public:
// Geometry
//- Return the face area magnitudes / [m2]
//- Return the face area magnitudes / [m^2]
inline const surfaceScalarField& nMagSf() const;
//- Return the number of layers in the region

View File

@ -76,7 +76,7 @@ protected:
//- Patch normal vectors
autoPtr<volVectorField> nHatPtr_;
//- Face area magnitudes / [m2]
//- Face area magnitudes / [m^2]
autoPtr<volScalarField> magSfPtr_;
@ -126,7 +126,7 @@ public:
//- Return the patch normal vectors
virtual const volVectorField& nHat() const;
//- Return the face area magnitudes / [m2]
//- Return the face area magnitudes / [m^2]
virtual const volScalarField& magSf() const;

View File

@ -39,8 +39,8 @@ Description
U_p | patch velocity [m/s]
n | patch normal vector
\phi | mass flux [kg/s]
\rho | density [kg/m3]
Sf | patch face area vectors [m2]
\rho | density [kg/m^3]
Sf | patch face area vectors [m^2]
\delta | film height [m]
\endvartable

View File

@ -107,13 +107,13 @@ protected:
// Fields
//- Density [kg/m3]
//- Density [kg/m^3]
volScalarField rho_;
//- Dynamic viscosity [Pa.s]
volScalarField mu_;
//- Surface tension [m/s2]
//- Surface tension [m/s^2]
volScalarField sigma_;
@ -134,10 +134,10 @@ protected:
//- Velocity - wall [m/s]
volVectorField Uw_;
//- Film thickness*density (helper field) [kg/m2]
//- Film thickness*density (helper field) [kg/m^2]
volScalarField deltaRho_;
//- Mass flux (includes film thickness) [kg.m/s]
//- Mass flux (includes film thickness) [kg m/s]
surfaceScalarField phi_;
@ -159,26 +159,26 @@ protected:
// Note: need boundary value mapped from primary region, and then
// pushed into the patch internal field
//- Momementum [kg/m/s2]
//- Momementum [kg/m/s^2]
volVectorField USp_;
//- Pressure [Pa]
volScalarField pSp_;
//- Mass [kg/m2/s]
//- Mass [kg/m^2/s]
volScalarField rhoSp_;
// Primary region - registered to the primary region mesh
// Internal use only - not read-in
//- Momementum [kg/m/s2]
//- Momementum [kg/m/s^2]
volVectorField USpPrimary_;
//- Pressure [Pa]
volScalarField pSpPrimary_;
//- Mass [kg/m2/s]
//- Mass [kg/m^2/s]
volScalarField rhoSpPrimary_;
@ -191,7 +191,7 @@ protected:
//- Pressure [Pa]
volScalarField pPrimary_;
//- Density [kg/m3]
//- Density [kg/m^3]
volScalarField rhoPrimary_;
//- Viscosity [Pa.s]
@ -342,7 +342,7 @@ public:
//- Return const access to the dynamic viscosity [Pa.s]
inline const volScalarField& mu() const;
//- Return const access to the surface tension [kg/s2]
//- Return const access to the surface tension [kg/s^2]
inline const volScalarField& sigma() const;
@ -363,13 +363,13 @@ public:
//- Return the film wall velocity [m/s]
virtual const volVectorField& Uw() const;
//- Return the film thickness*density (helper field) [kg/m3]
//- Return the film thickness*density (helper field) [kg/m^3]
virtual const volScalarField& deltaRho() const;
//- Return the film flux [kg.m/s]
//- Return the film flux [kg m/s]
virtual const surfaceScalarField& phi() const;
//- Return the film density [kg/m3]
//- Return the film density [kg/m^3]
virtual const volScalarField& rho() const;
//- Return the film mean temperature [K]
@ -411,8 +411,8 @@ public:
const label patchi, // patchi on primary region
const label facei, // facei of patchi
const scalar massSource, // [kg]
const vector& momentumSource, // [kg.m/s] (tang'l momentum)
const scalar pressureSource, // [kg.m/s] (normal momentum)
const vector& momentumSource, // [kg m/s] (tang'l momentum)
const scalar pressureSource, // [kg m/s] (normal momentum)
const scalar energySource = 0 // [J]
);
@ -421,34 +421,34 @@ public:
// Primary region
//- Momementum [kg/m/s2]
//- Momementum [kg/m/s^2]
inline volVectorField& USpPrimary();
//- Pressure [Pa]
inline volScalarField& pSpPrimary();
//- Mass [kg/m2/s]
//- Mass [kg/m^2/s]
inline volScalarField& rhoSpPrimary();
// Film region
//- Momentum [kg/m/s2]
//- Momentum [kg/m/s^2]
inline volVectorField& USp();
//- Pressure [Pa]
inline volScalarField& pSp();
//- Mass [kg/m2/s]
//- Mass [kg/m^2/s]
inline volScalarField& rhoSp();
//- Momentum [kg/m/s2]
//- Momentum [kg/m/s^2]
inline const volVectorField& USp() const;
//- Pressure [Pa]
inline const volScalarField& pSp() const;
//- Mass [kg/m2/s]
//- Mass [kg/m^2/s]
inline const volScalarField& rhoSp() const;
@ -460,7 +460,7 @@ public:
//- Pressure [Pa]
inline const volScalarField& pPrimary() const;
//- Density [kg/m3]
//- Density [kg/m^3]
inline const volScalarField& rhoPrimary() const;
//- Viscosity [Pa.s]

View File

@ -86,13 +86,13 @@ private:
//- Specie name
word name_;
//- Density [kg/m3]
//- Density [kg/m^3]
mutable thermoData rho0_;
//- Dynamic viscosity [Pa.s]
mutable thermoData mu0_;
//- Surface tension [kg/s2]
//- Surface tension [kg/s^2]
mutable thermoData sigma0_;
//- Specific heat capacity [J/kg/K]
@ -157,13 +157,13 @@ public:
// Elemental access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual scalar rho(const scalar p, const scalar T) const;
//- Return dynamic viscosity [Pa.s]
virtual scalar mu(const scalar p, const scalar T) const;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual scalar sigma(const scalar p, const scalar T) const;
//- Return specific heat capacity [J/kg/K]
@ -190,13 +190,13 @@ public:
// Field access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual tmp<volScalarField> rho() const;
//- Return dynamic viscosity [Pa.s]
virtual tmp<volScalarField> mu() const;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual tmp<volScalarField> sigma() const;
//- Return specific heat capacity [J/kg/K]

View File

@ -121,13 +121,13 @@ public:
// Elemental access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual scalar rho(const scalar p, const scalar T) const = 0;
//- Return dynamic viscosity [Pa.s]
virtual scalar mu(const scalar p, const scalar T) const = 0;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual scalar sigma(const scalar p, const scalar T) const = 0;
//- Return specific heat capacity [J/kg/K]
@ -154,13 +154,13 @@ public:
// Field access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual tmp<volScalarField> rho() const = 0;
//- Return dynamic viscosity [Pa.s]
virtual tmp<volScalarField> mu() const = 0;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual tmp<volScalarField> sigma() const = 0;
//- Return specific heat capacity [J/kg/K]

View File

@ -124,13 +124,13 @@ public:
// Elemental access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual scalar rho(const scalar p, const scalar T) const;
//- Return dynamic viscosity [Pa.s]
virtual scalar mu(const scalar p, const scalar T) const;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual scalar sigma(const scalar p, const scalar T) const;
//- Return specific heat capacity [J/kg/K]
@ -157,13 +157,13 @@ public:
// Field access
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual tmp<volScalarField> rho() const;
//- Return dynamic viscosity [Pa.s]
virtual tmp<volScalarField> mu() const;
//- Return surface tension [kg/s2]
//- Return surface tension [kg/s^2]
virtual tmp<volScalarField> sigma() const;
//- Return specific heat capacity [J/kg/K]

View File

@ -60,7 +60,7 @@ class constantRadiation
{
// Private Data
//- Constant radiative flux [kg/s3]
//- Constant radiative flux [kg/s^3]
volScalarField qrConst_;
//- Radiation mask

View File

@ -58,7 +58,7 @@ class primaryRadiation
{
// Private Data
//- Incident radiative flux mapped from the primary region / [kg/s3]
//- Incident radiative flux mapped from the primary region / [kg/s^3]
volScalarField qinPrimary_;

View File

@ -57,7 +57,7 @@ class standardRadiation
{
// Private Data
//- Radiative incident flux mapped from the primary region / [kg/s3]
//- Radiative incident flux mapped from the primary region / [kg/s^3]
volScalarField qinPrimary_;
//- Remaining radiative flux after removing local contribution

View File

@ -57,7 +57,7 @@ class constantHeatTransfer
{
// Private Data
//- Constant heat transfer coefficient [W/m2/K]
//- Constant heat transfer coefficient [W/m^2/K]
scalar c0_;
@ -97,7 +97,7 @@ public:
//- Correct
virtual void correct();
//- Return the heat transfer coefficient [W/m2/K]
//- Return the heat transfer coefficient [W/m^2/K]
virtual tmp<volScalarField> h() const;
};

View File

@ -120,7 +120,7 @@ public:
//- Correct
virtual void correct() = 0;
//- Return the heat transfer coefficient [W/m2/K]
//- Return the heat transfer coefficient [W/m^2/K]
virtual tmp<volScalarField> h() const = 0;
};

View File

@ -58,10 +58,10 @@ class mappedConvectiveHeatTransfer
{
// Private Data
//- Heat transfer coefficient - primary region [W/m2/K]
//- Heat transfer coefficient - primary region [W/m^2/K]
volScalarField htcConvPrimary_;
//- Heat transfer coefficient - film region [W/m2/K]
//- Heat transfer coefficient - film region [W/m^2/K]
// Assumes that the primary regtion to film region boundaries are
// described as mappedPushed types
volScalarField htcConvFilm_;
@ -106,7 +106,7 @@ public:
//- Correct
virtual void correct();
//- Return the heat transfer coefficient [W/m2/K]
//- Return the heat transfer coefficient [W/m^2/K]
virtual tmp<volScalarField> h() const;
};

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -161,7 +161,7 @@ void standardPhaseChange::correctModel
}
else
{
// Primary region density [kg/m3]
// Primary region density [kg/m^3]
const scalar rhoInfc = rhoInf[celli];
// Primary region viscosity [Pa.s]

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2017-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2017-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -230,7 +230,7 @@ void waxSolventEvaporation::correctModel
Ysolvent*Wsolvent/((1 - Ysolvent)*Wwax + Ysolvent*Wsolvent)
);
// Primary region density [kg/m3]
// Primary region density [kg/m^3]
const scalar rhoInfc = rhoInf[celli];
// Cell pressure [Pa]

View File

@ -69,7 +69,7 @@ protected:
// Protected data
//- Acceleration due to gravity [m/s2]
//- Acceleration due to gravity [m/s^2]
const dimensionedVector& g_;
@ -137,7 +137,7 @@ public:
//- Return the film wall velocity [m/s]
virtual const volVectorField& Uw() const = 0;
//- Return the film density [kg/m3]
//- Return the film density [kg/m^3]
virtual const volScalarField& rho() const = 0;
//- Return the film mean temperature [K]

View File

@ -167,10 +167,10 @@ protected:
autoPtr<filmViscosityModel> viscosity_;
//- Heat transfer coefficient between film surface and primary
// region [W/m2/K]
// region [W/m^2/K]
autoPtr<heatTransferModel> htcs_;
//- Heat transfer coefficient between wall and film [W/m2/K]
//- Heat transfer coefficient between wall and film [W/m^2/K]
autoPtr<heatTransferModel> htcw_;
//- Phase change
@ -311,8 +311,8 @@ public:
const label patchi, // patchi on primary region
const label facei, // facei of patchi
const scalar massSource, // [kg]
const vector& momentumSource, // [kg.m/s] (tangential momentum)
const scalar pressureSource, // [kg.m/s] (normal momentum)
const vector& momentumSource, // [kg m/s] (tangential momentum)
const scalar pressureSource, // [kg m/s] (normal momentum)
const scalar energySource // [J]
);

View File

@ -117,7 +117,7 @@ public:
//- Return the film mean temperature [K]
virtual const volScalarField& T() const;
//- Return density [Kg/m3]
//- Return density [Kg/m^3]
virtual const volScalarField& rho() const;
//- Return thermal conductivity [W/m/K]

View File

@ -162,7 +162,7 @@ public:
//- Return temperature [K]
virtual const volScalarField& T() const;
//- Return density [Kg/m3]
//- Return density [Kg/m^3]
virtual const volScalarField& rho() const;
//- Return thermal conductivity [W/m/K]

View File

@ -200,7 +200,7 @@ public:
// Fields
//- Return density [kg/m3]
//- Return density [kg/m^3]
virtual const volScalarField& rho() const = 0;
//- Return const temperature [K]

Some files were not shown because too many files have changed in this diff Show More