Skip to content
Snippets Groups Projects
Commit 9b3d2144 authored by Vishal Jambhekar's avatar Vishal Jambhekar
Browse files

New naminig convention FIRST SESSION 3p3c model


git-svn-id: svn://svn.iws.uni-stuttgart.de/DUMUX/dumux/trunk@8246 2fb0f335-1f38-0410-981e-8018bf24f1b0
parent 5e6ae267
No related branches found
No related tags found
No related merge requests found
...@@ -183,13 +183,13 @@ public: ...@@ -183,13 +183,13 @@ public:
* \brief Returns the temperature within the domain. * \brief Returns the temperature within the domain.
* *
* \param element The element * \param element The element
* \param fvElemGeom The finite-volume geometry in the box scheme * \param fvGeometry The finite-volume geometry in the box scheme
* \param scvIdx The local vertex index (SCV index) * \param scvIdx The local vertex index (SCV index)
* *
* This problem assumes a temperature of 10 degrees Celsius. * This problem assumes a temperature of 10 degrees Celsius.
*/ */
Scalar boxTemperature(const Element &element, Scalar boxTemperature(const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
return temperature_; return temperature_;
...@@ -274,7 +274,7 @@ public: ...@@ -274,7 +274,7 @@ public:
* *
* \param values The neumann values for the conservation equations * \param values The neumann values for the conservation equations
* \param element The finite element * \param element The finite element
* \param fvElemGeom The finite-volume geometry in the box scheme * \param fvGeometry The finite-volume geometry in the box scheme
* \param is The intersection between element and boundary * \param is The intersection between element and boundary
* \param scvIdx The local vertex index * \param scvIdx The local vertex index
* \param boundaryFaceIdx The index of the boundary face * \param boundaryFaceIdx The index of the boundary face
...@@ -284,10 +284,10 @@ public: ...@@ -284,10 +284,10 @@ public:
*/ */
void neumann(PrimaryVariables &values, void neumann(PrimaryVariables &values,
const Element &element, const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
const Intersection &is, const Intersection &is,
int scvIdx, int scvIdx,
int boundaryFaceIdx) const const int boundaryFaceIdx) const
{ {
const GlobalPosition &globalPos = element.geometry().corner(scvIdx); const GlobalPosition &globalPos = element.geometry().corner(scvIdx);
values = 0; values = 0;
...@@ -313,7 +313,7 @@ public: ...@@ -313,7 +313,7 @@ public:
* *
* \param values The initial values for the primary variables * \param values The initial values for the primary variables
* \param element The finite element * \param element The finite element
* \param fvElemGeom The finite-volume geometry in the box scheme * \param fvGeometry The finite-volume geometry in the box scheme
* \param scvIdx The local vertex index * \param scvIdx The local vertex index
* *
* For this method, the \a values parameter stores primary * For this method, the \a values parameter stores primary
...@@ -321,7 +321,7 @@ public: ...@@ -321,7 +321,7 @@ public:
*/ */
void initial(PrimaryVariables &values, void initial(PrimaryVariables &values,
const Element &element, const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
const GlobalPosition &globalPos = element.geometry().corner(scvIdx); const GlobalPosition &globalPos = element.geometry().corner(scvIdx);
......
...@@ -30,7 +30,7 @@ ...@@ -30,7 +30,7 @@
#define DUMUX_INFILTRATION_SPATIAL_PARAMETERS_HH #define DUMUX_INFILTRATION_SPATIAL_PARAMETERS_HH
#include <dumux/boxmodels/3p3c/3p3cindices.hh> #include <dumux/boxmodels/3p3c/3p3cindices.hh>
#include <dumux/material/spatialparameters/boxspatialparameters.hh> #include <dumux/material/spatialparams/boxspatialparams.hh>
#include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3p.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3p.hh>
#include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3pparams.hh> #include <dumux/material/fluidmatrixinteractions/3p/parkerVanGen3pparams.hh>
...@@ -153,14 +153,14 @@ public: ...@@ -153,14 +153,14 @@ public:
* potential gradient. * potential gradient.
* *
* \param element The current finite element * \param element The current finite element
* \param fvElemGeom The current finite volume geometry of the element * \param fvGeometry The current finite volume geometry of the element
* \param scvIdx The index of the sub-control volume * \param scvIdx The index of the sub-control volume
*/ */
const Scalar intrinsicPermeability(const Element &element, const Scalar intrinsicPermeability(const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; const GlobalPosition &pos = fvGeometry.subContVol[scvIdx].global;
if (isFineMaterial_(pos)) if (isFineMaterial_(pos))
return fineK_; return fineK_;
return coarseK_; return coarseK_;
...@@ -170,15 +170,15 @@ public: ...@@ -170,15 +170,15 @@ public:
* \brief Define the porosity \f$[-]\f$ of the spatial parameters * \brief Define the porosity \f$[-]\f$ of the spatial parameters
* *
* \param element The finite element * \param element The finite element
* \param fvElemGeom The finite volume geometry * \param fvGeometry The finite volume geometry
* \param scvIdx The local index of the sub-control volume where * \param scvIdx The local index of the sub-control volume where
* the porosity needs to be defined * the porosity needs to be defined
*/ */
double porosity(const Element &element, double porosity(const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
//const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; //const GlobalPosition &pos = fvGeometry.subContVol[scvIdx].global;
// if (isFineMaterial_(pos)) // if (isFineMaterial_(pos))
// return finePorosity_; // return finePorosity_;
// else // else
...@@ -191,14 +191,14 @@ public: ...@@ -191,14 +191,14 @@ public:
* \brief return the parameter object for the material law which depends on the position * \brief return the parameter object for the material law which depends on the position
* *
* \param element The current finite element * \param element The current finite element
* \param fvElemGeom The current finite volume geometry of the element * \param fvGeometry The current finite volume geometry of the element
* \param scvIdx The index of the sub-control volume * \param scvIdx The index of the sub-control volume
*/ */
const MaterialLawParams& materialLawParams(const Element &element, const MaterialLawParams& materialLawParams(const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
//const GlobalPosition &pos = fvElemGeom.subContVol[scvIdx].global; //const GlobalPosition &pos = fvGeometry.subContVol[scvIdx].global;
//if (isFineMaterial_(pos)) //if (isFineMaterial_(pos))
//return fineMaterialParams_; //return fineMaterialParams_;
//else //else
...@@ -212,18 +212,18 @@ public: ...@@ -212,18 +212,18 @@ public:
* This is only required for non-isothermal models. * This is only required for non-isothermal models.
* *
* \param element The finite element * \param element The finite element
* \param fvElemGeom The finite volume geometry * \param fvGeometry The finite volume geometry
* \param scvIdx The local index of the sub-control volume where * \param scvIdx The local index of the sub-control volume where
* the heat capacity needs to be defined * the heat capacity needs to be defined
*/ */
double heatCapacity(const Element &element, double heatCapacity(const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvIdx) const int scvIdx) const
{ {
return return
850. // specific heat capacity [J / (kg K)] 850. // specific heat capacity [J / (kg K)]
* 2650. // density of sand [kg/m^3] * 2650. // density of sand [kg/m^3]
* (1 - porosity(element, fvElemGeom, scvIdx)); * (1 - porosity(element, fvGeometry, scvIdx));
} }
/*! /*!
...@@ -234,19 +234,19 @@ public: ...@@ -234,19 +234,19 @@ public:
* *
* \param heatFlux The resulting heat flux vector * \param heatFlux The resulting heat flux vector
* \param fluxDat The flux variables * \param fluxDat The flux variables
* \param vDat The volume variables * \param elemVolVars The volume variables
* \param tempGrad The temperature gradient * \param tempGrad The temperature gradient
* \param element The current finite element * \param element The current finite element
* \param fvElemGeom The finite volume geometry of the current element * \param fvGeometry The finite volume geometry of the current element
* \param scvfIdx The local index of the sub-control volume face where * \param scvfIdx The local index of the sub-control volume face where
* the matrix heat flux should be calculated * the matrix heat flux should be calculated
*/ */
void matrixHeatFlux(Vector &heatFlux, void matrixHeatFlux(Vector &heatFlux,
const FluxVariables &fluxDat, const FluxVariables &fluxDat,
const ElementVolumeVariables &vDat, const ElementVolumeVariables &elemVolVars,
const Vector &tempGrad, const Vector &tempGrad,
const Element &element, const Element &element,
const FVElementGeometry &fvElemGeom, const FVElementGeometry &fvGeometry,
int scvfIdx) const int scvfIdx) const
{ {
static const Scalar ldry = 0.35; static const Scalar ldry = 0.35;
...@@ -254,12 +254,12 @@ public: ...@@ -254,12 +254,12 @@ public:
static const Scalar lSn1 = 0.65; static const Scalar lSn1 = 0.65;
// arithmetic mean of the liquid saturation and the porosity // arithmetic mean of the liquid saturation and the porosity
const int i = fvElemGeom.subContVolFace[scvfIdx].i; const int i = fvGeometry.subContVolFace[scvfIdx].i;
const int j = fvElemGeom.subContVolFace[scvfIdx].j; const int j = fvGeometry.subContVolFace[scvfIdx].j;
Scalar Sw = std::max(0.0, (vDat[i].saturation(wPhaseIdx) + Scalar Sw = std::max(0.0, (elemVolVars[i].saturation(wPhaseIdx) +
vDat[j].saturation(wPhaseIdx)) / 2); elemVolVars[j].saturation(wPhaseIdx)) / 2);
Scalar Sn = std::max(0.0, (vDat[i].saturation(nPhaseIdx) + Scalar Sn = std::max(0.0, (elemVolVars[i].saturation(nPhaseIdx) +
vDat[j].saturation(nPhaseIdx)) / 2); elemVolVars[j].saturation(nPhaseIdx)) / 2);
// the heat conductivity of the matrix. in general this is a // the heat conductivity of the matrix. in general this is a
// tensorial value, but we assume isotropic heat conductivity. // tensorial value, but we assume isotropic heat conductivity.
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment