v0.14.0
COR-1: Time dependent nonlinear mix formulation (unsaturated flow)

In this tutorial, we show how to solve a strongly nonlinear time dependent equation using mix-finite-elements. We focus on construction of finite elements, finite element user data operators (UDO), setting up discrete manager (DM) and time solver (TS). Issues related to the nonlinear solver and line searchers are briefly discussed. We also show how to use automatic differentiation (ADOL-C) to calculate derivatives of a constitutive model.

Problem solved here is similar to the solution of nonlinear Poisson's equation described in COR-5: A nonlinear Poisson equation and is a generalization of the problem described in COR-0: Mixed formulation and integration on skeleton (h-adaptivity). You might look to those tutorials if some implementation aspects of presented methodology are unclear. Also, you are encouraged to post questions on our Q&A forum.

Presented methodology is applied to the problem of unsaturated water transport. We have no intention to give a detailed description of transport in unsaturated materials, here we only focus on problem discretization, equations linearization and implementation of finite element. Also, we do not show here how to do hp-adaptivity, this is part of other tutorials. This problem can be solved with block solver, improving its efficiency and robustness, see example COR-4: Using fieldsplit solver and DM sub problem.. If you like to extend this work, adding block solver or hp-adaptivity, we offer our guidance and help.

The application for unsaturated flow is implemented in unsaturated_transport.cpp, material models are implemented in MaterialUnsaturatedFlow.hpp, problem definition and implementation are implemented in UnsaturatedFlow.hpp.

The tutorial is organized as follows. First, we explain how to run the application. Next, we show how the material model is implemented, after that we explain the mathematical and numerical models. Finally, we explain implementation details.

Note
Not all information presented here is essential, some parts you can skip and come back to them later. For example, if you like to add your material model you have to focus attention on section Physical equations.

Numerical examples

Numerical example 1

You can imagine that we do an experiment, such that we have wet silt and dry clay, we make three layers, with silt in the middle, and clay on the top and below. Such column of soil we put in the box, for example, made from plexiglass. Thus all sides are impermeable. We will observe water content and capillary pressure for two days, that is long enough to approach equilibrium.

Mesh

First, we create a mesh which can be made in Salome, gMesh, Tetgen, or any other code. MoFEM uses MOAB for mesh database which can read various mesh file formats. Here we using Cubit to make the mesh, the journal file for this problem is as follows

reset
# create body volume
brick x 0.01 y 0.002 z 0.1
move Volume all x 0 y 0 z -0.05 include_merged
brick x 0.1 y 0.06 z 0.02
move Volume 2  location volume 1  include_merged
chop volume 1 with volume 2
imprint volume all
merge volume all
# make block for clay
block 1 volume 4 5
block 1 name 'SOIL_CLAY1'
# make block for silt
block 2 volume 3
block 2 name 'SOIL_SILT2'
# make mesh
volume all size auto factor 10
volume all scheme Tetmesh
mesh volume all
# refine mesh at interfaces between clay & silt
refine surface 13 14 size 0.0025 bias 1.5 depth 1 smooth

Note that we do not set any boundary conditions here, in that case, it is assumed that fluxes on the boundary are zero, that is the boundary is impermeable.

Model parameters

Next, we need to make a configuration file, where all problem specific parameters are set.

[mat_block_1]
# VanGenuchten
# SimpleDarcy
material_name=VanGenuchten
# Default material for VanGenuchten is Clay (no need to set parameters if clay is used)
# Assumed units are in meters and days.

# Model parameters controlling convergence
sCale=1e6       # Scale mass conservation equation
ePsilon1=1e-5   # Minimal capacity when removing spurious oscillations in time

Ah=-9 # head suction at z = 0
AhZ=1 #�gradient of initial head suction
AhZZ=0 # initial head suction is calculated from equation h = Ah + AhZZ*z + AhZZ*zz

[mat_block_2]
material_name=VanGenuchten
# Material parameters for Silt from Vogel., van Genuchten Cislerova 2001
sCale=1e6
ePsilon1=1e-5
Ah=-0.09
AhZ=1
thetaS=0.46
thetaM=0.46
thetaR=0.034
alpha=1.6
n=1.37
Ks=0.006
hS=0

The material parameters are taken from [73], the initial parameters for clay (mat_block_1) and silt (mat_block_2) are set with the \(A_h\) and \(A_h^z\), such that initial capillary pressure head is given by \( h = A_h+A_h^z z \) where

\[ \left\{ \begin{array}{ll} h(z,t=0) = -9+z&\textrm{for clay}\\ h(z,t=0) = -0.09+z&\textrm{for silt} \end{array} \right. \]

Analysis

The analysis is run using script run_uf.sh

Editing that file you can set range of parameters, control time solver, tolerances, stop criteria, line-searcher. For details look to PETSc manual link.

  • Options controlling time solver (TS) see link.
  • Options controlling nonlinear solver (SNES) see link.
  • Options controlling line-searcher see link.
  • Options controlling linear solver see link.

Note that here the solved problem is strongly nonlinear, and we use secant line-search in the L2 norm (see link). For stability of the result at each Newton iteration, we execute three sub-iterations with line searcher. Also, you have the option of controlling the time step adaptively and linear solver pre-conditioner. All command line options, both PETSc and MoFEM are printed if you add switch -help when you run MoFEM application.

MoFEM specific options are

  • -my_file out.h5m set the name of the mesh file. Note that mesh has to be partitioned into a number of processors. MoFEM code is parallel.
  • -configure unsaturated.cfg set the name of the material config file.
  • -my_order 0 set the approximation order of the pressure head.
  • -how_often_output 5 set how often you dump data on the hard drive. In this case, five means that file is dumped every fifth step.
  • -my_max_post_proc_ref_level 0 set the post-processing mesh refinement level. If you are using higher order polynomial, higher than two, to resolve the solution on the mesh you can increase the refinement level. Note that the file size could increase significantly, therefore, it is not recommended to use this value higher that one.

Finally, we can run the simulation by executing above the script

cd /mofem_build/um/basic_finite_elements/mix_transport
./run_uf.sh soil_impermeable.cub unsaturated.cfg 4 0.001 1 0

where

  • the first parameter is the mesh file name
  • the second parameter is the material configuration name
  • third parameter is the number of processors which you want to use to run analysis
  • the fourth parameter sets the time step size
  • the fifth parameter sets the time of the simulation
  • the sixth parameter is the approximation order

Results

For the problem setup like above, results are shown in Figure 1, where the evolution of various parameters over time until equilibrium is reached is shown. You can note that initially, clay is relatively dry, whereas silt is wet. Over time, the clay sucks the water from the silt. On the left-hand side, we observe the distribution of saturation. Initially, high gradients of pressure head are created on the interface between the two materials. Those are captured very well, despite the coarse mesh, showing capabilities of the presented problem formulation. For creation of this figure we used the 2nd order of polynomial to approximate the pressure head and the 3rd order polynomial to approximate the fluxes.

Figure 1. On the bottom axis is depth, on the left axis is pressure head, right axis is water content. Red line is water head, green line is water content. Colormap on the left hand side is for saturation.

Numerical example 2

In the second example, we show how to run downward infiltration problem with three layers, i.e. clay, silt and clay.

Mesh

In the case above, we apply zero pressure head and the rest of the boundary is impermeable. See the following journal script to generate such a mesh

reset
# create body volume
brick x 0.01 y 0.002 z 0.1
move Volume all x 0 y 0 z -0.05 include_merged
brick x 0.1 y 0.06 z 0.02
move Volume 2  location volume 1  include_merged
chop volume 1 with volume 2
imprint volume all
merge volume all
# make block for clay
block 1 volume 4 5
block 1 name 'SOIL_CLAY1'
# make block for silt
block 2 volume 3
block 2 name 'SOIL_SILT2'
block 3 surface 1
block 3 name 'HEAD1'
block 3 attribute count 1
block 3 attribute index 1 0
# make mesh
volume all size auto factor 10
volume all scheme Tetmesh
mesh volume all
# refine mesh at interfaces between clay & silt
refine surface 1 13 14 size 0.0025 bias 1.5 depth 1 smooth

Here we add the third block name HEAD1, where a boundary condition is applied. Similarly, non-zero fluxes can be applied by making a block with some surface elements and called it for example "FLUX1".

Model parameters

The material parameters are similar to the ones given in the previous problem

[mat_block_1]
# VanGenuchten
# SimpleDarcy
material_name=VanGenuchten
# Default material for VanGenuchten is Clay (no need to set parameters if clay is used)
# Assumed units are in meters and days.

# Model parameters controlling convergence
sCale=1e6       # Scale mass conservation equation
ePsilon1=1e-5   # Minimal capacity when removing spurious oscillations in time

Ah=-9 # head suction at z = 0
AhZ=1 #�gradient of initial head suction
AhZZ=0 # initial head suction is calculated from equation h = Ah + AhZZ*z + AhZZ*zz

[mat_block_2]
material_name=VanGenuchten
# Material parameters for Silt from Vogel., van Genuchten Cislerova 2001
sCale=1e6
ePsilon1=1e-5
Ah=-9
AhZ=1
thetaS=0.46
thetaM=0.46
thetaR=0.034
alpha=1.6
n=1.37
Ks=0.006
hS=0

# You can change boundary conditions here
#[head_block_3]
#head = 0

Note that for this example we set initial pressure head distribution such that clay and silt are in equilibrium.

\[ \left\{ \begin{array}{ll} h(z,t=0) = -9+z&\textrm{for clay}\\ h(z,t=0) = -9+z&\textrm{for silt} \end{array} \right. \]

Moreover at the end we show how to modify boundary condition. As an excrete one can change value of head on the top of the sample.

Analysis

We run script as before

./run_uf.sh upward_infiltration.cub unsaturated.cfg 4 0.001 1 0

Results

For this example, we observe an influx of water into the column of the solid, we can plot how it is changing over time. At every time step, the solver monitor prints on the screen following lines

63 TS dt 0.00242774 time 0.0710581
Flux at time 0.07106 3.859e-07
    0 SNES Function norm 4.123926528377e-02
    1 SNES Function norm 6.552371691866e-02
    2 SNES Function norm 7.740255184123e-02
    3 SNES Function norm 7.999178179888e-02
    4 SNES Function norm 7.881110800442e-02
    5 SNES Function norm 7.582982118207e-02
    6 SNES Function norm 7.173427725809e-02
    7 SNES Function norm 6.666200930695e-02
    8 SNES Function norm 6.040633270649e-02
    9 SNES Function norm 5.232159632926e-02
   10 SNES Function norm 4.057267597689e-02
   11 SNES Function norm 1.625005251310e-02
   12 SNES Function norm 4.316837250846e-05
   13 SNES Function norm 8.980432593466e-07
  Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 13
      TSAdapt 'basic': step  63 accepted t=0.0710581  + 2.428e-03 wlte=0.546 family='beuler' scheme=0:'' dt=2.627e-03
64 TS dt 0.00262737 time 0.0734859
Flux at time 0.07349 3.812e-07
    0 SNES Function norm 4.023589003253e-02
    1 SNES Function norm 6.962486297267e-02
    2 SNES Function norm 8.329691099303e-02
    3 SNES Function norm 8.641640743250e-02
    4 SNES Function norm 8.532070311444e-02
    5 SNES Function norm 8.223165652333e-02
    6 SNES Function norm 7.792739113001e-02
    7 SNES Function norm 7.257891287567e-02
    8 SNES Function norm 6.598809018682e-02
    9 SNES Function norm 5.751011198160e-02
   10 SNES Function norm 4.535116560548e-02
   11 SNES Function norm 2.147388609216e-02
   12 SNES Function norm 1.073710142541e-05
   13 SNES Function norm 4.011739514453e-11
  Nonlinear solve converged due to CONVERGED_FNORM_ABS iterations 13
      TSAdapt 'basic': step  64 accepted t=0.0734859  + 2.627e-03 wlte=0.588 family='beuler' scheme=0:'' dt=2.742e-03

where for step 63 and 64, total flux is printed in \(m^3/day\),

Flux at time 0.07106 3.859e-07
Flux at time 0.07349 3.812e-07

We can extract that information using awk/grep as follows

awk '/Flux at/ {print $4,$5/(0.01*0.002)}' log | tee gp

This shell command line takes all lines which have the phrase "Flux at", takes the fourth and the fifth columns from those lines, whereas fifth column is divided by area of the surface where the head is applied. Finally, results are stored in file gp. You can plot results in MS Excel or any other software, we choose to use gnuplot. As a result, we get Figure 2 below.

Figure 2. Influx of water for upward infiltration.

In Figure 3 below, we can observe how the wetting front is moving downwards. Note how the gradient of head differs between clay and silt, and how it moves through the interface between materials.

Figure 3. On the bottom axis is depth, on the left axis is pressure head, right axis is water content. Red line is water head, green line is water content. Colormap on the left hand side is for saturation.

Mathematical model

We consider porous material partially filled with water. In this tutorial, we are going to simulate water transport in such a system. The primary behaviour of the system depends on the material structure, capillary forces and the wetting angle, taken into account by experimentally estimated material parameters. Darcy's law gives the relation between flux and suction head (capillary pressure). Constitutive equations describe the relationship between hydraulic conductivity and water content. It is assumed that the state of the material is a function of water content, and using water retention curve one can map the between capillary head and the water content, i.e. \(\theta=\theta(h)\). The process of the water flow has to obey the conservation of mass, and consequently, the process of unsaturated transport is described by the parabolic differential equation.

PDE

The Richards equation describes the problem of unsaturated flow

\[ \frac{\partial \theta}{\partial t}- \nabla \cdot \left[ \left( K(\theta) \nabla ( h - z) \right) \right] = 0 \]

where \(z\) is depth and \(K=K(\theta)\) is hydraulic conductivity. \(\nabla\) and \(\nabla \cdot\) are differential operators for gradient and divergence respectively. The above equation can alternatively be expressed by the system of first order partial differential equations

\[ \left\{ \begin{array}{l} \frac{1}{K(\theta)}\boldsymbol\sigma + \nabla (h -z) = 0 \\ c(\theta)\frac{\partial h}{\partial t} - \nabla \cdot \boldsymbol\sigma = 0 \end{array} \right. \]

where \(\boldsymbol\sigma\) is flux. The first equation expresses the constitutive relation while the second is the conservation law. The second equation is also called the continuity equation, and it does not allow for creation or annihilation of mass. The capacity term \(c\) in the second equation is given by

\[ c = \frac{\partial \theta}{\partial h} \]

Physical equations

There exists semi-empirical relation between \(\theta\) and \(h\), called water retention curve, and for an unsaturated state one can uniquely map between the two when water retention hysteresis is not included. For simplicity here, we do not include hysteresis in our equations, and relations need to be established

\[ \left\{ \begin{array}{l} \theta=\theta(h)\\ K = K(\theta) \end{array} \right. \]

Generic material model is implemented in MixTransport::GenericMaterial, which is an abstract class, thus its instance cannot be created. This class sets methods and data used by finite element instances. It is not modified when a new material is implemented. This class is located in UnsaturatedFlow.hpp. To implement a new material model the user needs to implement this method

From MixTransport::GenericMaterial, the MixTransport::CommonMaterialData is derived. This class is unchanged if new material is implemented unless new material parameters need to be added to the model. Material parameters are read from text file given with command line option -configure unsaturated.cfg. Example of such file looks as follows

[mat_block_1]
# VanGenuchten
# SimpleDarcy
material_name=VanGenuchten
# Default material for VanGenuchten is Clay (no need to set paramters if clay is used)
# Assumed usinits are in meters and days.

# Model parameters controlling convergence
sCale=1e6       # Scale mass conservation equation
ePsilon1=1e-5   # Minimal capacity when removing spurious oscillations in time

Ah=-9 # head suction at z = 0
AhZ=1 # gradient of initial head suction
AhZZ=0 # initial head suction is calculated from equation h = Ah + AhZZ*z + AhZZ*zz

[mat_block_2]
material_name=VanGenuchten
# Material parameters for Silt from Vogel., van Genuchten Cislerova 2001
sCale=1e6
ePsilon1=1e-5
Ah=-0.09
AhZ=1
thetaS=0.46
thetaM=0.46
thetaR=0.034
alpha=1.6
n=1.37
Ks=0.006
hS=0

# You can change boundary conditions here
#[head_block_3]
#head = 0

Note that we have two blocks, which are sets of elements on the mesh. To each block, we can attach material and set material parameters. A user can add more material parameters by declaring them in MixTransport::CommonMaterialData and adding them to method MixTransport::CommonMaterialData::addOptions, such that added material parameters are read from the configuration file.

For purposes of this tutorial we have implemented two material models, i.e. MixTransport::MaterialDarcy and MixTransport::MaterialVanGenuchten, both classes are derived from MixTransport::CommonMaterialData.

Adding new material

The simplest method to implement new material is to derive class form MixTransport::MaterialWithAutomaticDifferentiation, and add it to file MaterialUnsaturatedFlow.cpp. MixTransport::MaterialWithAutomaticDifferentiation is a class to simplify implementation of the material model by utilizing advantages of automatic differentiation. Comprehensive description of library ADOL-C for automatic differentiation can be found here (link).

In principle automatic differentiation records mathematical operations in the function. Recorded mathematical operations are represented algorithmically in the tree, where each tree leaf is expanded into Taylor series, with sufficient order to calculate derivatives exactly. Automatic differentiation is different from symbolic differentiation, such that it can calculate derivatives of algorithm, so you can have loops and other commands in your differentiated function.

In consequence, user needs to build a tree to calculate water content density \(\theta=\theta(h)\) and relative hydraulic conductivity \(K_r=K_r(h)\). Using terminology from ADOL-C, one has to record tape with differentiated function. This is done by overloading two functions, MixTransport::MaterialWithAutomaticDifferentiation::recordTheta and MixTransport::MaterialWithAutomaticDifferentiation::recordKr. For example

struct MyMaterialForUnsaturatedFlow: public MaterialWithAutomaticDifferentiation {
static boost::shared_ptr<CommonMaterialData> createMatPtr(const CommonMaterialData &data) {
return boost::shared_ptr<CommonMaterialData>(new MyMaterialForUnsaturatedFlow(data));
}
MyMaterialForUnsaturatedFlow(const CommonMaterialData &data):
MaterialWithAutomaticDifferentiation(data) {
recordTheta();
recordKr();
}
adouble ah;
adouble aTheta;
adouble aKr;
adouble aSe;
adouble aSeStar;
template <typename TYPE>
inline TYPE funTheta(TYPE &h,const double m) {
return thetaR+(thetaS-thetaR)/pow(1+pow(-alpha*h,n),m);
}
virtual void recordTheta() {
trace_on(2*blockId+0,true);
h = -1-hS;
ah <<= h;
const double m = 1-1/n;
aTheta = funTheta(ah,m);
double r_theta;
aTheta >>= r_theta;
trace_off();
}
virtual void recordKr() {
trace_on(2*blockId+1,true);
h = -1-hS;
ah <<= h;
const double m = 1-1/n;
aTheta = funTheta(ah,m);
aSe = funSe(aTheta);
aKr = aSe*pow(1-pow(1-pow(Se,1/m),m),2);
double r_Kr;
aKr >>= r_Kr;
trace_off();
}
};

where method recordTheta represents equation

\[ \theta = \theta_r + \frac{\theta_s-\theta_r}{(1+(-\alpha h)^n)^m} \]

and method recordKr represents equation

\[ K_r(S_e) = S_e\left[1-(1-S_e^{1/m})^m\right]^2 \]

Note that \(h\) is an independent variable, whereas \(\theta\) and \(K_r\) are dependent variables. \(\alpha\), \(n\) and \(m\) are model parameters, for details see [73]. Dissecting method recordTheta, we have

trace_on(2*blockId+0,true);
/// Code here
trace_off();

where we start and stop tape recording/tracing. Each tape has unique Id, in our case we have a convention that even Id's are used to record operations to calculate \(\theta\) and odd Id's are used to record \(K_r\). Each material block has own set of tapes since it uses unique material parameters and physical model has Id calculated from block number set on the mesh. In following code

h = -1-hS;
ah <<= h;
// Calculate aTheta here
double r_theta;
aTheta >>= r_theta;

we start by seeding point for which we build tree, \(h\) can be arbitrary but for the unsaturated state. Next, using "<<=" we set independent variable and using operator ">>=" to set dependent variable.

Finally new material model needs to be registered, by adding lines to the code as follows

struct RegisterMaterials {
static map<std::string,CommonMaterialData::RegisterHook> mapOfRegistredMaterials;
MoFEMErrorCode operator()() const {
mapOfRegistredMaterials["SimpleDarcy"] = MaterialDarcy::createMatPtr;
mapOfRegistredMaterials["VanGenuchten"] = MaterialVanGenuchten::createMatPtr;
mapOfRegistredMaterials["MyModel"] = MyMaterialForUnsaturatedFlow::createMatPtr;
}
};

Numerical model

In the following, we apply mix-formulation, building on tutorial COR-0: Mixed formulation and integration on skeleton (h-adaptivity). We will show below that such approximation enables to solve Richards equation efficiently. This enables to address some issues of the regularity of the equations that are difficult to approximate for classical formulation of finite elements.

Mix-formulations allow converging to the solution faster than classical finite element formulation. Mix-elements have built-in error estimators into formulation allowing for efficient hp-adaptation and last but not least separation of nonlinearities, driving the development of effective solvers for strongly nonlinear problems.

Conservation of mass

Our PDE is system of two equations. The second equation is a universal law of the conservation of mass, which enforces continuity of fluxes, such that for an arbitrary surface \(\Gamma\) dividing body on two parts, that is \(\Omega = \Omega^1 \cup \Omega^2\)

\[ \mathbf{n}(\mathbf{x}) \cdot \left( \boldsymbol\sigma^1(\mathbf{x}) - \boldsymbol\sigma^2(\mathbf{x}) \right) = 0,\;\forall\mathbf{x}\in\Gamma \]

Utilizing this observation, we choose approximation base which a priori satisfies such continuity on element faces. However, it does not enforce continuity of tangential components on the element face, since those do not contribute to mass exchange on element faces. Such approximation base is constructed for Raviart Thomas elements. Here we are using the recipe from [30] to construct arbitrary polynomial base order on elements, which a priori enforces continuity of fluxes.

The mass conservation in discrete form can be expressed as follows

\[ \left(v,c(\theta) \frac{\partial h}{\partial t}\right)_\Omega - (v,\boldsymbol\sigma)_\Omega = 0 \quad \forall v \]

We obtain this equation by multiplying mass conservation by test function \(v\) and integrating both sides. Tested and test base functions are \(h,v \in L^2(\Omega)\), whereas \(\boldsymbol\sigma \in H(\nabla\cdot,\Omega)\) are divergence integrable functions which have been properly explained in the above paragraph. Here, we use the shorthand notation suitable for problems with many terms in the variational formulations. The first term reads

\[ \left(v,c(\theta) \frac{\partial h}{\partial t}\right)_\Omega = \int_\Omega v c(\theta) \frac{\partial h}{\partial t} \textrm{d}\Omega \]

and other terms are expressed similarly.

Physical equation

The physical equation is the source of strong nonlinearities and problems with convergence of nonlinear solver and irregularities in the solution. We note that continuity of capillary head (capillary pressure) is not derived from conservation law, but dictated by the regularity of hydraulic conductivity \(K=K(\theta)\).

The philosophy of the finite element formulation presented here is to use approximation base having a priory continuity demanded by the conservation law, whereas not to enforce continuity of capillary pressure head, which is controlled by the regularity of a constitutive law. That allows developing a numerical model for the bigger class of materials, initial and boundary conditions, suitable for analysis of interface effects. Here, continuity of capillary pressure head is enforced posterior, as a consequence of assumed physical model.

Taking the physical equation and testing it with a test function \(\boldsymbol\tau \in H(\nabla\cdot,\Omega)\) we get

\[ \left(\boldsymbol\tau,\frac{1}{K(\theta)} \boldsymbol\sigma\right)_\Omega + (\boldsymbol\tau,\nabla (h-z))_\Omega = 0 \quad \forall \boldsymbol\tau \]

next applying integration by parts we get

\[ \left(\boldsymbol\tau,\frac{1}{K(\theta)} \boldsymbol\sigma\right)_\Omega - (\nabla \cdot \boldsymbol\tau,(h-z))_\Omega + (\mathbf{n} \cdot \boldsymbol\tau,(\overline{h}-z))_{\partial\Omega} = 0 \]

where \(\overline{h}\) is the prescribed capillary pressure on the boundary. Note that

  • Boundary conditions on the capillary head are natural boundary conditions, enforced posterior, i.e. once a system of equations is solved.
  • We do not calculate derivatives over \(h\) and \(v\), and those functions can belong to \(L^2(\Omega)\) space.
  • The regularity of solution is controlled by \(K(\theta)\), that for most real materials will imply continuity of the capillary head, in particular at the interface between them. However, in some cases, the changes of the head are so sharp that it is beneficial to use mix-formulation.
Note
This equation is irregular, hydraulic conductivity can change sharply, as a function of the capillary head. The problem can be regularized by applying Kirchhoff transform, see details here [60]. However such approach is limited, and can be applied for special cases, in particular when no hysteresis is considered. Applying Kirchhoff transform, for steady case problem, transforms a nonlinear problem to a linear problem, and not steady case problem still has a nonlinear capacity term. Such approach enables to calculate large scale problems for unsaturated soils and is highly recommended to be implemented here as an alternative approach.

Semi-discrete linearized system of equations

In MoFEM we do not implement our own Newton method, but use one implemented in PETSc. PETSc Newton solver is implemented in a package of nonlinear solvers SNES. In the nonlinear time dependent problem, SNES is called by TS (time solver). Here we focus on the calculation of residual vector and tangent matrix.

In this section, we focus your attention on discretization in space, without restricting yourself to the particular time integration scheme. That is exclusively managed by TS solver from PETSc. As the title of this section indicates, this formulation is semi-discrete. We apply discretization in space here, but we assume that the function in time is given by some unknown analytical function.

Above we put physical justification for using particular spaces for fluxes, which is \(\boldsymbol\tau,\boldsymbol\sigma \in H(\nabla\cdot,\Omega)\), and capillary pressure head \(u,h \in L^2(\Omega)\). One can show that selection of such approximation spaces is stable, once the problem is discretized (i.e. finite element approximation spaces are used). Numerical solution is stable since the choice of approximation spaces complies with De Rham diagram.

To solve the problem we define residuals

\[ \left\{ \begin{array}{l} r_\tau = (\boldsymbol\tau,\frac{1}{K(\theta)} \boldsymbol\sigma)_\Omega - (\nabla \cdot \boldsymbol\tau,(h-z))_\Omega + (\mathbf{n} \cdot \boldsymbol\tau,(\overline{h}-z))_{\partial\Omega}\\ r_v = (v,c(\theta) \frac{\partial h}{\partial t})_\Omega - (v,\boldsymbol\sigma)_\Omega \end{array} \right. \]

Applying standard procedure where one solves nonlinear system of equations, we expand both equations into Taylor series, for terms \(\boldsymbol\sigma\), \(h\) and \(\frac{\partial h}{\partial t}\), since we have a time dependent problem. Truncating the Taylor series after linear term, we get

\[ \left\{ \begin{array}{l} r^i_\tau + (\boldsymbol\tau,\frac{1}{K^i} \delta\boldsymbol\sigma^{i+1})_\Omega - (\nabla \cdot \boldsymbol\tau,\delta h^{i+1})_\Omega + (\boldsymbol\tau,\frac{\textrm{d}K}{\textrm{d}\theta}|^i\frac{\textrm{d}\theta}{\textrm{d}h}|^i(K^i)^{-2} \boldsymbol\sigma^i) \delta h^{i+1})_\Omega = 0\\ r_v^i + (v,c^i\frac{\partial \delta h}{\partial t}|^{i+1})_\Omega + (v,\frac{\textrm{d}c}{\textrm{d}\theta}|^i\frac{\textrm{d}\theta}{\textrm{d}h}|^i \frac{\partial h}{\partial t}|^i) \delta h^{i+1})_\Omega - (v,\delta\boldsymbol\sigma^{i+1})_\Omega = 0 \end{array} \right. \]

where \(i\) is Newton iteration number. Note that tangent matrices and residuals are evaluated at known iteration \(i\) and unknowns are solved for iteration \(i+1\). Iterations are repeated until the residuals are small in the absolute or relative norm. Once we achieve equilibrium we move to the next time step.

Expressing test and tested function by vectors of basis functions and vectors of degrees of freedom, we have

\[ \boldsymbol\sigma^i_n(\mathbf{x}) = \boldsymbol \phi^\textrm{T}(\mathbf{x}) \mathbf{q}^i_n,\; h^i_n(\mathbf{x},t_n) = \boldsymbol \psi^\textrm{T}(\mathbf{x},t_n) \mathbf{p}^i_n \]

where base vectors \(\boldsymbol \phi\) and \(\boldsymbol \psi\) are for H-div and L2 space respectively. \(n\) is time step. Finally, we get system of linear equations

\[ \left[ \begin{array}{cc} \mathbf{C} & \mathbf{G} \\ \mathbf{H} & \mathbf{A} \end{array} \right] \left\{ \begin{array}{c} \delta \mathbf{q}^{i+1}\\ \delta \mathbf{p}^{i+1} \end{array} \right\} = \left[ \begin{array}{c} \mathbf{r}^i_\tau\\ \mathbf{r}^i_v \end{array} \right] \]

where vectors of unknowns are updated as follows

\[ \mathbf{q}^{i+1}_{n+1} = \mathbf{q}_n + \Delta \mathbf{q}_{n+1}^i + \delta \mathbf{q}^{i+1}\quad \mathbf{p}^{i+1}_{n+1} = \mathbf{p}_n + \Delta \mathbf{p}_{n+1}^i + \delta \mathbf{p}^{i+1} \]

Tangent matrices and vectors are implemented in following operators

Time discretization

In MoFEM, we do not implement time discretization algorithms unless we would like to do something novel and non-standard, and we would rather recommend implementing such an algorithm using PETSc time solver shell rather than doing so directly in MoFEM. Detailed description of how to use time solver (TS) in PETSc can be found in link, see chapter 6.

The constructions of time discretized problem are managed transparently for the user. If you are interested in details, see MoFEM::TsCtx class and auxiliary functions like MoFEM::TsSetIFunction, MoFEM::TsSetIJacobian and MoFEM::TsMonitorSet. Those functions are called by the discrete manager (DM) which is linked to time solver.

In the previous section, we transform PDE, by applying space discretization, into the system of linearized ordinary differential equations (ODE). In the following description, we transform the system of ODEs into a system of linear equations. In our particular problem, we need to calculate the rate of capillary head, which is discretized in time and space by

\[ h(\mathbf{x},t) = \boldsymbol \psi(\mathbf{x},t)^\textrm{T} \mathbf{p} = [\boldsymbol \xi(t).\boldsymbol{\tilde{\psi}}(\mathbf{x})]^\textrm{T} \mathbf{p} \]

where \([\xi(t).\boldsymbol{\tilde{\psi}}(\mathbf{x})]\) is element by element product of two vectors. With that at hand we can calculate rate of hydraulic head

\[ \frac{\partial h}{\partial t}(\mathbf{x},t) = \left[ \frac{\textrm{d}\boldsymbol\xi}{\textrm{d}t} (t).\boldsymbol{\tilde{\psi}}(\mathbf{x}) \right]^\textrm{T} \mathbf{p} \]

With above at hand, matrix \(\mathbf{C}\) where time derivative is present has the following form

\[ \mathbf{C} = \left(\boldsymbol\psi^\textrm{T}, \left( c^i \frac{\partial \boldsymbol\xi}{\partial t}+ \frac{\textrm{d}c}{\textrm{d}\theta}|^i\frac{\textrm{d}\theta}{\textrm{d}h}|^i \frac{\partial h}{\partial t}|^i \right) \boldsymbol{\tilde\psi}\right)_\Omega \]

Note that for any ODE integration method, the approximation of \(\frac{\partial h}{\partial t}\) is by linear function, hence

\[ \frac{\partial \boldsymbol\xi}{\partial t} = (shift) \]

For example, iterative change of capillary pressure head, when backwards Euler's method is applied, \((shift) = 1/\Delta t\), what can be derived as follows

\[ \left(\frac{\partial \delta h}{\partial t}\right)^{i+1}_{n+1} = \left(\frac{\partial \delta h}{\partial \delta \mathbf{p}}\frac{\partial \delta \mathbf{p}}{\partial t} \right)^{i+1}_{n+1} = \left( \boldsymbol{\tilde \psi} \delta \mathbf{p}^{i+1}\right) \left( 1/\Delta t \right) = \left( \boldsymbol{\tilde \psi} \delta \mathbf{p}^{i+1} \right) (shift) \]

Such an approach allows for code generalisation such that finite element formulation which concerns discretization in space, does not depend on discretization in time. That makes it possible to switch between time integration schemes without changing implementation, see list of time integration schemes in link, table 10.

Above is exploited in MixTransport::UnsaturatedFlowElement::OpVU_L2L2::doWork, where shift is applied at integration points as follows

for(int gg = 0;gg!=nb_gauss_pts;gg++) {
// get integration weight and multiply by element volume
double alpha = t_w*vol*scale;
// evaluate material model at integration points
// to calculate capacity and tangent of capacity term
block_data->h = t_h;
block_data->h_t = t_h_t;
block_data->x = t_coords(0);
block_data->y = t_coords(1);
block_data->z = t_coords(2);
CHKERR block_data->calC();
CHKERR block_data->calDiffC();
const double C = block_data->C;
const double diffC = block_data->diffC;
// assemble local entity tangent matrix
FTensor::Tensor0<double*> t_a(&*nN.data().begin());
// iterate base functions on rows
for(int kk = 0;kk!=nb_row;kk++) {
// get first base function on column at integration point gg
FTensor::Tensor0<double*> t_n_col = col_data.getFTensor0N(gg,0);
// iterate base functions on columns
for(int ll = 0;ll!=nb_col;ll++) {
// assemble elements of local matrix
t_a += (alpha*(C*ts_a+diffC*t_h_t))*t_n_row*t_n_col;
++t_n_col; // move to next base function on column
++t_a; // move to next element in local tangent matrix
}
++t_n_row; // move to next base function on row
}
++t_w; // move to next integration weight
++t_coords; // move to next coordinate at integration point
++t_h; // move to next capillary head at integration point
++t_h_t; // move to next capillary head rate at integration point
}

where \(\textrm{ts_a} = (shift)\). Note that evaluation of capillary head DOFs, i.e. \(\frac{\partial \mathbf{p}}{\partial t}\) is managed exclusively by PETSc and depends on used time integration shame.

Implementation

Declaration of fields, finite elements and problem

In method MixTransport::UnsaturatedFlowElement::addFields, we declare and define fields on entities and set order of approximation as follows

//Fields
CHKERR mField.add_field(fluxes,HDIV,DEMKOWICZ_JACOBI_BASE,1);
CHKERR mField.add_field(values,L2,AINSWORTH_LEGENDRE_BASE,1);
CHKERR mField.add_field(values+"_t",L2,AINSWORTH_LEGENDRE_BASE,1);
//add entities to field
if(it->getName().compare(0,4,"SOIL")!=0) continue;
CHKERR mField.add_ents_to_field_by_type(
dMatMap[it->getMeshsetId()]->tEts,MBTET,fluxes
);
CHKERR mField.add_ents_to_field_by_type(
dMatMap[it->getMeshsetId()]->tEts,MBTET,values
);
CHKERR mField.add_ents_to_field_by_type(
dMatMap[it->getMeshsetId()]->tEts,MBTET,values+"_t"
);
}
CHKERR mField.set_field_order(0,MBTET,fluxes,order+1);
CHKERR mField.set_field_order(0,MBTRI,fluxes,order+1);
CHKERR mField.set_field_order(0,MBTET,values,order);
CHKERR mField.set_field_order(0,MBTET,values+"_t",order);

Note that we set field space independently from the approximation base. We can have different recipes to construct approximation base, for example [1] and [30]. Note, to get a solvable system of linear equations, the pressure head approximation is one order lower than the approximation for fluxes. Here for simplicity, we set homogeneous approximation order, however, implementation can be easily extended to the case where approximation order is locally increased near interfaces or boundary where pressure head is applied.

In a similar way, we declare and define finite elements in MixTransport::UnsaturatedFlowElement::addFiniteElements, as follows

// Define element "MIX". Note that this element will work with fluxes_name and
// values_name. This reflect bilinear form for the problem
CHKERR mField.add_finite_element("MIX",MF_ZERO);
CHKERR mField.modify_finite_element_add_field_row("MIX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_col("MIX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_row("MIX",values_name);
CHKERR mField.modify_finite_element_add_field_col("MIX",values_name);
CHKERR mField.modify_finite_element_add_field_data("MIX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_data("MIX",values_name);
CHKERR mField.modify_finite_element_add_field_data("MIX",values_name+"_t");
if(it->getName().compare(0,4,"SOIL")!=0) continue;
CHKERR mField.add_ents_to_finite_element_by_type(
dMatMap[it->getMeshsetId()]->tEts,MBTET,"MIX"
);
}
// Define element to integrate natural boundary conditions, i.e. set values.
CHKERR mField.add_finite_element("MIX_BCVALUE",MF_ZERO);
CHKERR mField.modify_finite_element_add_field_row("MIX_BCVALUE",fluxes_name);
CHKERR mField.modify_finite_element_add_field_col("MIX_BCVALUE",fluxes_name);
CHKERR mField.modify_finite_element_add_field_data("MIX_BCVALUE",fluxes_name);
CHKERR mField.modify_finite_element_add_field_data("MIX_BCVALUE",values_name);
if(it->getName().compare(0,4,"HEAD")!=0) continue;
CHKERR mField.add_ents_to_finite_element_by_type(
bcValueMap[it->getMeshsetId()]->eNts,MBTRI,"MIX_BCVALUE"
);
}
// Define element to apply essential boundary conditions.
CHKERR mField.add_finite_element("MIX_BCFLUX",MF_ZERO);
CHKERR mField.modify_finite_element_add_field_row("MIX_BCFLUX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_col("MIX_BCFLUX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_data("MIX_BCFLUX",fluxes_name);
CHKERR mField.modify_finite_element_add_field_data("MIX_BCFLUX",values_name);
if(it->getName().compare(0,4,"FLUX")!=0) continue;
CHKERR mField.add_ents_to_finite_element_by_type(
bcFluxMap[it->getMeshsetId()]->eNts,MBTRI,"MIX_BCFLUX"
);
}

Note that we create three elements including "MIX", "MIX_BCVALUE" and "MIX_BCFLUX", to evaluate fields in volume, on the boundary where natural conditions are applied and where essential conditions are applied, respectively.

Both fields and finite elements are defined on part of the mesh, i.e. entities set, where mesh block name starts with first four letters "SOIL". In case of "MIX_BCVALUE" and "MIX_BCFLUX" where blocks name having first for letters "HEAD" and "FLUX", respectively. A user can define multiple blocks and attach a material model, material parameters and initial conditions independently to each of them independently.

In a similar way, other types of elements can be added to the formulation, for example, we can create an evaporation element on some parts of the boundary, or one can extend formulation with other mechanical and non-mechanical fields. For example, one can add heat conduction and solve a coupled problem with freezing and thawing processes.

In method MixTransport::UnsaturatedFlowElement::buildProblem, we create problem and Discrete Manager operating on that problem

// create DM instance
CHKERR DMCreate(PETSC_COMM_WORLD,&dM);
// setting that DM is type of DMMOFEM, i.e. MOFEM implementation manages DM
CHKERR DMSetType(dM,"DMMOFEM");
// mesh is portioned, each process keeps only part of problem
// creates problem in DM, "MIX" is name of problem
CHKERR DMMoFEMCreateMoFEM(dM,&mField,"MIX",ref_level);
// discretized problem creates square matrix (that makes some optimizations)
// set DM options from command line
CHKERR DMSetFromOptions(dM);
// add finite elements
CHKERR DMMoFEMAddElement(dM,"MIX_BCFLUX");
CHKERR DMMoFEMAddElement(dM,"MIX_BCVALUE");
// constructor data structures
CHKERR DMSetUp(dM);

Note that problem in DM is created by setting finite elements on which it operates.

Creating finite element instances

Definition of the problem enables construction of a matrix since the matrix connectivity is derived from problem definition. To fill the matrix with the numbers, you need to implement finite elements. In fact, you can have more than one implementation of the same problem.

Once you have problem defined, the developer is released from the need of managing complexities related to management of DOFs, iteration over elements, matrix assembly, etc. He/she can focus on the integration of local entity matrices, as shown in Semi-discrete linearized system of equations.

MoFEM provides technology whith simplifies implementation of the element, enabling the developer to break a complex problem into smaller tasks, which are easier to implement, debug and reuse in different contexts, this has been discussed in several tutorials already. Assembly of residual vectors and tangent matrices is made with the use of the so called user data operators (UDO). For example, the sequence of user data operators of finite element instance to assemble tangent matrix is shown in Figure 4.

Figure 4. Sequence of operators on instance of MIX element

We have already discussed the last four operators in sequence for feVolLhs finite element instance, those are used to assemble tangent matrix blocks, i.e. \(\mathbf{C}\), \(\mathbf{G}\), \(\mathbf{H}\) and \(\mathbf{A}\). The first three operators are used to evaluate fields at integration points, i.e. capillary head, flux and rate of capillary head. Note that the first three operators have been reused from other tutorials.

In this problem, we use two generic implementations of finite element, MoFEM::VolumeElementForcesAndSourcesCore and MoFEM::FaceElementForcesAndSourcesCore, for integrating fields on volumes and faces. Finite element instances are iterated over a particular element in the problem, and for each entity on finite element entity, the sequence of UDO is called.

We use smart pointers to create the finite element instances, which gives the code flexibility and a safe memory management. The finite element instances are created in method MixTransport::UnsaturatedFlowElement::setFiniteElements as follows

feFaceBc = boost::shared_ptr<ForcesAndSourcesCore>(new FaceElementForcesAndSourcesCore(mField));
feFaceRhs = boost::shared_ptr<ForcesAndSourcesCore>(new FaceElementForcesAndSourcesCore(mField));
feVolInitialPc = boost::shared_ptr<ForcesAndSourcesCore>(new VolumeElementForcesAndSourcesCore(mField));
feVolLhs = boost::shared_ptr<ForcesAndSourcesCore>(new VolumeElementForcesAndSourcesCore(mField));
feVolRhs = boost::shared_ptr<ForcesAndSourcesCore>(new VolumeElementForcesAndSourcesCore(mField));

Next, we set the integration rule, as has been discussed in tutorial COR-2: Solving the Poisson equation as follows

// set integration rule to elements
feFaceBc->getRuleHook = face_rule;
feFaceRhs->getRuleHook = face_rule;
feVolInitialPc->getRuleHook = vol_rule;
feVolLhs->getRuleHook = vol_rule;
feVolRhs->getRuleHook = vol_rule;

In addition, we add hooks to functions which are run at the beginning and the end of the loop over a particular element. Those functions are used to preprocess and postprocess the matrix assembly. Those pre-processing and post-processing hooks are added as follows

feVolRhs->preProcessHook = preProcessVol(*this,feVolRhs);
feVolLhs->preProcessHook = preProcessVol(*this,feVolLhs);
feVolRhs->postProcessHook = postProcessVol(*this,feVolRhs);
feVolLhs->postProcessHook = postProcessVol(*this,feVolLhs);

We use classes MixTransport::UnsaturatedFlowElement::preProcessVol and MixTransport::UnsaturatedFlowElement::postProcessVol to enforce essential boundary conditions. The method of enforcing essential boundary conditions is discussed in COR-0: Mixed formulation and integration on skeleton (h-adaptivity). In addition, in function MixTransport::UnsaturatedFlowElement::postProcessVol::operator()(), we scatter the vector of rate of capillary pressure on the field data. Since the rate of capillary head is not primary unknown but linear function of solution at current and previous steps, it is evaluated by PETSc for particular integration scheme.

CHKERR fePtr->mField.getInterface<VecManager>()->setOtherLocalGhostVector(
fePtr->problemPtr,"VALUES",string("VALUES")+"_t",
ROW,fePtr->ts_u_t,INSERT_VALUES,SCATTER_REVERSE
);

Time solver provides vector of DOFs, \(\left(\frac{\textrm{d}\mathbf{p}}{\textrm{d}t}\right)^{i+1}_{n+1}\) at integration \(i+1\) and time step \(n+1\), and the above code scatters the vector values on the mesh, such that values of capillary head at integration points are evaluated early, i.e. \(\frac{\textrm{d}h}{\textrm{d}t}|^{i+1}_{n+1}\). Capillary head DOFs are sub-vectors of fePtr->ts_u_t.

Adding operators to elements

The user data operators are added to the finite element calculating tangent matrix as follows

// set tangent matrix finite element operators
feVolLhs->getOpPtrVector().push_back(
new OpCalculateScalarFieldValues(string("VALUES")+"_t",headRateAtGaussPts,MBTET)
);
feVolLhs->getOpPtrVector().push_back(new OpValuesAtGaussPts(*this,"VALUES"));
feVolLhs->getOpPtrVector().push_back(new OpFluxDivergenceAtGaussPts(*this,"FLUXES"));
feVolLhs->getOpPtrVector().push_back(new OpTauDotSigma_HdivHdiv(*this,"FLUXES"));
feVolLhs->getOpPtrVector().push_back(new OpVU_L2L2(*this,"VALUES"));
feVolLhs->getOpPtrVector().push_back(new OpVDivSigma_L2Hdiv(*this,"VALUES","FLUXES"));
feVolLhs->getOpPtrVector().push_back(new OpDivTauU_HdivL2(*this,"FLUXES","VALUES"));

and similarly for other elements, evaluating the boundary conditions and the vector of residuals. For more details we refer to tutorial FUN-0: Hello world.

In addition, finite element instances are created to post-process results and to run time stepping monitor, see code in MixTransport::UnsaturatedFlowElement::setFiniteElements.

Adding finite element instances to DM

Once we have created finite element instances, in MixTransport::UnsaturatedFlowElement::setFiniteElements, we add finite instances to DM manager, such that the system of equations could be assembled. This is simply done by

CHKERR DMMoFEMTSSetIFunction(dM,"MIX_BCVALUE",feFaceRhs,null,null);
CHKERR DMMoFEMTSSetIFunction(dM,"MIX",feVolRhs,null,null);
CHKERR DMMoFEMTSSetIJacobian(dM,"MIX",feVolLhs,null,null);

Those functions are specific to MoFEM implementation, they have been implemented based on PETSc documentation, link, see Chapter 6.

Solving problem using TS

Finally, we can solve the problem by creating TS solver and link it to DM as follows

// Create time solver
TS ts;
CHKERR TSCreate(PETSC_COMM_WORLD,&ts);
// Use backward Euler method
CHKERR TSSetType(ts,TSBEULER);
// Not test functions to evalye matrix and rigth hand side, TS ask DM
// for doing that
CHKERR TSSetIFunction(ts,F,PETSC_NULL,PETSC_NULL);
CHKERR TSSetIJacobian(ts,Aij,Aij,PETSC_NULL,PETSC_NULL);
// Set final time
double ftime = 1;
CHKERR TSSetDuration(ts,PETSC_DEFAULT,ftime);
// Setup solver from commabd line
CHKERR TSSetFromOptions(ts);
// Set DM to TS
CHKERR TSSetDM(ts,dM);
#if PETSC_VERSION_GE(3,7,0)
CHKERR TSSetExactFinalTime(ts,TS_EXACTFINALTIME_STEPOVER);
#endif
// Set-up monitor
TsCtx *ts_ctx;
CHKERR TSMonitorSet(ts,TsMonitorSet,ts_ctx,PETSC_NULL);
CHKERR TSSolve(ts,D);

Note that TS calls the finite elements instance by DM, similarly how SNES (Newton solver) calls finite elements in COR-5: A nonlinear Poisson equation, or KSP (Krylov solver) calls finite elements in COR-2: Solving the Poisson equation. The above is implemented in MixTransport::UnsaturatedFlowElement::solveProblem, where prior to solution, initial conditions are calculated, and statistics at the end printed to the terminal.

Application code

Application code is unsaturated_transport.cpp, which calls sequence of functions

// Initialise
MoFEM::Core::Initialize(&argc,&argv,(char *)0,help);
// Register materials
CHKERR RegisterMaterials()();
// Register MOFEM DM implementation
CHKERR DMRegister_MoFEM("DMMOFEM"); // register MoFEM DM in PETSc
try {
// Create moab instance
moab::Core mb_instance;
moab::Interface& moab = mb_instance;
// Read mesh
...
// Create mofem interface
MoFEM::Core core(moab);
MoFEM::Interface& m_field = core;
// Create unsaturated flow structures
UnsaturatedFlowElement uf(m_field);
\\ Read data from meshsets
...
CHKERR uf.addFields("VALUES","FLUXES",order);
CHKERR uf.addFiniteElements("FLUXES","VALUES");
zero_flux_ents,MBTRI,"MIX_BCFLUX"
);
CHKERR uf.buildProblem();
CHKERR uf.createMatrices();
CHKERR uf.setFiniteElements();
CHKERR uf.calculateEssentialBc();
CHKERR uf.calculateInitialPc();
CHKERR uf.solveProblem();
CHKERR uf.destroyMatrices();

To do

Todo:

Add example with hp-adaptivity

Implement block-solver and multigrid

Apply Kirchhoff transform

Add boundary condition for evaporation

Add air phase and mechanical filed

Add diffusion and other physical phenomena

Make example with flux history or head history. That is implemented but no example is added

Add diffusion and other physical phenomenas

MoFEMFunctionReturnHot
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:447
MoFEM::CoreTmp< 0 >
Core (interface) class.
Definition: Core.hpp:82
L2
@ L2
field with C-1 continuity
Definition: definitions.h:88
help
static char help[]
Definition: activate_deactivate_dofs.cpp:13
MoFEM::Exceptions::MoFEMErrorCode
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
Definition: Exceptions.hpp:56
MoFEM::CoreTmp< 0 >::Finalize
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
Definition: Core.cpp:112
ts_ctx
MoFEM::TsCtx * ts_ctx
Definition: level_set.cpp:1932
MoFEM::DMMoFEMAddElement
PetscErrorCode DMMoFEMAddElement(DM dm, std::string fe_name)
add element to dm
Definition: DMMoFEM.cpp:501
order
constexpr int order
Definition: dg_projection.cpp:18
MoFEM::DeprecatedCoreInterface
Deprecated interface functions.
Definition: DeprecatedCoreInterface.hpp:16
ROW
@ ROW
Definition: definitions.h:123
MoFEM::Interface
DeprecatedCoreInterface Interface
Definition: Interface.hpp:1975
MoFEM::TsMonitorSet
PetscErrorCode TsMonitorSet(TS ts, PetscInt step, PetscReal t, Vec u, void *ctx)
Set monitor for TS solver.
Definition: TsCtx.cpp:259
MoFEM::CoreInterface::add_ents_to_finite_element_by_type
virtual MoFEMErrorCode add_ents_to_finite_element_by_type(const EntityHandle entities, const EntityType type, const std::string &name, const bool recursive=true)=0
add entities to finite element
CHKERR
#define CHKERR
Inline error check.
Definition: definitions.h:535
ContactOps::scale
double scale
Definition: EshelbianContact.hpp:22
MoFEM::DMMoFEMTSSetIJacobian
PetscErrorCode DMMoFEMTSSetIJacobian(DM dm, const std::string fe_name, boost::shared_ptr< MoFEM::FEMethod > method, boost::shared_ptr< MoFEM::BasicMethod > pre_only, boost::shared_ptr< MoFEM::BasicMethod > post_only)
set TS Jacobian evaluation function
Definition: DMMoFEM.cpp:857
h
double h
Definition: photon_diffusion.cpp:60
MoFEM::DMRegister_MoFEM
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
Definition: DMMoFEM.cpp:47
MoFEM::DMMoFEMCreateMoFEM
PetscErrorCode DMMoFEMCreateMoFEM(DM dm, MoFEM::Interface *m_field_ptr, const char problem_name[], const MoFEM::BitRefLevel bit_level, const MoFEM::BitRefLevel bit_mask=MoFEM::BitRefLevel().set())
Must be called by user to set MoFEM data structures.
Definition: DMMoFEM.cpp:118
FaceElementForcesAndSourcesCore
convert.n
n
Definition: convert.py:82
adouble
MoFEM::CoreTmp< 0 >::Initialize
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
Definition: Core.cpp:72
MF_ZERO
@ MF_ZERO
Definition: definitions.h:98
CATCH_ERRORS
#define CATCH_ERRORS
Catch errors.
Definition: definitions.h:372
DEMKOWICZ_JACOBI_BASE
@ DEMKOWICZ_JACOBI_BASE
Definition: definitions.h:66
FTensor::Tensor0
Definition: Tensor0.hpp:16
_IT_CUBITMESHSETS_BY_SET_TYPE_FOR_LOOP_
#define _IT_CUBITMESHSETS_BY_SET_TYPE_FOR_LOOP_(MESHSET_MANAGER, CUBITBCTYPE, IT)
Iterator that loops over a specific Cubit MeshSet having a particular BC meshset in a moFEM field.
Definition: MeshsetsManager.hpp:71
MoFEM::Core
CoreTmp< 0 > Core
Definition: Core.hpp:1094
BLOCKSET
@ BLOCKSET
Definition: definitions.h:148
AINSWORTH_LEGENDRE_BASE
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
Definition: definitions.h:60
MoFEM::DMMoFEMTSSetIFunction
PetscErrorCode DMMoFEMTSSetIFunction(DM dm, const char fe_name[], MoFEM::FEMethod *method, MoFEM::BasicMethod *pre_only, MoFEM::BasicMethod *post_only)
set TS implicit function evaluation function
Definition: DMMoFEM.cpp:804
MoFEM::DMMoFEMGetTsCtx
PetscErrorCode DMMoFEMGetTsCtx(DM dm, MoFEM::TsCtx **ts_ctx)
get MoFEM::TsCtx data structure
Definition: DMMoFEM.cpp:1146
ReactionDiffusionEquation::D
const double D
diffusivity
Definition: reaction_diffusion.cpp:20
m
FTensor::Index< 'm', 3 > m
Definition: shallow_wave.cpp:80
MoFEMFunctionBeginHot
#define MoFEMFunctionBeginHot
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:440
HDIV
@ HDIV
field with continuous normal traction
Definition: definitions.h:87
F
@ F
Definition: free_surface.cpp:394
MoFEM::DMMoFEMSetIsPartitioned
PetscErrorCode DMMoFEMSetIsPartitioned(DM dm, PetscBool is_partitioned)
Definition: DMMoFEM.cpp:1127