Elmer Models Manual
Elmer Models Manual
Copyright information
The original copyright of this document belongs to CSC – IT Center for Science, Finland, 1995–2019. This
document is licensed under the Creative Commons Attribution-No Derivative Works 3.0 License. To view a
copy of this license, visit http://creativecommons.org/licenses/by-nd/3.0/.
Elmer program is free software; you can redistribute it and/or modify it under the terms of the GNU
General Public License as published by the Free Software Foundation; either version 2 of the License, or (at
your option) any later version. Elmer software is distributed in the hope that it will be useful, but without
any warranty. See the GNU General Public License for more details.
Elmer includes a number of libraries licensed also under free licensing schemes compatible with the
GPL license. For their details see the copyright notices in the source files.
All information and specifications given in this document have been carefully prepared by the best ef-
forts of CSC, and are believed to be true and accurate as of time writing. CSC assumes no responsibility or
liability on any errors or inaccuracies in Elmer software or documentation. CSC reserves the right to modify
Elmer software and documentation without notice.
2
Contents
Table of Contents 3
2 Navier-Stokes Equations 19
3 Advection-Diffusion Equation 29
4 Advection-Reaction Equation 35
7 Finite Elasticity 54
14 Wave Equation 97
3
CONTENTS 4
Index 335
Part I
Heat Equation
1.1 Introduction
Heat equation results from the requirement of energy conservation. In addition the Fourier’s law is used to
model the heat conduction. The linearity of the equation may be ruined by temperature dependent thermal
conductivity, or by heat radiation.
1.2 Theory
1.2.1 Governing Equations
The incompressible heat equation is expressed as
∂T
ρcp + (~u · ∇)T − ∇ · (k∇T ) = τ : ε + ρh, (1.1)
∂t
where ρ is the density, cp the heat capacity at constant pressure, T the temperature, ~u the convection velocity,
k the heat conductivity and h is source of heat. The term τ : ε is the frictional viscous heating, which is
negligible in most cases. For Newtonian fluids, the viscous part of the stress tensor is
τ = 2µε, (1.2)
T = Tb . (1.13)
where the subscripts i and k refer to surfaces i and k, and the parameters Ai and Ak to the specific surface
areas. The factors Gik are Gebhardt factors, and N represents the total number of radiating surfaces present
in the system. Emissivities are assumed to be constant on each surface.
The heat equation is nonlinear when radiation is modelled. The nonlinear term in the boundary condition
(1.15) can be linearized as
T 4 − Text
4
≈ (T 3 + Text T 2 + Text
2 3
T + Text )(T − Text ), (1.17)
where Pi is the power of the source and αi is vector of geometrical factors giving the portion of energy
incident on a given boundary element. The factors take into account the orientation of the boundary element
with respect to the sources and shadowing. Note that this type of source is not available in cylindrically
symmetric cases.
One may also give an additional heat flux term as
∂T
−k = q. (1.19)
∂n
1.3 Keywords
Constants
Stefan Boltzmann Real
The value of the Stefan-Boltzmann constant needed for thermal radiation.
Simulation
The simulation section gives the case control data:
Simulation Type String
Heat equation may be either Transient or Steady State.
Coordinate System String
Defines the coordinate system to be used, one of: Cartesian 1D, Cartesian 2D, Cartesian
3D, Polar 2D, Polar 3D, Cylindric, Cylindric Symmetric and Axi
Symmetric.
Timestepping Method String
Possible values of this parameter are Newmark (an additional parameter Newmark Beta must
be given), BDF (BDF Order must be given). Also as a shortcut to Newmark-method with
values of Beta= 0.0, 0.5, 1.0 the keywords Explicit Euler, Crank-Nicolson, and
Implicit Euler may be given respectively. The recommended choice for the first order
time integration is the BDF method of order 2.
BDF Order Integer
Value may range from 1 to 5.
Newmark Beta Real
Value in range from 0.0 to 1.0. The value 0.0 equals to the explicit Euler integration method and
the value 1.0 equals to the implicit Euler method.
Solver solver id
The solver section defines equation solver control variables. Most of the possible keywords – related
to linear algebra, for example – are common for all the solvers and are explained elsewhere.
Equation String [Heat Equation]
The name of the equation. If it is Heat Equation then an old logic will define the following
keyword.
Procedure File "HeatSolve" "HeatSolver"
The name of the procedure for the heat equation. This must be given as stated here.
Variable String [Temperature]
This may be of any name for temperature as long at it is used consistently elsewhere. The default
name is Temperature.
Nonlinear System Convergence Tolerance Real
The criterion to terminate the nonlinear iteration after the relative change of the norm of the field
variable between two consecutive iterations is small enough
where λ is the factor given with this keyword. The default value for the relaxation factor is unity.
Steady State Convergence Tolerance Real
With this keyword a equation specific steady state or coupled system convergence tolerance is
given. All the active equation solvers must meet their own tolerances before the whole system is
deemed converged. The tolerance criterion is:
Radiating sources ("radiators") are activated using the following keywords (see also the "Boundary
Conditions" section). Also some of the view factor shadowing subdivision/accuracy keywords are
used when resolving the shadowing between the radiation sources and participating boundary surfaces.
In some cases the geometry or the emissivities of the radiation boundaries change. This may require
the recomputation of the view factors and Gebhardt factors. For that purpose also dynamic computa-
tion of the factors is enabled and it is controlled by the keywords below. The radiation factors are also
automatically computed if no files for the factors are given although radiation boundaries exist.
hits/maxrays. This keyword is also used for "radiators" when resolving shadowing between
boundary elements and the radiating sources. The default is 1.
Viewfactor Factor Tolerance Real
In 2D and 3D cases the shadowing is resolved by casting rays between elements. This setting
gives the maximum of the computed facto which is accepted for a boundary patch even if shad-
owing is undetermined for the patch (the number of hits is larger than zero or fewer than number
of rays). shadowing between boundary elements and the radiating sources. The default is 1.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies.
Heat Equation Logical
If set to True, solve the heat equation.
Convection String
The type of convection to be used in the heat equation, one of: None, Computed, Constant.
Phase Change Model String
One of: None, Spatial 1, Spatial 2 and Temporal. Note that when solidification
is modelled, the enthalpy-temperature- and viscosity-temperature-curves must be defined in the
material section.
Body Forces bf id
The body force section may be used to give additional force terms for the equations. The following
keywords are recognized by the base solver:
Heat Source Real
A heat source h for the heat equation may be given with this keyword. Note that by default the
heating is given per unit mass, not unit volume.
Friction Heat Logical
Currently redundant keyword, the frictional heating hf is automatically added.
Joule Heat Logical
If set True, triggers use of the electromagnetic heating. This keywords accounts for the heating
of many different solvers; electrostatics, magnetostatics, and induction equation.
Smart Heater Control Logical
Sometimes the predescribed heat source does not lead to the desired temperature. Often the
temperature is controlled by a feedback and therefore a similar heater control in the simulation
may give more realistic results. This flag makes sets the smart heater control on for the given
body force.
Integral Heat Source Real
This keyword activates a normalization of the Heat Source so that the integral heating power
is the desired objective.
Temperature Lower Limit Real
The lower limit for temperature that is enforced iteratively when the soft limiters are applied.
Temperature Upper Limit Real
The upper limit for temperature that is enforced iteratively when the soft limiters are applied.
There are four optional keywords related to the Pennes’ Bioheat equation term that model the perfusion
process.
Initial Condition ic id
The initial condition section may be used to set initial values for temperature.
Temperature Real
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be effective when heat equation is solved.
Density Real
The value of density is given with this keyword. The value may be constant, or variable. For the
compressible flow, the density is computed internally, and this keyword has no effect.
Enthalpy Real
Note that, when using the solidification modelling, an enthalpy-temperature curve must be given.
The enthalpy is derived with respect to temperature to get the value of the effective heat capacity.
Viscosity Real
Viscosity is needed if viscous heating is taken into account. When using the solidification mod-
elling, a viscosity-temperature curve must be given. The viscosity must be set to high enough
value in the temperature range for solid material to effectively set the velocity to zero.
Heat Capacity Real
The value of heat capacity in constant pressure cp is given with this keyword. The value may
be constant, or variable. For the phase change model, this value is modified according to rules
given in the theory section.
Heat Conductivity Real
The value of heat conductivity k is given with this keyword. The value may be a constant or
variable.
Convection Velocity i Real
Convection velocity i= 1, 2, 3 for the constant convection model.
Compressiblity Model Real
This setting may be used to set the compressibilty model for the flow simulations. Choices are
Incompressible and Perfect Gas. If set to the latter there may be mechanical work
performed by the heating. Then also the settings Reference Pressure and Specific
Heat Ratio must also be given.
Reference Pressure Real
With this keyword a reference level of pressure may be given.
Specific Heat Ratio Real
The ratio of specific heats (in constant pressure versus in constant volume) may be given with this
keyword. The default value of this setting is 5/3, which is the appropriate value for monoatomic
ideal gas.
Emissivity Real
Emissivity of the radiating surface, required for radiation model is present. If the emissivity is
not found in the radiating boundary only then will it be looked at the material properties of the
parent elements. Often locating the emissivity here makes the case definition more simple.
Transmissivity Real
For the diffuse gray radiation model also transmissivity of the surface may be provided. It gives
the part of the energy that is lost as it passes through the wall. By default transmissivity is zero.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types. In
heat equation we may set the temperature directly by Dirichlet boundary conditions or use different
flux conditions for the temperature. The natural boundary condition of heat equation is zero flux
condition.
Temperature Real
Heat Flux BC Logical
Must be set to True, if heat flux boundary condition is present.
Heat Flux Real
A user defined heat flux term.
Heat Transfer Coefficient Real
Defines the parameter α in the heat flux boundary condition of the type
∂T
−k = α(T − Text ).
∂n
External Temperature Real
Defines the variable for ambient temperature Text in the previous equation.
Radiation String
The type of radiation model for this boundary, one of: None, Idealized, Diffuse Gray.
Radiation Boundary Integer
If there are many closures with radiation boundary conditions that do not see each other the
view factors may be computed separately. This keyword is used to group the boundaries to
independent sets. The default is one.
Radiation Boundary Open Logical
The closures may be partially open. Then no normalization of the view factors is enforced. The
missing part of the radiation angle is assumed to be ideal radiation. Therefore if this option is
enforced also the parameter External Temperature must be given.
Radiation External Temperature Real
In case the external temperature related to the heat transfer coefficient is different than that related
to the radiation they cannot be given with the same keyword. For this purpose an alternative
keyword is provided for radiation problems. This is used instead if it is present.
Emissivity Real
Emissivity of the radiating surface, required for radiation model is present. If the emissivity is
not found here it will be searched at the parent elements.
Transmissivity Real
If the transmissivity is not found here it will be searched at the parent elements.
Radiator BC Logical
This boundary is getting radiated by "radiators". The surface normal is determined similarly to
diffuse gray radiation model (see "Radiation Target Body" -keyword). Default 1 "False".
Radiation Target Body Integer
This flag may be used to set the direction of the outward pointing normal. This is used when
computing view factors. If the value of emissivity is given in the Material section, then
the normal is assumed to point outwards from the material having the property. If the value
of emissivity is given in the Boundary Condition section, then the direction of normal is
ambiguous. This keyword may then be used to give the direction of the normal by specifying the
material to which the normal points to. Value -1 means that the normal is pointing outwards to
non-existing material (this is also the default). Hence, this keyword should be given on internal
ambiguous boundaries or on external boundaries where we are radiating into the domain.
Smart Heater BoundaryLogical If the smart heater is activated the point for monitoring the tempera-
ture is the point with maximum x-coordinate on the boundary where this keyword is set True.
Alternatively the logical variable Phase Change is looked for.
Smart Heater TemperatureReal The desired temperature for the smart heater system is set by this
keyword. Alternatively the real variable Melting Point may be used.
Navier-Stokes Equations
2.1 Introduction
In solid and liquid materials heat transfer and viscous fluid flow are governed by heat and Navier-Stokes
equations, which can be derived from the basic principles of conservation of mass, momentum and energy.
Fluid can be either Newtonian or non-Newtonian. In the latter case the consideration in Elmer is limited to
purely viscous behaviour with the power-law model.
In the following we present the governing equations of fluid flow, heat transfer and stresses in elastic
material applied in Elmer. Also the most usual boundary conditions applied in computations are described.
2.2 Theory
The momentum and continuity equations can be written as
∂~u
ρ + (~u · ∇)~u − ∇ · σ = ρf~, (2.1)
∂t
and
∂ρ
+ (~u · ∇)ρ + ρ(∇ · ~u) = 0, (2.2)
∂t
where µ is the viscosity, p is the pressure, I the unit tensor and ε the linearized strain rate tensor, i.e.
1 ∂ui ∂uj
εij = + . (2.4)
2 ∂xj ∂xi
The density of an ideal gas depends on the pressure and temperature through the equation of state
p
ρ= , (2.5)
RT
∇ · ~u = 0. (2.8)
Enforcing the constraint (2.8) in (2.1), (2.2) and (2.3), the equations reduce to the Navier-Stokes equations
∂~u
ρ + (~u · ∇)~u − ∇ · (2µε) + ∇p = ρf~, (2.9)
∂t
∇ · ~u = 0. (2.10)
Compressible flows are modelled by the equations (2.1)-(2.7). Then, it is possible to replace the state equa-
tion (2.5) by
1
ρ = 2 p, (2.11)
c
where c = c(p, T, . . . ) is the speed of sound. The equation (2.11) can be used with liquid materials as well.
Most commonly the term ρf~ represents a force due to gravity, in which case the vector f~ is the gravita-
tional acceleration. It can also represent, for instance, the Lorentz force when magnetohydrodynamic effects
are present.
For isothermal flows the equations (2.9) and (2.10) describe the system in full. For thermal flows also
the heat equation needs to be solved.
For thermal incompressible fluid flows we assume that the Boussinesq approximation is valid. This
means that the density of the fluid is constant except in the body force term where the density depends
linearly on temperature through the equation
where β is the volume expansion coefficient and the subscript 0 refers to a reference state. Assuming that
the gravitational acceleration ~g is the only external force, then the force ρ0~g (1 − β(T − T0 )) is caused in the
fluid by temperature variations. This phenomenon is called Grashof convection or natural convection.
One can choose between transient and steady state analysis. In transient analysis one has to set, besides
boundary conditions, also initial values for the unknown variables.
ui = ubi . (2.13)
A value ubi can be constant or a function of time, position or other variables. In cylindrical cases the Dirichlet
boundary condition for angular velocity uθ is
uθ = ω, (2.14)
In axisymmetric geometries one has to set ur = 0 and ∂uz /∂r = 0 on the symmetry axis.
If there is no flow across the surface, then
~u · ~n = 0 (2.15)
where ϑ is the temperature coefficient of the surface tension and the subscript 0 refers to a reference state.
If a Boussinesq hypothesis is made, i.e., the surface tension coefficient is constant except in (2.17) due to
(2.18), the boundary condition for tangential stress becomes
In equation (2.16) it holds then that γ = γ0 . The linear temperature dependence of the surface tension
coefficient is naturally only one way to present the dependence. In fact, the coefficient γ can be any user
defined function in Elmer. One may also give the force vector on a boundary directly as in
σ · ~n = ~g . (2.20)
2.2.2 Linearization
As is well known, the convective transport term of the Navier-Stokes equations and the heat equation is a
source of both physical and numerical instability. The numerical instability must be compensated somehow
in order to solve the equations on a computer. For this reason the so called stabilized finite element method
([2],[1]) is used in Elmer to discretize these equations.
The convection term of the Navier-Stokes equations is nonlinear and has to be linearized for computer
solution. There are two linearizations of the convection term in Elmer:
~ · ∇)~u
(~u · ∇)~u ≈ (U (2.21)
and
~ · ∇)~u + (~u · ∇)U
(~u · ∇)~u ≈ (U ~ − (U
~ · ∇)U,
~ (2.22)
where U~ is the velocity vector from the previous iteration. The first of the methods is called Picard iteration
or the method of the fixed point, while the latter is called Newton iteration. The convergence rate of the
Picard iteration is of first order, and the convergence might at times be very slow. The convergence rate of
the Newton method is of second order, but to successfully use this method, a good initial guess for velocity
and pressure fields is required. The solution to this problem is to first take a couple of Picard iterations, and
switch to Newton iteration after the convergence has begun.
This results naturally to Picard iteration. For Newton iteration the additional two terms remains the same
since the mesh velocities in there cancel each other.
where r is the porous resistivity which may also be an orthotropic tensor. Usually the given parameter is
permeability which is the inverse of the resistivity as defined here. No other features of the porous media
flow is taken into consideration. Note that for large value of r only the bubble stabilization is found to work.
which results to the following form of the Navier-Stokes equation in rotating coordinates
∂~u ~ × ~u = ρ(Ω
~ · Ω)~
~ x − ρ(Ω ~ + ρf~,
~ · ~x)Ω
ρ + (~u · ∇)~u − ∇ · σ + 2ρΩ (2.31)
∂t
It should be noted that now also the boundary conditions need to be given in the rotational coordinate system.
f~m = J~ × B,
~ (2.33)
~ and E
Here B ~ are the magnetic and electric fields, respectively. The current density J~ is defined as
J~ = σ(E
~ + ~u × B).
~ (2.34)
2.3 Keywords
Constants
Gravity Size 4 Real [x y z abs]
The above statement gives a real vector whose length is four. In this case the first three compo-
nents give the direction vector of the gravity and the fourth component gives its intensity.
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
where λ is the factor given with this keyword. The default value for the relaxation factor is unity.
Steady State Convergence Tolerance Real
With this keyword a equation specific steady state or coupled system convergence tolerance is
given. All the active equation solvers must meet their own tolerances before the whole system is
deemed converged. The tolerance criterion is:
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Navier-Stokes Logical
if set to True, solve the Navier-Stokes equations.
Magnetic Induction Logical
If set to True, solve the magnetic induction equation along with the Navier-Stokes equations.
Convection String [None, Computed, Constant]
The convection type to be used in the heat equation, one of: None, Computed, Constant.
The second choice is used for thermal flows.
Body Force bf id
The body force section may be used to give additional force terms for the equations.
Boussinesq Logical
If set true, sets the Boussinesq model on.
Flow BodyForce i Real
May be used to give additional body force for the flow momentum equations, i=1,2,3.
Lorentz Force Logical
If set true, triggers the magnetic field force for the flow momentum equations.
Potential Force Logical
If this is set true the force used for the electrostatic coupling is activated.
Potential Field Real
The field to which gradient the external force is proportional to. For example the electrostatic
field.
Potential Coefficient Real
The coefficient that multiplies the gradient term. For example, the charge density.
Angular Velocity Real
~ used for rotating coordinate systems. The size is always expected to be
The angular velocity Ω
three.
Initial Condition ic id
The initial condition section may be used to set initial values for the field variables. The following
variables are active:
Pressure Real
Velocity i Real
For each velocity component i= 1, 2, 3.
Kinetic Energy Real
For the k-ε turbulence model.
Kinetic Energy Dissipation Real
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be set in Navier-Stokes equation.
Density Real The value of density is given with this keyword. The value may be constant, or
variable. For the of compressible flow, the density is computed internally, and this keyword has
no effect.
Viscosity Real
The relationship between stress and strain velocity. When using the solidification modelling, a
viscosity-temperature curve must be given. The viscosity must be set to high enough value in
the temperature range for solid material to effectively set the velocity to zero.
Reference Temperature Real
This is the reference temperature for the Boussinesq model of temperature dependence of density.
Heat Expansion Coefficient real
For the Boussinesq model the heat expansion coefficient must be given with this keyword. De-
fault is 0.0.
Applied Magnetic Field i Real
An applied magnetic field may be given with these keywords with i=1,2,3.
Compressibility Model String
This setting may be used to set the compressibility model for the flow simulations. Currently the
setting may be set to either Incompressible, Perfect Gas and ArtificialCompressible.
If perfect gas model is chosen the settings Reference Pressure and Specific Heat
Ratio must also be given. The artificial compressibility model may be used to boost conver-
gence in fluid-structure-interaction cases. The default value of this setting is Incompressible.
Reference Pressure Real
with this keyword a reference level of pressure may be given. This setting applies only if the
Compressibility Model is set to the value Perfect Gas.
Specific Heat Ratio Real
The ratio of specific heats (in constant pressure versus in constant volume) may be given with
this keyword. This setting applies only if the Compressibility Model is set to value
Perfect Gas. The default value of this setting is 5/3, which is the appropriate value for
monoatomic ideal gas.
For the k-ε turbulence model the model parameters may also be given in the material section using the
following keywords
KE SigmaK Real [1.0]
KE SigmaE Real [1.3]
KE C1 Real [1.44]
KE C2 Real [1.92]
KE Cmu Real [0.09]
Non-Newtonian material laws are also defined in material section. For the power law the constant
coefficient is given by the keyword Viscosity.
Viscosity Model String
The choices are power law, carreau, cross, powell eyring and thermal carreau.
If none is given the fluid is treated as Newtonian.
Viscosity Exponent Real
Parameter n in the models power law, Carreau, Cross
Viscosity Difference Real
Difference ∆η between high and low shearrate viscosities. Ablicable to Carreau, Cross and
Powell-Eyring models.
Viscosity Transition Real
Parameter c in the Carreau, Cross and Powell-Eyring models.
Critical Shear Rate Real [0.0]
Optional parameter γ̇0 in power law viscosity model.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. The one related to Navier-
Stokes equation are
Velocity i Real
Dirichlet boundary condition for each velocity component i= 1, 2, 3.
Pressure Real
Absolute pressure.
Normal-Tangential Velocity Real
The Dirichlet conditions for the vector variables may be given in normal-tangential coordinate
system instead of the coordinate axis directed system using the keywords
Flow Force BC Logical
Set to true, if there is a force boundary condition for the Navier-Stokes equations.
Surface Tension Expansion Coefficient Real
Triggers a tangential stress boundary condition to be used. If the keyword Surface Tension
Expansion Coefficient is given, a linear dependence of the surface tension coefficient
on the temperature is assumed. Note that this boundary condition is the tangential derivative of
the surface tension coefficient
Surface Tension Coefficient Real
Triggers the same physical model as the previous one except no linearity is assumed. The value
is assumed to hold the dependence explicitly.
External Pressure Real
A pressure boundary condition directed normal to the surface.
Pressure i Real
A pressure force in the given direction i= 1, 2, 3.
Free Surface Logical
Specifies a free surface.
Bibliography
[1] L.P. Franca and S.L. Frey. Computer methods in Applied Mechanics and Engineering, 99:209–233,
1992.
[2] L.P. Franca, S.L. Frey, and T.J.R. Hughes. Computer methods in Applied Mechanics and Engineering,
95:253–276, 1992.
Advection-Diffusion Equation
3.1 Introduction
Advection-diffusion equation (sometimes called diffusion-convection equation) describes the transport of a
scalar quantity or a chemical species by convection and diffusion. The difference in the nomenclature usually
indicates that an advected quantity does not have an effect on the velocity field of the total fluid flow but
a convected quantity has. Advection-diffusion equation is derived from the principle of mass conservation
of each species in the fluid mixture. Advection-diffusion equation may have sources or sinks, and several
advection-diffusion equations may be coupled together via chemical reactions.
Fick’s law is used to model the diffusive flux. Diffusion may be anisotropic, which may be physically
reasonable at least in solids. If the velocity field is identically zero, the advection-diffusion equation reduces
to the diffusion equation, which is applicable in solids.
Heat equation is a special case of the advection-diffusion (or diffusion-convection) equation, and it is
described elsewhere in this manual.
3.2 Theory
3.2.1 Governing Equations
The advection-diffusion equation may, in general, be expressed in terms of relative or absolute mass or
molar concentrations. In Elmer, when the transported quantity is carried by an incompressible fluid (or it is
diffused in a solid), relative mass concentration ci = Ci /ρ for the species i is used (Ci is the absolute mass
concentration in units kg/m3 , and ρ the total density of the mixture). We have used the approximation valid
for dilute multispecies flows, i.e., 0 ≤ ci 1. The advection-diffusion equation is now written as
∂ci
ρ + (~v · ∇)ci = ρ∇ · (Di ∇ci ) + Si , (3.1)
∂t
where ~v is the advection velocity, Di the diffusion coefficient and Si is a source, sink or a reaction term. The
diffusion coefficient may be a tensor.
For a compressible fluid, the concentration should be expressed in absolute mass units, and the advection-
diffusion equation reads
∂Ci
+ (∇ · ~v )Ci + (~v · ∇)Ci = ∇ · (Di ∇Ci ) + Si . (3.2)
∂t
For a situation, where the quantity is transported through a phase change boundary, it is convenient to
scale the absolute mass formulation by the respective solubilities of the different phases. Such a case is for
example the surface of a liquid, where the transported quantity is evaporated into a gaseous material. The
scaled concentration variable satisfies the equilibrium boundary condition on the phase change boundary
automatically, and thus the advection-diffusion equation can be solved for both materials simultaneously.
The scaling is following
Ci
xi = , (3.3)
Ci,max
where xi is the concentration of species i relative to its maximum solubility in the current material in absolute
mass units. The maximum solubility has to be a constant (temperature independent) for the absolute mass
formulation of the advection-diffusion equation to remain unchanged.
It is also possible to include temperature dependent diffusion (Soret diffusion). This introduces an addi-
tional term on the right had side of the equation:
∇ · (ρDi,T ∇T ), (3.4)
where Di,T is the thermal diffusion coefficient of species i. The coefficient Di,T has to be given in the units
m2 /Ks regardless of the units used for concentration.
The velocity of the advecting fluid, ~v , is typically calculated by the Navier-Stokes equation and read in
from a restart file. All quantities can also be functions of, e.g., temperature that is given or solved by the
heat equation. Several advection-diffusion equations for different species i may be coupled and solved for
the same velocity field.
Given volume species sources Si can be prescribed. They are given in absolute mass units, i.e., kg/m3 s.
If the equation is scaled to maximum solubility, the source term can be given in absolute mass units, or in
scaled units, Si,sc = Si /Ci,max , which is the default.
The equilibrium boundary condition on phase change boundaries under certain conditions is that the
relative amounts of the transported quantity are equal on both sides of the boundary,
(1) (2)
Ci Ci
(1)
= (2)
, (3.10)
Ci,max Ci,max
where the superscripts (1) and (2) refer to different sides of the boundary. This boundary condition is
(j)
automatically satisfied if the equation is scaled with the maximum solubilities Ci,max .
However, the scaling causes a discontinuity into the mass flux of the species through the phase change
surface. The solver compensates this effect as long as such a boundary is flagged in the command file by the
user.
3.3 Keywords
Simulation
The simulation section gives the case control data:
Simulation Type String
Advection-diffusion equation may be either Transient or Steady State.
Coordinate System String
Defines the coordinate system to be used, one of: Cartesian 1D, Cartesian 2D, Cartesian
3D, Polar 2D, Polar 3D, Cylindric, Cylindric Symmetric and Axi
Symmetric.
Timestepping Method String
Possible values of this parameter are Newmark (an additional parameter Newmark Beta must
be given), BDF (BDF Order must be given). Also as a shortcut to Newmark-method with
values of Beta=0.0,0.5, 1.0 the keywords Explicit Euler, Crank-Nicolson,
and Implicit Euler may be given respectively. The recommended choice for the first order
time integration is the BDF method of order 2.
BDF Order Integer
Value may range from 1 to 5.
Newmark Beta Real
Value in range from 0.0 to 1.0. The value 0.0 equals to the explicit Euler integration method and
the value 1.0 equals to the implicit Euler method.
Solver solver id
The solver section defines equation solver control variables. Most of the possible keywords – related
to linear algebra, for example – are common for all the solvers and are explained elsewhere.
Equation String [Advection Diffusion Equation Varname]
The name of the equation, e.g., Advection Diffusion Equation Oxygen.
Variable String Varname
The name of the variable, e.g., Oxygen.
Procedure File "AdvectionDiffusion" "AdvectionDiffusionSolver"
The name of the file and subroutine.
Nonlinear System Convergence Tolerance Real
The criterion to terminate the nonlinear iteration after the relative change of the norm of the field
variable between two consecutive iterations k is small enough
where λ is the factor given with this keyword. The default value for the relaxation factor is unity.
Steady State Convergence Tolerance Real
With this keyword a equation specific steady state or coupled system convergence tolerance is
given. All the active equation solvers must meet their own tolerances for their variable u before
the whole system is deemed converged. The tolerance criterion is:
Varname Real
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be effective when advection-diffusion equation is solved.
Boundary Condition bc id
In advection-diffusion equation we may set the concentration directly by Dirichlet boundary condi-
tions or use mass flux condition. The natural boundary condition is zero flux condition.
Varname Real
Mass Transfer Coefficient Real
External Concentration Real
These two keywords are used to define flux condition that depends on the external concentration
and a mass transfer coefficient. This condition is only applicable to absolute mass formulation
of the equation (see keywords for Equation block).
Varname Flux Real
A user defined mass flux term in absolute mass units or, in case of scaling, in the scaled units.
Advection-Reaction Equation
4.1 Introduction
Advection-reaction equation describes the transport of a passive scalar quantity, c, by a fluid. The advected
quantity is assumed not to have an effect on the velocity field. Besides a reaction rate, advection-reaction
equation may have sources or sinks. If no reaction rate and source are given, this equation may be used to
trace passive scalars through a given flow-field. If a constant source of unity value is given, the equation also
may be used to evaluate the time a passive tracer has remained in the flow field.
4.2 Theory
4.2.1 Governing Equations
The advective transport of a scalar c can be written as
∂c
+ ~v · ∇c + Γc = S, (4.1)
∂t
where ~v is the advection velocity, Γ is the reaction rate and S is a source/sink, depending on the sign.
Due to the absence of any diffusion, (4.1) has to be solved applying the Discontinuous Galerkin (DG)
method. Elmer implements the particular method as presented in [1]. In order to evaluated jumps across
partition boundaries in parallel computations, DG requires the utilization of halo-elements for domain de-
composition (see ElmerGrid manual for details).
4.2.2 Limiters
If the scalar has a lower, cmin ≤ c and/or an upper limit c ≤ cmax limit (where the limit can be also a
function of another variable), the variational form of (4.1) becomes a variational inequality. In order to
obtain a consistent solution a method using Dirichlet constraints within the domain is applied. The exact
procedure is the following:
1. construct the linear system: Ac = S, with the system matrix A and the solution vector c on the
left-hand side and the force vector S on the right hand side
2. set nodes as active if the constraint is violated
3. for active nodes the matrix and force vector are manipulated such that effectively a Dirichlet condition
c = cmax/min is applied
4. the manipulated system is solved: Ãc̃ = S̃
5. a residual is obtained from the un-manipulated system: R = Ac̃ − S
6. an active node is reset if the residual is R < 0 (for lower limit) and R > 0 (for upper limit)
The whole algorithm is iterated (within the non-linear iteration loop) until the limit given in Nonlinear
System Convergence Tolerance is reached. In the converged solution the residual represents the
needed accumulation/volume flux (on matrix level, hence not in physical units) needed in order to obtain the
limited solution. Consequently, the system not necessarily is volume conserving if the Dirichlet method is
applied.
c = cb . (4.2)
By nature of the applied DG method, the condition above only applies at inflow boundaries, i.e., if
4.3 Keywords
Simulation
The simulation section gives the case control data:
Simulation Type String
Advection-reaction equation may be either Transient or Steady State.
Coordinate System String
Defines the coordinate system to be used, one of: Cartesian 1D, Cartesian 2D, Cartesian
3D, Polar 2D, Polar 3D, Cylindric, Cylindric Symmetric and Axi
Symmetric.
Timestepping Method String
Possible values of this parameter are Newmark (an additional parameter Newmark Beta must
be given), BDF (BDF Order must be given). Also as a shortcut to Newmark-method with
values of Beta=0.0,0.5, 1.0 the keywords Explicit Euler, Crank-Nicolson,
and Implicit Euler may be given respectively. The recommended choice for the first order
time integration is the BDF method of order 2.
BDF Order Integer
Value may range from 1 to 5.
Newmark Beta Real
Value in range from 0.0 to 1.0. The value 0.0 equals to the explicit Euler integration method and
the value 1.0 equals to the implicit Euler method.
Solver solver id
The solver section defines equation solver control variables. Most of the possible keywords – related
to linear algebra, for example – are common for all the solvers and are explained elsewhere.
Initial Condition ic id
The initial condition section may be used to set initial values for the scalar c.
Variable_name Real
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be effective when advection-diffusion equation is solved.
Boundary Condition bc id
Variable_name Real sets the value for c at inflow boundaries
Bibliography
[1] F. Brezzi and E. Marini, .L. D.and Süli. Discontinuous Galerkin methods for first-order hyperbolic prob
lems. Math. Models Methods Appl. Sci., 14(12):1893–1903, 2004.
5.1 Introduction
The flow of fluids is in the continuum level usually described by the Navier-Stokes equations. For narrow
channels this approach is an overkill and usually not even necessary. Neglecting the inertial forces and
assuming fully developed laminar velocity profiles the flow equations may be reduced in dimension resulting
to the Reynolds equation.
The current implementation of the Reynolds equation is suitable for incompressible and weakly com-
pressible liquids as well as for isothermal and adiabatic ideal gases. The nonlinear terms for the compressible
fluids are accounted for. The fluid is assumed to be newtonian i.e. there is a direct connection between the
strain rate and stress. The equation may be solved either in steady state or in a transient mode.
There is an additional solver for postprocessing purposes that computes the local heat generation field
using the Galerkin method. It also computes the integrals over the force and heating fields over the whole
area.
5.2 Theory
The underlying assumption of the Reynolds equation is that the flow in the channel is fully developed and
has thus the Hagen-Poiseuille parabolic velocity profile. Accounting also for the movement of the planes
and leakage through perforation holes the pressure may be solved from the equation
3
ρh 1 ∂ρ
∇· ∇p − Y ρp = ∇ · (ρh~vt ) + h + ρvn , (5.1)
12η 2 ∂t
where ρ is the density, η is the viscosity, p is the pressure and h is the gap height, vt is the tangential velocity,
and vn is the velocity in direction of the surface normal [1, 5]. Holes may be homogenized using the flow
admittance Y which gives the ratio between pressure drop and mean flow velocity through the hole.
The exact form of the Reynolds equation depends on the material law for density, ρ(p). The absolute
value of density does not play any role and therefore we may study just the functional forms. For gases we
solve for the pressure variation from the reference pressure P0 rather than for the absolute pressure. The
different functional forms for some idealized material laws are the following:
Here γ = Cp /CV is the specific heat ratio and β the bulk modulus. In discretization of the equations it is
also useful to derive the functional dependencies of the density derivatives in respect to pressure,
In order to improve convergence of the iteration of the nonlinear system some terms including differen-
tials of density may be expressed implicitly using pressure. This way equation (5.1) may be written in the
following form:
3
ρh ∂p 1 1
∇· ∇p − Y ρp − ρp h − ρp h~vt · ∇p = ρ∇ · (h~vt ) + ρvn . (5.2)
12η ∂t 2 2
The surface velocity ~v may also be given in normal Cartesian coordinate system. Then the normal and
tangential components may easily be obtained from
vn = ~v · ~n
~vt = ~v − vn~n.
where λ is the mean free path of the molecules and h is the characteristic scale (here the gap height). In this
solver only the dependence with pressure is taken into account from the formula
1
λ= λ0 . (5.7)
1 + p/P0
When the Knudsen number is very small (Kn 1) the gas may be considered as a continuous medium.
When the Knudsen number is in the transition regime (Kn ≈ 1) we may take the gas rarefaction effect
into account by an effective viscosity. This accounts for the slip conditions of the flow in the channel by
decreasing the viscosity value. An approximation given by Veijola [4] is
η0
η= . (5.8)
1 + 9.638Kn1.159
It s relative accuracy is 5 % in the interval 0 < Kn < 880.
5.2.4 Postprocessing
When the equation has been solved the solution may be used to compute some data for postprocessing
purposes. The local volume flux in the lateral direction may be obtained from
h3
~q = − ∇p + h~vt . (5.12)
12η
The total force acting on the surface is
Z
η
F~ = p~n + ~vt dA, (5.13)
A h
where the first term is due to pressure driven flow and the second one due to sliding driven flow. Also the
heating effect may be computed. It consist of two parts: pressure driven flow and sliding flow. The local
form of this is
h3 η
h= |∇p|2 + |~vt |2 . (5.14)
12η h
Therefore the total heating power of the system is
Z
Q= q dA. (5.15)
A
It should be noted that if the velocity field ~v is constant then the integral quantities should fulfill the condition
Q = F~ · ~v .
Note that the above implementation does not take into account the leakage through perforation holes nor
the compressibility effects of the fluids.
5.3 Keywords
The module includes two different solvers. ReynoldsSolver solves the differential equation (5.2) while
ReynoldsHeatingSolver solves the equation (5.14) and computes the integrals. The second solver
only makes sense when the pressure field has already been computed with the first one. The second solver
uses the same material parameters as the first one.
Solver solver id
Equation String ReynoldsPostprocess
A describing name for the solver. This can be changes as long as it is used consistently.
Procedure File "ReynoldsSolver" "ReynoldsPostProcess"
Name of the solver subroutine.
Reynolds Pressure Variable Name String
The name of the field that is assumed to provide the pressure field. The default is FilmPressure.
Note that the Variable of this equation need not to be defined since it is automatically set when
any of the field computation is requested.
Calculate Force Logical
Calculate the forces resulting from the pressure distribution computed with the Reynolds equa-
tion. The name of the field is obtained by adding the suffix Force.
Calculate Flux Logical
Calculate the fluxes resulting from the pressure distribution computed with the Reynolds equa-
tion. The name of the field is obtained by adding the suffix Flux.
Calculate Heating Logical
Calculate the heating efficiency from the pressure distribution computed with the Reynolds equa-
tion. The name of the field is obtained by adding the suffix Heating.
Bibliography
[1] B.J. Hamrock, S.R. Schmid, and B.O. Jacobson. Fundamentals of fluid film lubrication. Marcel Dekker,
second edition, 2004.
[2] P. Rback, A. Pursula, V. Junttila, and T. Veijola. Hierarchial finite element simulation of perforated
plates with arbitrary hole geometries. In NANOTECH 2003, San Francisco, 23-27 February 2003,
volume 1, pages 194–197.
[3] T. Veijola. APLAC 7.60 Reference Manual, January 2002. Electromechanical Macro Models.
[4] T. Veijola, H. Kuisma, J. Lahdenper, and T. Ryhnen. Equivalent-circuit model of the squeezed gas
film in a silicon accelerometer. Sensors and Actuators A, pages 239–248, 1995.
[5] T. Veijola and P. Rback. A method for solving arbitrary mems perforation problems with rare gas
effects. In NANOTECH 2005, Anaheim, May 8-12, 2005, volume 3, pages 561–564.
Linear Elasticity
6.1 Introduction
This module computes displacement field from the Navier equations. The Navier equations correspond to
linear theory of elastic deformation of solids. The material may be anisotropic and stresses may be computed
as a post processing step, if requested by the user. Thermal stresses may also be requested.
6.2 Theory
The dynamical equation for elastic deformation of solids may be written as
∂ 2 d~
ρ − ∇ · τ = f~, (6.1)
∂t2
where ρ is density, d~ is the displacement field, f~ given volume force, and τ the stress tensor. Stress tensor is
given by
τ ij = C ijkl εkl − β ij (T − T0 ), (6.2)
where ε is the strain and quantity C is the elastic modulus. The elastic modulus is a fourth order tensor,
which has at the most 21 (in 3D, 10 in 2D) independent components due to symmetries. In Elmer thermal
stresses may be considered by giving the heat expansion tensor β and reference temperature of the stress free
state T0 . The temperature field T may be solved by the heat equation solver or otherwise. The linearized
strains are given simply as:
1
ε = (∇d~ + (∇d) ~ T ). (6.3)
2
where µ and λ are the first and second Lame parameters respectively, β the heat expansion coefficient, and
I is the unit tensor. The Lame parameters in terms of Young’s modulus and Poisson’s ratio read
Yκ Y
λ= , µ= (6.5)
(1 + κ)(1 − 2κ) 2(1 + κ)
Quantities Y and κ are the Young’s modulus and Poisson’s ratio respectively.
For anisotropic materials, the stress-strain relations may be given in somewhat different form:
τV = EεV , (6.7)
where τV and εV are the stress and strain vectors respectively. The 6 × 6 matrix E (in 3D, 4 × 4 in 2D) is
the matrix of elastic coefficients. The stress and strain vectors are defined as
T
τV = (τx τy τz τxy τyz τxz ) (6.8)
and
T
εV = (εx εy εz 2εxy 2εyz 2εxz ) . (6.9)
In 2D the stress vector is
T
τV = (τx τy τz τxy ) (6.10)
and the strain vector
T
εV = (εx εy εz 2εxy ) . (6.11)
When plane stress computation is requested τz = 0, otherwise εz = 0. Cylindrically symmetric case is
identical to the 2D case, the components are given in the order of r, z, and φ. The matrix E is given as input
for the anisotropic material model of Elmer.
τ = ΠI + 2µ. (6.13)
If the viscoelastic model is used in the context of solid-Earth deformation, a restoring force (second term
below), called Gravitational Pre-stress Advection (GPA), has to be introduced to prevent a loaded Earth to
collapse [1]. The quasi-stationary momentum balance then reads
∇ · τ − ρg ∇ ~ez · d~ = 0, (6.14)
|{z}
=cGP A
where g is the acceleration by gravity and ~ez the vertical direction (aligned with gravity). cGP A = ρg is the
local coefficient for gravitational pre-stress advection, changing between different layers of the Earth.
or Z Z
ω 2
ρφk ψk dΩ = ~ ij (ψ)
τij (φ) ~ dΩ, (6.16)
Ω Ω
The last term on the right-hand-side represents here the geometric stiffness due to external loads, thermal
stresses etc.
In stability analysis the buckling modes φ~ are obtained from
Z Z
∂φk ∂ψk ~ ij (ψ)
~ dΩ,
−λ σij dΩ = τij (φ) (6.18)
Ω ∂xi ∂xj Ω
where λ is the margin of safety with respect to bifurcation (the current load can be multiplied by factor λ
before stability is lost).
The equations may be interpreted as generalized eigenproblems and solved with standard techniques.
C = αM + βK (6.19)
di = dbi (6.20)
F = KD (6.23)
Lumped displacements and angles are determined as the mean values over the boundary,
Z
1
Di = di dA. (6.25)
A A
Therefore the methodology works best if the boundary is quite rigid in itself.
There are two different model lumping algorithms. The first one uses pure lumped forces and lumped
moments to define the corresponding displacements and angles. In 3D this means six different permutations.
Each permutation gives one row of the inverse matrix K −1 . Pure lumped forces are obtained by constant
force distributions whereas pure moments are obtained by linearly varying loads vanishing at the center of
area. Pure moments are easily achieved only for relatively simple boundaries which may limit the usability
of the model lumping utility.
The second choice for model lumping is to set pure translations and rotations on the boundary and
compute the resulting forces on the boundary. This method is not limited by geometric constraints. Also
here six permutations are required to get the required data. In this method the resulting matrix equation is
often better behaving in comparison with the model lumping by pure forces which may be another reason to
favour this procedure.
6.3 Keywords
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Stress Analysis Logical
if set to True, solve the Navier equations.
Plane Stress Logical
If set to True, compute the solution according to the plane stress situation τzz = 0. Applies
only in 2D.
Body Force bf id
The body force section may be used to give additional force terms for the equations.
Stress Bodyforce 1 Real
Stress Bodyforce 2 Real
Stress Bodyforce 3 Real
The keywords may be used to give volume force.
Stress Bodyforce 1 im Real
Stress Bodyforce 2 im Real
Stress Bodyforce 3 im Real
The keywords may be used to give volume force for the imaginary part. May be applied only to
harmonic solution of the equation.
Stress Load Real
Keyword for defining stress load for the body.
Strain Load Real
Keyword for defining strain load for the body.
Gravitational Prestress Advection Logical
Switches the additional restoring term of pre-stress advection used in solid-Earth deformation
GPA Coeff Real
Sets the factor of the gravitational pre-stress advection, cGP A
Initial Condition ic id
The initial condition section may be used to set initial values for the field variables. The following
variables are active:
Displacement i Real
For each displacement component i= 1, 2, 3.
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be set in Navier equations.
Density Real The value of density is given with this keyword. The value may be constant, or
variable.
Poisson Ratio Real
For isotropic materials Poisson’s ratio must be given with this keyword.
Youngs Modulus Real
The elastic modulus must be given with this keyword. The modulus may be given as a scalar for
the isotropic case or as 6 × 6 (3D) or 4 × 4 (2D and axisymmetric) matrix for the anisotropic
case. Although the matrices are symmetric, all entries must be given.
Rayleigh Damping Logical
Apply Rayleigh damping.
Rayleigh Damping Alpha Real
Rayleigh Damping Beta Real
The parameters of Rayleigh damping.
Pre Stress Real
One may give prestress as an input to the solver.
Pre Strain Real
One may give prestrain as an input to the solver.
Bibliography
[1] T. Zwinger, GA. Nield, J. Ruokolainen, and M.A. King. A new open-source viscoelastic solid earth
deformation module implemented in Elmer (v8.4). Geoscientific Model Development, 13:1155–1164,
2020.
Finite Elasticity
7.1 Introduction
This chapter is concerned with the equations which describe finite deformations of elastic solids. As the
region of space occupied by the body at time t is not known in advance, it is not convenient to handle
the equations in the form that expresses the field equations on the deformed configuration. Therefore the
associated problem is formulated here by employing the reference configuration which equals to the region
occupied by the body before the deformation.
with λ and µ the Lame material parameters. We note that a common way to express (7.2) uses the material
strain tensor
E = 1/2(C − I), (7.4)
so that the constitutive law (7.2) may be written as
Σ = λtr(E)I + 2µE.
To treat the incompressible neo-Hookean material associated with the limit case λ → ∞ (or equivalently
ν → 1/2, with ν the Poisson ratio), we introduce an auxiliary field p defined by
1
(1/λ)p = − [det C − 1] (7.5)
2
to replace (7.3) by
Σ̄(C, p) = −pC −1 + µ(I − C −1 ). (7.6)
To handle the case of a nearly incompressible material (the value of ν close to 0.5) computationally, the field
p is taken to be an additional unknown which is solved under the constraint (7.5). It is notable that in the limit
case of incompressible material p is unique only up to a constant if the displacement is prescribed over the
entire boundary of the body (a special care is then needed to ensure that the condition det C = det F 2 = 1
is respected by the boundary conditions).
The solver also offers some utilities to handle more general constitutive laws so that a user-defined
material model in the form of an Abaqus user subroutine (UMAT) may be included. In this case the con-
stitutive law has to be defined differently by employing the Cauchy stress σ whose material description
σ m (p, t) ≡ σ(x(p, t), t) is related to the first Piola-Kirchhoff stress by
S = (det F )σ m F −T . (7.7)
A user-defined subroutine should define a stress response function σ̄ to specify how the Cauchy stress de-
pends on a strain field Ê(F ) and an additional N -tuple of state variable fields denoted by q = (q1 , . . . , qN ).
One may then consider a generic constitutive law of the type
The user-defined subroutine should also define the derivative of the Cauchy stress at the current state with
respect to the strain variable for performing the nonlinear solution procedure. That is, in the differentiation
the stress response function is treated as the composition
with q being taken as a parameter, so that the Fréchet differential of (7.9) is obtained by using the chain rule
as
U 7→ Dσ̄(Ê(F ), q)[DÊ(F )[U ]]. (7.10)
The user-defined subroutine must thus return a representation of Dσ̄(Ê(F ), q) so that the differential (7.10)
can be generated on the side where the user-defined subroutine is called. In this connection the strain field
Ê(F ) need not necessarily be the material strain (7.4), as the Hencky (logarithmic) strain or the standard
linearized strain can also be used. Including a user-defined material model requires some programming skills
and the best place to check for the current functionality is the solver code. A template subroutine for a user-
defined material model can also be found in the file UMATLib.F90 that is located in the same directory as
the code of the solver module.
where m(x) is the unit normal on the deformed configuration, x ∈ x(Γ2 , t) for any t, and g(x, t) is a given
scalar function. This can be shown to be equivalent to specifying the values of Sn such that
where n = n(p) is the normal vector to the boundary ∂Ω and ĝ = ĝ(p, t) = g(x(p, t), t). The constraint
(7.12) gives rise to a nonlinear force term which is handled in the computational solution iteratively by using
a lagged-value approximation.
The surface traction s may also be specified by giving its components with respect to the frame of
reference such that
s(x(p, t), t) = ŝ(p, t), (7.13)
with ŝ(p, t) a given vector. While the condition (7.13) specifies the actual force per unit area of the deformed
surface, it also possible to specify directly the pseudo-traction s0 = Sn which gives the actual force per
unit undeformed area. If the pseudo-traction is specified on Γ2 as
the total force exerted across Γ2 is then given by the surface integral
Z
ŝ0 dΓ.
Γ2
where the additional scalar term in the integrand relates to the area change during the deformation.
while
DΣ(F )[∇v] =λ(det F )2 tr(∇vF −1 )C(F )−1 +
λ
[µ − (det F − 1)(det F + 1)]C(F )−1 [F T ∇v + ∇v T F ]C(F )−1
2
for the neo-Hookean material obeying (7.3). In the computation of the associated tangential stiffness matrix,
which result from substituting the approximation (7.15) into the discrete version of the weak formulation of
(7.1), the following self-adjointness property
is also used.
When a nearly incompressible neo-Hookean material is considered, we need to linearize both the consti-
tutive law S = Ŝ(F , p) = F Σ(F , p), with Σ(F , p) = Σ̄(F T F , p), and the constraint
ϕ(F , p) = 0 (7.16)
where
ϕ(F , p) = εp + 1/2(det F )2 − 1/2 (7.17)
with
ε = 1/λ. (7.18)
The Newton updates related to solving (7.16) are given by
To obtain the Newton linearization of the stress response function, we note in particular that the derivative
of the function G(F , p) = −pC(F )−1 is given by
DΣ(F , p)[(U , h)] = −hC(F )−1 + (p + µ)C(F )−1 [F T U + U T F ]C(F )−1 . (7.20)
In the differentiation the state variables are thus treated as parameters. In the case of a user-defined material
model the equation (7.22) provides the key ingredient for linearization.
7.7 Keywords
Simulation
In specifying the keywords for the simulation section, note that all coordinate systems are not sup-
ported.
Coordinate System String
The coordinate system may be Cartesian 2D, Cartesian 3D or Axi Symmetric.
Material mat id
The following keywords relate to giving the material parameters for the finite elasticity solver.
Density Real
This keyword is used for defining the density field ρ0 corresponding to the reference configura-
tion.
Poisson Ratio Real
The values of the scalar Lame material parameters depend on the Poisson ratio as in the case of
the linear elasticity solver. The Poisson ratio is given by using this keyword.
Youngs Modulus Real
The values of the scalar Lame material parameters depend on Young’s modulus as in the case of
the linear elasticity solver. This keyword specifies the value of Young’s modulus.
UMAT Subroutine File
The value of this keyword consists of two string parameters. The first parameter specifies the
name of a compiled file containing the definition of a user-defined material model in the UMAT
form. The second parameter defines the name of the user-defined subroutine. If this keyword is
used, all material models must be defined in the UMAT form.
Number of Material Constants Integer
The value of this keyword defines the number of material constants that are passed to the UMAT
subroutine.
Material Constants Real
The values of the material constants passed to the UMAT subroutine.
Number of State Variables Integer
This keyword is used to declare the number of state variables.
Name String
This keyword may be used to define the name argument of the UMAT subroutine.
Equation eq id
Solver solver id
Body Force bf id
This section may be used to define body forces.
Inertial Bodyforce j Real
This keyword may be used to give the component j of the body force b(x, t) in order to define
b0 = ρ0 (p)b(x(p, t), t). It is noted that in this case b(x, t) defines the body force per unit mass.
The density changes are then considered correctly , i.e. the condition ρ(x(p, t), t) det F (p, t) =
ρ0 (p) is respected.
Stress Bodyforce j Real
This keyword may be used to give the component j of the body force b(x, t) in order to define
b0 = (det F )b(x(p, t), t). It is noted that b(x, t) is now the body force per unit volume of
the deformed body, so this type of force is appropriate for specifying true volumetric forces,
whatever they might be.
Boundary Condition bc id
The Dirichlet conditions (7.11) for the displacement variable of the solver can be given in the standard
manner. Other options for defining boundary conditions are explained in the following.
Normal Surface Traction Real
A surface force which is normal to the deformed boundary and gives force per unit area of the
deformed surface may be given with this keyword.
Surface Traction k Real
By default this keyword may be used to give the actual force per unit area of the deformed sur-
face. The value of this keyword then specifies the component k of ŝ in (7.13). If the keyword
command Pseudo-Traction = True is also given, then the values of this keyword com-
mand are used to determine the components of the pseudo-traction vector ŝ0 which gives the
actual force per unit undeformed area.
Pseudo-Traction Logical
If this keyword has the value True, then the surface force is defined via the pseudo-traction
condition; see the explanation of the keyword Surface Traction k below.
Spring Real
This keyword can be used to generate a reaction force which is aligned with the normal direction
of the undeformed configuration and which is proportional to the displacement in the normal
direction.
Spring i Real
This keyword is similar to the keyword Spring but here the spring coefficients are defined with
respect to the coordinate axes.
FSI BC Logical
If this keyword has the value True, then the Navier–Stokes flow solution is used to determine
the surface force generated by the flow.
8.1 Introduction
This chapter is concerned with the equations which describe deformations of thin elastic shells. Here a shell
refers to a curved three-dimensional body which can be described in terms of its mid-surface and thickness
(the extent of the shell in the direction of normal to the mid-surface). When the placement of the shell in its
reference configuration is described by using a system of normal coordinates (that is, two coordinate curves
on the mid-surface are perpendicular to the third coordinate curve), simplifications to solving 3-D elasticity
equations can be sought via the process of dimensional reduction, so that unknowns that depend only on the
two curvilinear coordinates associated with the shell mid-surface can be employed. Classical shell theory [3]
is dedicated to the study of such models by assuming that the exact parametrization of the shell mid-surface
is known in advance.
However, classical shell theory cannot often be applied in a straightforward manner in connection with
finite element modelling, since in practice the mapping giving the mid-surface is not usually available in an
explicit form. To offer generality, the shell solver described here is also able to create a computational surface
model by assuming that information about the surface position and the director vector (the unit normal to
the exact mid-surface) are given at the nodes of a background mesh. Elementwise approximations of the
mid-surface are then created such that the surface position and the normal to the approximate surface agree
with the data given at the nodes. It should be noted that the approximate mid-surface obtained in this way
generally gives a more accurate description of the surface position than what would be obtained by using
the standard strategy where straightforward Lagrange interpolation merely based on the nodal position data
is employed. Here the approximation of the director field is then derived via straightforward differentiation
of the mapping giving the approximate surface (it should be noted that this approximation is consistent with
the given data at the nodes). As an alternate to the internal surface reconstruction, a higher-order nodal mesh
can be used to derive the necessary geometric data without expecting director data.
In the first place each (physical) element S of the approximate mid-surface is originally parametrized in
terms of the rectangular Cartesian coordinates of points of a usual reference element (a square or an equilat-
eral triangle). However, the solver considered performs additional computation in order to find a convenient
elementwise reparametrization by lines of curvature coordinates, so that we may write S = ϕK (K) where
ϕK : K ⊂ R2 → E3 and the rectangular Cartesian coordinates y α of a point y in K correspond to lines
of curvature coordinates on S (for the basic concepts related to lines of curvature, see [2]). Then each point
on the surface can naturally be associated with an orthogonal system of basis vectors which offer a conve-
nient starting point for representing vector-valued fields over the surface. Since the basis is orthogonal, the
components of a vector field have intuitive physical significance and tensor calculations related to the shell
equations are greatly simplified in comparison with the case of general curvilinear coordinates.
It is mentioned that this solver can also be adapted to handle special cases where the exact parametrization
of the shell mid-surface by lines of curvature coordinates can be given globally. In this case, the approach of
classical shell theory is followed, so the mathematical formulation is done over a two-dimensional (planar)
reference domain.
8.2.1 Preliminaries
We may now think of a physical surface element S = ϕK (K) to be associated with the physical solid
element ΩS ⊂ E3 which is the image of the set S × [−d/2, d/2] under a mapping of normal coordinates
with d being the shell thickness and the surface function p 7→ (a3 ◦ ϕ−1 K )(p) giving the unit normal to
the mid-surface at a point p ∈ S in terms of the vector field a3 : K → R3 . Since the normal coordinates
(p, y 3 ) ∈ S × [−d/2, d/2] thus identify a point in the physical element ΩS , it is natural to approximate the
elementwise restriction of the displacement vector field of the shell
This representation of geometry follows by writing an alternate referential description of the normal coordi-
nates representation defined by (8.1).
Each physical point Θ(y, y 3 ) of the shell can be associated with three vectors
with êk being the orthonormal basis vectors associated with the mathematical domain of definition, to give
a covariant basis for the translation space R3 of E3 . Similarly, by restricting to the mid-surface, we define a
set of surface basis vectors ai : K → R3 , which give the covariant basis at p = ϕK (y), via
The covariant components of the metric surface tensor A (the first fundamental form) are now given by
They give the covariant components of the second fundamental form B of the surface at p = ϕK (y). We
shall also need the contravariant basis vectors ai of the surface satisfying the orthogonality conditions
g 1 (y, y 3 ) = µ11 (y, y 3 )a1 (y), g 2 (y, y 3 ) = µ22 (y, y 3 )a2 (y), g 3 (y, y 3 ) = a3 (y) (8.10)
where µβα are the mixed components of a diagonal (shifter) tensor. We then have
with
1 B11 (y) 1 B22 (y)
=− = −B11 (y) and =− = −B22 (y) (8.12)
R1 (y) A11 (y) R2 (y) A22 (y)
being the principal curvatures. The sign convention is here chosen such that the principal radii of curvature
Rα > 0 if the normal vector is directed away from the centre of curvature.
Two different kinematic assumptions in the form (8.3) can be chosen. The most general version of
(8.3) leads to handling nine scalar fields as unknowns. The simplest kinematic assumption, which does not
necessitate introducing an additional assumption about the state of stress, however corresponds to the choice
where the part v (2) can be expressed simply as
i.e. only one scalar field describes the second-order part with respect to y 3 . The resulting kinematic assump-
tion thus involves seven scalar fields (for original contributions that use this restriction, see historical notes
in [3] and papers by Reissner and Naghdi mentioned there). The assumption that only one quadratic compo-
nent in y 3 is included is motivated by having the ability to expand all components of linearized strain tensor
up to the first-order terms in y 3 . In practice, especially in the context of linear theory, this choice allows the
derivation of a variational formulation which does not necessitate solving the part (8.13) as tightly coupled
with the other unknowns, i.e. its values can be found afterwards when v (k) , k = 0, 1, have first been solved.
2Ēij (û)(·) = g i (·) · ∂j û(·) + ∂i û(·) · g j (·) + [∂i û(·)] · [∂j û(·)]. (8.14)
In practice, we shall perform a change of basis in order to express the strain tensor field as
so that the components are then expressed with respect to the surface basis vectors depending only on the
two curvilinear coordinates of the mid-surface. Alternatively, the most basic representation of strain follows
by switching to a local orthonormal basis {e1 (y), e2 (y), e3 (y)} = {e1 (y), e2 (y), e3 (y)} obtained as
aα (y)
eα (y) = , e3 (y) = a3 (y), with Aα (y) = |aα (y)|, (8.15)
Aα (y)
and writing then
E(û)(y, y 3 ) = Êij (û)(y, y 3 )ei (y) ⊗ ej (y).
The components of these representations can be shown to obey the following transformation rules (here the
summation convention is adopted so that a repeated index simultaneously appearing as a subscript and as a
superscript in a term imply summation over all possible values, with a Greek index being however allowed
to have values in {1, 2})
Eαβ (û) (µ−1 )λα (µ−1 )νβ Ēλν (û) Eα3 (û) (µ−1 )να Ēν3 (û)
Êαβ (û) = = , Êα3 (û) = = ,
Aα Aβ Aα Aβ Aα Aα
Ê33 (û) = E33 (û) = Ē33 (û).
By letting U = (v1 , v2 , . . .) denote an n-tuple of 2-D scalar fields which determine û, we next expand the
components of the strain tensor in powers of the normal coordinate y 3 to obtain the first-order approximation
Eij (û(U))(y, y 3 ) = γij (U)(y) + ij (U)(y) − y 3 κij (U)(y) − y 3 χij (U)(y) (8.16)
where the 2-D fields γij (U) : K → R and κij (U) : K → R are linear with respect to U, while ij (U) :
K → R and χij (U) : K → R are nonlinear. If the shell undergoes only small deflections, linearization can
additionally be performed by omitting the nonlinear terms to write then
We note that the tangent plane components γαβ (U) and καβ (U) constitute the so-called membrane strain
and bending strain tensors, while γα3 (U) are the transverse shear strains.
When we simplify the notation by setting
the components of the linearized strain tensors have the following component-free representations (the
component-freeness should be understood with respect to the displacements)
2γαβ (U) = aα · ∂β v + ∂α v · aβ ,
2γα3 (U) = a3 · ∂α v − aα · β,
γ33 (U) = −β · a3 ,
καα (U) = aα · ∂α β − κα γαα , (8.18)
2κ12 (U) = a1 · ∂2 β + ∂1 β · a2 − κ2 a1 · ∂2 v − κ1 ∂1 v · a2 ,
2κα3 (U) = a3 · ∂α β − κα a3 · ∂α v + ψ · aα ,
κ33 (U) = ψ · a3 ,
with κ1 ≡ B11 and κ2 ≡ B22 . On the other hand, the nonlinear parts of the strain tensors can be expressed as
2αβ (U) = ∂α v · ∂β v,
2α3 (U) = −β · ∂α v,
33 (U) = 1/2β · β,
(8.19)
2χαβ (U) = ∂α v · ∂β β + ∂α β · ∂β v − (κ1 + κ2 )∂α v · ∂β v,
2χα3 (U) = −β · ∂α β + ψ · ∂α v + κα β · ∂α v,
χ33 (U) = −β · ψ.
It should be noted that under our kinematic assumptions the expression for the linearized normal strain
is precisely
γ33 (U) − y 3 κ33 (U) = −β3 − y 3 ψ3 , (8.20)
so we cannot generally proceed beyond linear terms in y 3 in the expansions of strains. This generally
motivates our choice to truncate the expressions for strains as done in (8.16). In addition, the terms of type
Bβα γαk (U) in the expressions for κij (U) are expected to have little impact on the strain energy of a thin
shell and could therefore be omitted to obtain simplified expressions.
It is notable that the derivatives of ψ do not occur in the expressions for strains when only the terms up to
the first order with respect to y 3 are taken into account. When weak solutions of shell equations are sought,
the components of ψ are thus seen to be exceptional in that less regularity can be supposed. In addition, in
the context of linear theory together with the restriction (8.13), ψ enters only through its normal component
ψ3 in the expression for κ33 (U). In this case, a variational formulation of the shell problem may be obtained
such that it does not necessitate solving ψ3 as tightly coupled with the other unknowns, i.e. its values can
be found afterwards when v (k) , k = 0, 1, have first been solved. In the context of nonlinear theory such
simplification cannot be attained in a fully consistent manner and using the nine-component shell model
may be a more natural choice. If the nine-component model is not employed and nonlinearities are taken
into account, the shell solver neglects the incomplete part ψ · ∂α v in the expression for χα3 (U), so that a
formulation in terms of v (k) , k = 0, 1, can be obtained.
with
εij (U) ≡ γij (U) + ij (U),
(8.22)
ρij (U) ≡ κij (U) + χij (U).
Currently the shell solver can handle only a nonlinear extension of the standard constitutive law for an
isotropic material characterized by Young’s modulus E and Poisson’s ratio ν. That is, we assume that
νE E
Σ̂ij (·) = [Ê11 (û)(·) + Ê22 (û)(·) + Ê33 (û)(·)]δij + Êij (û)(·) (8.23)
(1 + ν)(1 − 2ν) 1+ν
where the scalar fields Σ̂ij : ΩK → R are the components of the second Piola-Kirchhoff stress with respect
to the orthonormal basis. This model is expected to be feasible when the stretches of the shell remain
relatively small, while rigid body deformations of arbitrary magnitude are possible.
The statement of the three-dimensional principle of virtual work can now be put into the form
DU(U)[V] = Q(U, V)
where DU(U)[V] gives the derivative of strain energy and Q(U, ·) is a linear functional determined by
loads. We note that the linear functional does not always depend on the solution U. In that case we could
simplify the statement of the principle of virtual work as
DU(U)[V] = L(V),
with L(·) being a linear functional independent of U. The strain energy is expressed elementwise as
Z p
UK (U) = W (E(û(U))(y, y 3 )) g(y, y 3 )dydy 3 , (8.24)
ΩK
with W : Sym → R giving the strain-energy density and g(y, y 3 ) denoting the determinant of three-
dimensional metric tensor. The contribution to the principle of virtual work can then be expressed as
Z p
R(E(û(U))(y, y 3 )) · DE(û(U))[V](y, y 3 ) g(y, y 3 ) dΩK = QK (U, V) (8.25)
ΩK
for all kinematically admissible V, with the second Piola-Kirchhoff stress field Σ(·) = R(E(û(U))(·))
being found as the derivative R(E) · H = DW (E)[H].
A truly two-dimensional variational formulation follows by using (8.21) in connection with (8.24) and
performing the integration over the thickness of the shell. In the integration, we have chosen to neglect terms
of O(d/Rα ) in order to simplify the final statement of the 2-D version of the principle of virtual work. When
the restriction (8.13) is employed, after some reduction the strain energy over K may be expressed as
Z n 2 o√
Ed X
UK (U) = ν[ε11 (U) + ε22 (U)]2 + (1 − ν) [εαβ (U)]2 a dK
2(1 − ν 2 )
K α,β=1
Ed(1 − ν)
Z n
ν o2 √
+ ε33 (U) + [ε11 (U) + ε22 (U)] a dK
2(1 + ν)(1 − 2ν) 1−ν
K
√
Z
Ed
+ [(ε13 (U))2 + (ε23 (U))2 ] a dK (8.26)
1+ν
K
2
Ed3 o√
Z n X
2 2
+ ν[ρ 11 (U) + ρ22 (U)] + (1 − ν) [ραβ (U)] a dK
24(1 − ν 2 )
K α,β=1
Ed3 √
Z
+ [(ρ13 (U))2 + (ρ23 (U))2 ] a dK
12(1 + ν)
K
three components. To cope with this discrepancy, the beam stiffness matrix is manipulated before assembling
into the global stiffness matrix in such a way that the resultant couple vector cannot have a component with
respect to the director vector of the beam. The beam and shell directors are now defined independently, but
it is natural to construct the combined model so that the shell and beam directors agree in places where the
domains of the two models intersect.
8.5 Keywords
Simulation
Coordinate System String Cartesian 3D
The coordinate system should be selected to be three-dimensional, although basis functions for
computation correspond to 2-D finite elements.
Material mat id
The following keywords relate to specifying the shell thickness and material parameters.
Shell Thickness Real
The thickness d of the shell is specified with this keyword.
Poisson Ratio Real
Poisson’s ratio is given by using this keyword.
Youngs Modulus Real
This keyword specifies the value of Young’s modulus.
Density Real
This keyword is used for defining the density of the material.
Rayleigh Damping Alpha Real
This specifies a coefficient to activate mass-proportional damping.
Solver solver id
Equation String
A describing name for the solver.
Procedure File "ShellSolver" "ShellSolver"
The name of the solver subroutine.
Variable String Deflection[U:3 DNU:3]
The name of the solver variable can be chosen freely (but it is must be used consistently else-
where). The default variable is Deflection[U:3 DNU:3] which is thus suitable for the
model derived under the restriction (8.13). Then the first three components of the solver variable
define the mid-surface displacement field v (0) (the default variable name U), while the rest are
related to the vector v (1) (the default variable name DNU). The variables always correspond to
the orthogonal Cartesian components with respect to the global coordinate frame.
Variable DOFs Integer
The value of this can be either 6 or 9. The value 9 can be used only when p-elements are applied.
The value 6 is given by default.
Large Deflection Logical
By default the nonlinear equations are solved. With the value being False, the linearized strain
tensor is employed.
Eigen Analysis Logical
Eigenanalysis based on the linearized model can be done if this keyword is given the value True.
Displace Mesh Logical
If this keyword is given the value True, the mesh is mapped to represent the deformed config-
uration. The formulation of the total Lagrangian type is nevertheless used, so the shell problem
is posed over the undeformed configuration. In the case of eigenanalysis this keyword is not
supported.
I I
to the linear functional of the shell problem. Note that by default the components of all data vectors
are defined with respect to the global coordinate frame.
U i Real
If the default variable name is used, then, with i=1,2,3, Dirichlet BCs for the components of
the mid-surface displacement v (0) can be given.
DNU i Real
If the default variable name is used, then, with i=1,2,3, Dirichlet BCs for the components of
v (1) can be given.
Resultant Force i Real
This keyword may be used to give the components of the resultant force N measured per unit
length of a curve c on the mid-surface.
Bibliography
[1] D. Chapelle and K.J. Bathe. The Finite Element Analysis of Shells - Fundamentals. Springer, second
edition, 2011.
[2] P.G. Ciarlet. An Introduction to Differential Geometry with Applications to Elasticity. Springer, Dor-
drecht, the Netherlands, 2005.
[3] P.M. Naghdi. Foundations of elastic shell theory. In Progress in Solid Mechanics, Vol. 4 (I.N. Sneddon,
R. Hill, Eds) North-Holland, pages 1–90, 1963.
9.1 Introduction
The linear elastic plate elements of Elmer are based on the shear deformable model of Reissner and Mindlin.The
finite element discretization is performed using the so called stabilized MITC-plate elements, which are free
from numerical locking.
where θx and θy are components of the rotation vector θ = (θx , θy ) and w is the transverse deflection of the
mid-surface, see Figure 1.
The functions w and θ = (θx , θy ) are determined from the condition that they minimize the total potential
energy Z Z Z
1
κ : m dΩ + γ · q dΩ − pw dΩ (9.4)
2 Ω Ω Ω
where p is the transverse pressure load, κ = 12 (∇θ + ∇θT ) is the curvature of the mid-surface, γ = ∇w − θ
is the transverse shear strain, m = E : κ is the bending moment, and q = G · γ the transverse shear force
vector. The fourth order tensor E and second order tensor G define the bending and shear rigidities of the
cross section, respectively. For linearly elastic materials we have G · γ = Gtγ and
ν
E : κ = K[κ + (trκ)I] (9.5)
1−ν
where K = Et3 /[12(1 − ν 2 )] is the bending stiffness, E is Young’s modulus, G shear modulus, and ν
Poisson ratio. The design of the tensors E and G for orthotropic and perforated materials is discussed in
section 9.3.
∇·m+q =0 (9.6)
−∇ · q = p (9.7)
where T is a second order tensor representing the given normal force (usually T = T I, where T is constant).
The equilibrium equation (9.7) is then rewritten as
−∇ · (q + T · ∇w) = p (9.9)
K∆∆w − T ∆w = p (9.11)
where γ h is called the reduced shear strain (sometimes also referred to as the assumed or substitute shear)
and q h = (t2 + αh2 )−1 G · γ h the reduced shear force. Here h is the mesh size (the diameter of the biggest
element) and α > 0 is a numerical stabilization parameter (typically α = 0.15).
The reduced shear γ h is defined elementwise such that
γ h|K = (aK − bK y, aK + cK x) (9.13)
for any element K. The parameters aK , bK , and cK , are determined from the conditions
Z
(γ − γ h ) · t ds = 0 (9.14)
E
basic
element
2a
b
Figure 9.1: The basic element of the perforated plate consisting of five rectangular beams
The midplane tension of the perforated plate may be reduced to lateral stresses of the orthotropic plate
by a simple scaling, p
T = (1 − 4a2 /b2 ) T0 , (9.19)
where is the tension T0 of the perforated plate. Using this reduced tension and the modified material param-
eters of equations (9.15), (9.16) and (9.17) the orthotropic plate mimics the behavior of the perforated plate
when looking at macroscopic quantities. However, the model is not suitable for approximating maximum
stresses around the holes, for example.
9.4 Keywords
Solver solver id
discontinuous at h = b − 2a.
Bibliography
[1] F. Auricchio and R.L. Taylor. A triangular thick plate finite element with an exact thin limit. Finite
Element in Analysis and Design, 19:57–68, 1995.
[2] M. Fortin F. Brezzi and R. Stenberg. Error analysis of mixed-interpolated elements for reissner-mindlin
plates. Mathematical Models and Methods in Applied Sciences, 1:125–151, 1991.
[3] M. Lyly. On the connection between some linear triangular reissner-mindlin plate bending elements.
Numerische Mathematik, 85:77–107, 2000.
[4] M. Lyly and R. Stenberg. Stabilized mitc plate bending elements. In Advances in Finite Element
Techniques (M. Papadrakakis and B.H.V. Topping, eds.) Civil Comp Press., pages 11–16, 1994.
[5] R.H. MacNeal. Derivation of element stiffness matrices by assumed strain distribution. Nucl. Engrg.
Design, 70:3–12, 1982.
[6] M. Pedersen, W. Olthuis, and P. Bergveld. On the mechanical behaviour of thin perforated plates and
their application in silicon condenser microphones. Sensors and Actuators, A 54:6.
[7] A. Tessler and T.J.R. Hughes. A three-node mindlin plate element with improved transverse shear.
Comp. Meths. Appl. Mech. Engrg., 50:71–101, 1985.
[8] Z. Xu. A thick-thin triangular plate element. Int. J. Num. Meths. Eng., 33:963–973, 1992.
10.1 Introduction
The solver described in this section can be used to solve structural beam equations. The equilibrium equa-
tions are expressed in terms of stress resultants N and M that represent forces and moments experienced
by the cross section of a beam. If the cross section is considered to be an oriented surface with positive unit
normal e1 , the stress resultant N is defined by
Z
N = σe1 dA (10.1)
A
where σ is the stress tensor and A denotes the cross section of the beam. Generally N is resolved into
components with respect to an orthonormal basis {e1 , e2 , e3 } associated with a local frame which has its
origin at the intersection of the cross section and the axis of the beam. The coordinates of points with respect
to this frame are denoted by (y1 , y2 , y3 ) with the y1 -axis being aligned with the axis of the beam, while the
other two axes are assumed to coincide with the principal directions of the cross section. The stress resultant
M = M1 e1 + M2 e2 + M3 e3 has as its components the bending moments
Z Z
M2 = y3 (σe1 ) · e1 dA, M3 = − y2 (σe1 ) · e1 dA, (10.2)
A A
while M1 is a torsional moment. We note that in general accurate modelling of the torsion is not a simple
problem and here a rudimentary approximation will only be employed.
−N 0 (s) = F (s),
(10.3)
−M 0 (s) − t(s) × N (s) = G(s),
where F and G are the densities of applied forces and moments per unit length and t(s) ≡ e1 (s) is tangential
to the beam axis. It should be noted that F and G can be considered to include inertial body forces to obtain
equations for transient cases.
In the case of Timoshenko’s treatment of shear deformation, suitable generalized measures of strain may
be expressed as
where u : [0, L] → R3 is the displacement of the beam axis and the components of θ : [0, L] → R3 are the
so-called rotations. It is noted that the underlying approximation of the displacement u3D for a generic point
r(s) + y2 e2 (s) + y3 e3 (s) of the cross sections is given componentwise by
where
D = diag(EA, GAk2 , GAk3 ) (10.7)
and
E = diag(GJT , EI2 , EI3 ). (10.8)
Here E and G are Young’s modulus and the shear modulus, respectively, while JT and Ik give a torsional
constant and the second moments of area, respectively. The parameters kj are known as the shear correction
factors.
ZL ZL
0
− N · v ds = F · v ds,
0 0
(10.9)
ZL ZL ZL
− M 0 · ψ ds − t × N · ψ ds = G · ψ ds
0 0 0
ZL ZL
0
N · v ds = F · v ds + N (L) · v(L) − N (0) · v(0),
0 0
(10.10)
ZL ZL ZL
M · ψ 0 ds − t × N · ψ ds = G · ψ ds + M (L) · ψ(L) − M (0) · ψ(0).
0 0 0
In order to specify forces exerted upon the beam by the environment, we shall set
By using (10.4) and (10.6) and by including transient inertia terms, the equations (10.10) lead to the
standard abstraction of the problem: Find w ≡ (u(·, t), θ(·, t)) ∈ U such that
with
ZL ZL ZL ZL
0 0
a(w, z) = mü · v ds + I m θ̈ · ψ ds + Eθ · ψ ds + D(u0 − θ × t) · (v 0 − ψ × t) ds (10.14)
0 0 0 0
and
ZL ZL
l(z) = F · v ds + G · ψ ds + N L · v(L) + N 0 · v(0) + M L · ψ(L) + M 0 · ψ(0). (10.15)
0 0
Here m is the mass per unit length and the diagonal I m gives the (mass) moments of inertia. In addition, U
and V denote the sets of kinematically admissible functions and test functions, respectively.
10.4 Keywords
Simulation
Coordinate System String Cartesian 3D
The coordinate system should be selected to be three-dimensional, as no specific orientation of
the beam axis is supposed.
Material mat id
The following keywords relate to specifying the material parameters and the cross section data.
Youngs Modulus Real
This keyword specifies the value of Young’s modulus E.
Shear Modulus Real
This keyword specifies the value of G.
Density Real
This keyword is used for defining the density of the material. The density is needed in transient
cases to include the effects of inertial forces.
Cross Section Area Real
This keyword specifies the area A of the cross section.
Principal Direction 2(3) Real
The three components given by using this keyword should define the direction of the local y2 -
axis, so that the vector e2 can be computed. This direction must be orthogonal to the beam axis
that is determined by the coordinates of the element nodes. If this keyword is not specified, the
default value e2 = (0, 0, −1) is used.
Torsional Constant Real
To get an approximation of the torsional effects, the value of the parameter JT can be given.
Second Moment of Area 2 Real
This keyword should give the value of the integral I2 ≡ A y32 dA.
R
Solver solver id
Equation String
A describing name for the solver.
Procedure File "BeamSolver3D" "TimoshenkoSolver"
The name of the solver subroutine.
Variable String Deflection[U:3 Theta:3]
The name of the solver variable can be chosen freely (but it is must be used consistently else-
where).
Variable DOFs Integer 6
There is no need for using this keyword as the only possible value is 6 and it is given automat-
ically by the solver. The first three components of the solver variable define the displacement
u of the beam axis (the default variable name U), while the rest give the vector θ (the default
variable name Theta). In this connection the components of both the vectors are defined with
respect to the global coordinate frame.
Body Force bf id
11.1 Introduction
The utility described in this section can be used to add nodewise specified springs and masses to structural
models. This utility is generic and should be applicable to several structural models including equations
of linear and nonlinear elasticity, shells, plates and beams. It should be noted that some models may be
defined to have pointwise springs or masses without using this utility, provided the set of boundary elements
includes point elements and the model itself can handle springs or masses. The utility considered here does
not however depend on the content of the mesh file defining boundary elements, since the places of the
springs and masses are now supposed to be specified in terms of the indices of the mesh nodes.
Boundary Condition Y
Target Nodes(...) = ...
Spring 1 = ...
Spring 2 = ...
Spring 3 = ...
...
End
An additional mass (and moment of inertia when applicable) may be added in a similar way by using a
keyword Mass i, with i being an integer string.
11.3 Keywords
Solver id
Displacement Variable Name String
The value of this keyword must be the variable name of the solver which is modified to have
additional springs or masses. The default value is "Displacement".
Boundary Condition bc id
Spring i Real
This keyword may be used to create a reaction which is proportional to the value of the ith
global DOF (degree of freedom) of the finite element used to discretize the primary model.
Mass i Real
With this keyword, the mass matrix of the model can be modified by assembling an additional
diagonal mass matrix. The integer string i of the keyword refers to ith global DOF (degree of
freedom) of the element. In the basic 3D simulation the values for all i∈ {1, 2, 3} should be
the same by physical reasons as they originate from the same scalar property. With i > 3 an
additional moment of inertia may be given for models for which it is meaningful (for example a
shell model).
Models of Acoustics
12.1 Introduction
This module solves the Helmholtz equation, which is the Fourier transform of the wave equation. In addition
to the basic equation the solver may take into consideration variable density, background convections field,
simple damping and special boundary conditions with other time-harmonic solvers.
12.2 Theory
For example, sound propagation in air is fairly well described by the wave equation:
1 ∂2p
− ∇2 p = 0. (12.1)
c2 ∂t2
When linear the equation may be written in frequency space as
k 2 P + ∇2 P = 0, (12.2)
where k = ω/c. This is the Helmholtz equation. The instantaneous pressure may be computed from the
given field P :
p(t) = <(P eiωt ) = <(P ) cos(ωt) − =(P ) sin(ωt), (12.3)
√
where i = −1 is the imaginary unity.
In Elmer the equation has an added term which is proportional to first time derivative of the field, where-
upon the equation becomes
(k 2 − ikD)P + ∇2 P = 0, (12.4)
where D is the damping factor.
∇P · ~n = g, (12.5)
also Dirichlet boundary conditions may be set. The Sommerfeldt or far field boundary condition is as follows
iω
∇P · ~n + P = 0, (12.6)
Z
where the complex-valued quantity Z may be defined by the user. It is noted that incoming and outgoing
waves may be approximated by setting Z = ±c, respectively.
A special kind of flux condition is one with a given harmonic velocity field that is obtained from a
harmonic solution of a flow or structure equation. When the velocity field ~v is given then the flux is obtained
from
g = iωρ~v · ~n (12.7)
where ρ is the fluid density. If harmonic displacement is given instead a further term iω appears in the
equation.
12.3 Keywords
Simulation
This section gives values to parameters concerning the simulation as whole.
Frequency Real
Give simulation frequency in units of 1/s. Alternatively use the Angular Frequency key-
word.
Angular Frequency Real
Give simulation frequency in units of 1/rad. Alternatively use the Frequency keyword.
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere. Note also that for the Helmholtz equation ILUT
preconditioning works well.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Helmholtz Logical
If set to True, solve the Helmholtz equation, the name of the variable must match the Equation
setting in the Solver section. Alternatively use the Active Solvers keyword.
Initial Condition ic id
The initial condition section may be used to set initial values for the field variables. The following
variables are active:
Pressure i Real
For each the real and imaginary parts of the solved field i= 1, 2.
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be set in Helmholtz equation.
Body Force bf id
Pressure Source i Real
The pressure sources of the real (i = 1) and complex (i = 2) parts. The use of this is rather
seldom.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. The one related to
Helmholtz equations are
Pressure i Real
Dirichlet boundary condition for real and imaginary parts of the variable. Here the values i= 1, 2
correspond to the real and imaginary parts of the unknown field.
Wave Flux 1,2 Real
Real and imaginary parts of the boundary flux. Here the values i= 1, 2 correspond to the real
and imaginary parts of the boundary flux.
Wave Impedance 1,2 Real
This keyword may be used to define the real and imaginary parts of the quantity Z in (12.6).
Here the values i= 1, 2 correspond to the real and imaginary parts of Z.
Plane Wave BC Logical
Automatically sets the boundary conditions assuming outgoing plane waves if set True.
13.1 Introduction
The basic acoustic equations such as the Helmholtz equation, which is frequently taken as the starting point
in acoustic analyses, are based on the assumption of lossless flow, i.e. the effects of viscosity and heat
conduction are neglected. These effects are significant, however, in thin zones near a solid boundary. In this
chapter, a system of acoustic field equations taking into account the effects of viscosity and heat conduction
is described. Consideration is confined to the time-harmonic solution of these equations.
For numerical approximation the system (13.7) is rewritten as a mixed problem; to motivate this, see [2].
The mixed formulation is written as
~v − i∇τ − i∇φ + i∇(∇ · ~v ) + i∆~v = −(i/ω)~b,
i 1 1 ih
− ∆τ − τ+ φ= ,
(γ − 1)δ γ−1 1 + iγk 2 η βT0 ω 2 (13.9)
γk 2
i∇ · ~v − φ = 0,
1 + iγk 2 η
where φ is an auxiliary unknown, τ is the scaled temperature defined by
ωβ
τ= T (13.10)
γk 2
and
ω µ CV µ λ
k= = δ= η= (13.11)
c ρ0 ω κ µ
with c the adiabatic sound speed defined by the relation
It should be noted that although the solver of the acoustic equations is based on the formulation (13.9), the
solver overwrites the approximations of τ and φ by the unscaled temperature and the pressure, which may
be expressed as
1
p = ρ0 ω(τ + φ). (13.13)
1 + iγk 2 η
It is assumed that β = 1/T0 . This value is obtained by evaluating the coefficient of thermal expansion
for the equilibrium values of the state variables in the case of an ideal gas.
where ~t is a tangent vector to the boundary, cσ is the momentum accommodation coefficient and Tw and
~vw are the reference wall temperature and velocity. Here the reference wall temperature is defined to be the
deviation of the wall temperature from the equilibrium temperature T0 . The similar boundary condition for
the heat flux is given by
KU = F
the standard GCR method generates a sequence of improving approximations such that each iterate U (k)
minimizes ||F − KU (k) || over the so-called Krylov subspace. The standard algorithm can be modified
easily so that the update direction can be chosen flexibly. Obviously, an optimal update direction would be
given by the current error e(k) = U − U (k) . To find an approximation to the error one may apply an iterative
method to
Ke(k) = r(k) ,
where r(k) = F − KU (k) is the residual. The preconditioned GCR algorithm which employs this idea to
find the update direction can be described as follows:
Form an initial guess U (0)
r(0) = F − KU (0)
k=0
while (Stopping criterion is not met)
Solve Ks(k+1) = r(k) iteratively using at most m iteration steps
v (k+1) = Ks(k+1)
do j = 1, k
v (k+1) = v (k+1) − < v (j) , v (k+1) > v (j)
s(k+1) = s(k+1) − < v (j) , v (k+1) > s(j)
end do
v (k+1) = v (k+1) /kv (k+1) k
s(k+1) = s(k+1) /kv (k+1) k
U (k+1) = U (k) + < v (k+1) , r(k) > s(k+1)
r(k+1) = r(k) − < v (k+1) , r(k) > v (k+1)
k =k+1
end while
Here the inner product and norm are defined by < v, r >= v · r and kvk =< v, v >1/2 . The GCR iteration
steps used to update the approximation of U are referred to as outer iterations, while the iteration steps of
the preconditioning iterative method used for solving the new search direction s(k+1) are referred to as inner
iterations.
Here the GCR algorithm is also used as the inner iterative method. In connection with the inner iterations
a special block-preconditioner is used. The preconditioning is done by solving approximately the block-
triangular system of the form
A B∗ B∗ 0
sv rv
0 C D 0 sτ = rτ ,
0 E (13.14)
G H sφ rφ
0 0 0 M ψ rφ
where sv , sτ and sφ are update directions for the errors of v, τ and φ. In addition, ψ is an auxiliary unknown
which has been introduced so as to handle the boundary conditions of the preconditioner is a consistent way.
In practice, an approximate solution of (13.14) is constructed by applying iterative methods to the systems
of the type
M ψ = rφ , (13.15)
C D sτ rτ
= (13.16)
E G sφ r̂φ
and
Asv = r̂v , (13.17)
where r̂φ and r̂v are modified right-hand sides the computation of which requires the evaluation of certain
matrix-vector products. The special solver discussed hence requires that iterations are performed on three
levels.
One of the key ideas in the nested application of the GCR algorithm is that the outer iteration can be
made rapidly convergent. Consequently the optimality of the outer iteration need not be sacrificed by using
such techniques as restarting or truncation. A few inner iterations are usually enough to produce a useful
reduction in the outer iteration residual. Therefore the maximum number of iterations the inner iterative
method may take need not be large. We have found that limiting the number of inner iterations by taking
m = 5 (this is the default value) or m = 10 leads often to an efficient method. In addition to specifying
the maximum number of inner iterations, the user can control the residual reduction in the outer iteration
process by specifying the error tolerance δinner so that the inner GCR iteration is stopped if
kr(k) − K ŝ(k+1) k < δinner kr(k) k, (13.18)
(k+1) (k+1)
where ŝ is the approximation to s . The default value of δinner is 0.1.
Ideally a mild stopping criterion should be used in the solution of the linear systems of the type (13.15)–
(13.17) which arise in the block-preconditioning of the inner iteration. The iterative solution of (13.15) being
a cheap operation, the overall cost of the block-preconditioning is essentially determined by the solution of
the systems of the type (13.16) and (13.17). These systems are solved using the preconditioned BiCGStab(l)
method. In this connection the Jacobi and incomplete LU factorization preconditioners can be applied.
13.4 Utilities
The dissipative acoustics solver may be used in resolving the acoustic impedance of a system. The value of
the impedance defined by R
p dS
zi = R Si (13.19)
Si
~v · (−~n) dS
may automatically be calculated for a given boundary Si . Here this impedance will be referred to as the
specific acoustic impedance of the surface (Si ).
The acoustic impedance is divided into two parts, a part in phase with velocity and a part out of phase
with velocity. The value of the impedance zi is meaningful only when the velocity on the input boundary is
considered. It is though possible to calculate the response over an other boundary Sj and to compare it to
the input velocity, i.e. one may compute
R
Sj
p dS
zij = R . (13.20)
Si
~v · (−~n) dS
This impedance is here called the cross specific acoustic impedance.
13.5 Keywords
The following keywords are particularly related to the acoustics solver.
Simulation
Angular Frequency Real
This keyword is used to declare the angular frequency. Alternatively one may define the fre-
quency by using the Frequency keyword.
Frequency Real
This keyword is used to declare the frequency. Alternatively one may define the angular fre-
quency by using the Angular Frequency keyword.
Simulation Type String
The value of this keyword should be either Steady State or Scanning. The value Scanning
may be used to obtain results for several frequencies by using a single sif-file.
Coordinate System String
The coordinate system must be set to be one of the following options: Cartesian 2D, Cartesian
3D or Axi Symmetric.
Solver solver-id
The following keywords may be used in the solver section that contains solver parameters for the
acoustics solver.
Equation String
This keyword can be used to give a name for the discrete acoustic equations
Procedure File Acoustics AcousticsSolver
This keyword is used to give the Elmer solver the place where to search for the acoustics solver.
Variable String Flow
The name Flow is used for the solution of the acoustics equations consisting of the amplitudes
of the disturbances of the velocity, temperature and pressure from the equilibrium state (note that
the disturbance of the density is not computed explicitly). The acoustics solver uses a convention
that if dim is the coordinate system dimension then the components 1, ..., 2 × dim of Flow give
the real and imaginary parts of velocities (Flow.1 and Flow.2 are the real and imaginary
parts of the first velocity component, etc.). The temperature and pressure solutions come after
the velocity solution.
Variable Dofs Integer
The value of this keyword should equal to 2 × (dim + 2) where dim is the coordinate system
dimension.
Element String
The use of standard finite elements in the approximation of the acoustic equations is likely to
lead to an unstable method. The finite element formulation can be stabilised by using additional
bubble finite element functions in the approximation of velocities. If this keyword is given the
value p:1 b:n, with n an integer, then n additional bubble functions contained in the p-element
library are used in the approximation of each velocity component.
Bubbles in Global System Logical
This keyword should be given the value False, so that the additional bubble basis functions
needed for the stability are eliminated via the static condensation.
Utilize Previous Solution Logical
If a single sif-file is used to compute the solutions for several frequencies, then the previous
solution can be used as an initial guess for the next iterative solution. This can be done by giving
the value True for this keyword.
Material material-id
The following keywords are related to the use of block preconditioning and may be given in the Solver
section.
Solver solver-id
Block Preconditioning Logical
The value of this keyword should be set to be True to enable the use of block preconditioning.
Max Outer Iterations Integer
The value of this keyword defines the maximum number of outer iterations.
Max Inner GCR Iterations Integer
This keyword is used to define the value of the parameter m, i.e. the maximum number of inner
iterations. The default value is 5.
Ratio of Convergence Tolerances Real
This keyword is used to define the stopping criterion for the outer iteration. The outer iteration
is stopped when
Here εr is defined using this keyword and ε is the value of the Linear System Convergence
Tolerance keyword. Having εr 1 is desirable.
Residual Reduction Ratio Real
This keyword is used to define the value of the parameter δinner in the stopping criterion (13.18).
The default value is 0.1.
is used. Here ε is the value of this keyword. It is noted that the solution accuracy of (13.15) need
not be specified by the user.
Velocity Convergence Tolerance Real
The systems (13.16) and (13.17) may solved with different degrees of accuracy. Instead of using
the Linear System Convergence Tolerance keyword one may specify the solution
accuracy for (13.17) by using this keyword.
Schur Complement Convergence Tolerance Real
The systems (13.16) and (13.17) may solved with different degrees of accuracy. Instead of using
the Linear System Convergence Tolerance keyword one may specify the solution
accuracy for (13.16) by using this keyword.
Linear System Max Iterations Integer
In connection with the block-preconditioning the Linear System Max Iterations key-
word is used for defining the maximum number of iteration steps which can be taken in the
iterative solution of (13.15)–(13.17).
Velocity Assembly Logical
The coefficient matrix A in (13.17) corresponds to the (1,1) block of the coefficient matrix K.
As the elements of A can be extracted from K, the assembly of A can be avoided if a diagonal
preconditioning is used in the iterative solution of (13.17). If an incomplete factorization pre-
conditioner is used, the matrix A is assembled explicitly. In this case the value True must be
given for this keyword.
ILU Order for Schur Complement Integer
The value of this keyword defines the fill level for the incomplete LU factorization preconditioner
that is applied in the iterative solution of the linear systems of the type (13.16).
ILU Order for Velocities Integer
The value of this keyword defines the fill level for the incomplete LU factorization preconditioner
that is applied in the iterative solution of the linear systems of the type (13.17). If this keyword
is not given, then a diagonal preconditioning is used. This keyword has an effect only when the
Velocity Assembly keyword is given the value True.
Bibliography
[1] M. Malinen. Boundary conditions in the schur complement preconditioning of dissipative acoustic
equations. SIAM J. Sci. Comput., 29:1567–1592, 2007.
[2] M. Malinen, M. Lyly, P. Råback, A. Kärkkäinen, and L. Kärkkäinen. A finite element method for the
modeling of thermo-viscous effects in acoustics. In P. Neittaanmäki et. al., editor, Proceedings of the
4th European Congress on Computational Methods in Applied Sciences and Engineering, 2004.
Wave Equation
14.1 Introduction
This module can be used to solve a generalized version of the wave equation in time domain. It provides an
alternative to the Helmholtz equation which follows from the wave equation by transforming to the frequency
domain.
14.2 Theory
This solver can be used to handle the following generalized version of the wave equation:
1 ∂2p η ∂p α ∂p
− + ∆p + 2 ∆( ) − 2 = f, (14.1)
c2 ∂t2 c ∂t c ∂t
with c and f being the sound speed and a source function, respectively. In addition, η and α are model
parameters, which can also be set to be zero to obtain the standard wave equation.
In the case of sound waves the equation (14.1) can be obtained from the equation of motion and the
continuity equation by linearization. By assuming an isentropic fluid and irrotational flow, we then come to
considering the velocity-pressure system
∂v
ρ0 − η̂∇(∇ · v) + α̂v − ∇P = ρ0 b,
∂t
(14.2)
1 ∂P
+ ∇ · v = 0,
ρ0 c2 ∂t
where ρ0 is the density of the fluid at the equilibrium state, η̂ is a parameter related to the fluid viscosity
and α̂ is a reaction parameter. If we use the continuity equation to eliminate the divergence term from the
equation of motion and set η = η̂/ρ0 , α = α̂/ρ0 and p = P/ρ0 , the velocity-pressure system can also be
expressed as
∂v η ∂p
+ 2 ∇( ) + αv − ∇p = b,
∂t c ∂t (14.3)
1 ∂p
+ ∇ · v = 0.
c2 ∂t
1 ∂2p ∂v
− −∇·( )=0 (14.4)
c2 ∂t2 ∂t
then yields (14.1), with f ≡ ∇ · b.
Boundary conditions. Basically boundary conditions of three types can be given. In addition to a basic
Dirichlet constraint, one can specify the Neumann constraint
η ∂p
− ∇p · n − ∇( ) · n = g. (14.5)
c2 ∂t
In the absence of body forces and reaction terms (b = 0 and α = 0), the value of g is related to the normal
component of the acceleration via
∂v
g=− · n.
∂t
The final option is to set
η ∂p 1 ∂p
− ∇p · n − 2 ∇( ) · n = (14.6)
c ∂t c ∂t
in order to approximate outgoing waves, especially when η is small.
14.3 Keywords
Solver solver id
The following keywords are especially related to the wave equation solver.
Equation String
This keyword can be used to give a name for the equation handled by the solver.
Procedure File "WaveSolver" "WaveSolver"
This specifies the name of the solver subroutine.
Variable String "Excess Pressure"
The name of the solver variable can be chosen freely.
Variable DOFs Integer
The value of this keyword must be 1.
Time Derivative Order Integer
There is no need for using this keyword as the only possible value is 2 and it is given automati-
cally by the solver.
Initial Condition ic-id
The initial condition section may be used to set initial values for the field variable. The form of the
commands depends on the name given for the solver variable.
Material mat id
The material section is used to give the values of the material parameters.
Sound Speed Real
This keyword is used to give the value of the sound speed c.
Sound Damping Real
This keyword is used to give the value of the parameter η.
Sound Reaction Damping Real
This keyword is used to give the value of the parameter α.
Body Force bf id
Although volumetric sources may be rare, there is an option to specify such a source.
15.1 Introduction
This module contains a monolithic solver for the compressible Navier–Stokes equations subject to the ideal
gas law. It can be used to model the fully nonlinear wave propagation in the time domain.
p = RρT, (15.1)
∂~v
ρ[ + (~v · ∇)~v ] − µ∆~v − (µ + λ)∇(∇ · ~v ) + Rρ∇T + RT ∇ρ = ~b, (15.2)
∂t
the energy equation
∂T
ρCV ( + ~v · ∇T ) − K∆T + RρT ∇ · ~v = 0, (15.3)
∂t
and the continuity equation
∂ρ
+ ~v · ∇ρ + ρ∇ · ~v = 0. (15.4)
∂t
Here ~v , ρ and T are the fluid velocity, density and temperature, respectively, and the material properties are
expressed in terms of the viscosity parameters µ and λ, the heat conductivity K and the specific heat CV ,
with R = (γ − 1)CV .
If ρ0 and T0 are the equilibrium values of density and temperature, we may then write
ρ = ρ0 + δ, T = T0 + τ, (15.5)
so that δ and τ give the disturbances in ρ and T . To solve the coupled system consisting of (15.2)–(15.4) the
fully implicit time integration is employed. At each time level a nonlinear iteration is thus applied. Given
with the time derivatives approximated using suitable finite difference schemes. It is recommended that the
BDF(2) method is used for the time discretization. It is also noted that the pressure is not approximated
directly, so it has to be computed separately using (15.1) and (15.5).
It should be noted that the solver is tailored to the case of the lowest-order continuous temperature and
density approximation. To obtain stable finite element solutions the velocity discretization must be enhanced
by using elementwise bubble functions or by rising the polynomial order of the velocity approximation.
Therefore a special element type definition in the solver input file should be given.
15.3 Keywords
The keywords that are related especially to this solver are described in the following.
Simulation
Coordinate System String
The coordinate system must be set to be one of the following options: Cartesian 2D,
Cartesian 3D or Axi Symmetric.
Solver solver id
Equation String
A name to the equation may be given by using this keyword.
Procedure File "CompressibleNS" "CompressibleNS"
This keyword is used to give the Elmer solver the place where to search for the compressible
Navier–Stokes solver.
Variable String
A name to the solver variable should be given by using this keyword.
Variable DOFs Integer
The value of this keyword should equal to dim + 2 where dim is the coordinate system dimen-
sion. The field variables are organized in such a way that the first dim components correspond
to the velocity solution and the temperature and density fluctuations come after the velocity.
Element String
The user has to specify what strategy is used for enhancing the velocity approximation by giving
the element type definition. If the command Element = ”p:2” is given, then the velocity is
approximated using the shape functions of the second order elements. The element type defini-
tion Element = ”p:1 b:1” can be given to enhance the velocity approximation with one
bubble function.
Material mat id
Equilibrium Density Real
The equilibrium density ρ0 should be specified by using this keyword.
Equilibrium Temperature Real
The equilibrium temperature T0 should be specified by using this keyword.
Specific Heat Real
The value of this keyword specifies CV .
Models of Electromagnetism
Electrostatics
16.1 Introduction
The macroscopic electromagnetic theory is governed by Maxwell’s equations. In Elmer it is possible to
solve the electrostatic potential in linear dielectric material and in conducting medium. The dielectric case
is described in this Chapter. For static currents, refer to Chapter 17. Based on the potential, various field
variables as well as physical parameters, such as capacitance, can be calculated.
16.2 Theory
Maxwell’s equations are here written as
~
∇·D = ρ (16.1)
~
∇·B = 0 (16.2)
~
∂B
~
∇×E = − (16.3)
∂t
∂D~
~
∇×H = J~ + (16.4)
∂t
~ = µH
For linear materials the fields and fluxes are simply related, B ~ and D ~ = εE, ~ where the permittivity
ε = ε0 εr is defined through the permittivity of vacuum ε0 and the relative permittivity of the material εr .
In a stationary case the electric field may be expressed with a help of an electric scalar potential φ,
~ = −∇φ.
E (16.5)
Assuming linear material law and using the equation (16.1) gives
− ∇ · ε∇φ = ρ. (16.6)
If there is only one potential difference Φ present then the capacitance C may be computed from
2E
C= . (16.9)
Φ2
− ε∇φ · ~n = g. (16.10)
~r · ~n
g = εφ . (16.11)
r2
This may be implemented as an additional term to the matrix so that the linear nature of the problem is
maintained.
Conductors are often covered by thin oxidation layers which may contain static charges. The effect of
these charges can be taken into account by Robin type of boundary condition which combines the fixed
potential value on the conductor and the flux condition due to the static charges
εh 1 εh
g=− φ + ρh + Φ0 on the boundary, (16.12)
h 2 h
where εh and h are the permittivity and the thickness of the oxidation layer respectively, ρ is the static charge
density of the layer, and Φ0 is the fixed potential on the conductor.
Note that this formulation is valid only for thin layers. For a larger layer a separate body should be added
and a source defined for that.
q = Aφ. (16.13)
The induced charges on a body may be computed by summing up the point charges.
If there are n different bodies the boundary conditions are permuted n times so that body i gets a potential
unity while others are set to zero potential,
X
Cij = q. (16.14)
Γj
16.4 Keywords
Constants
Permittivity Of Vacuum Real [8.8542e-12]
Solver solver id
Equation String Stat Elec Solver
Variable String Potential
This may be of any name as far as it is used consistently also elsewhere.
Variable DOFs Integer 1
Degrees of freedom for the potential.
Procedure File "StatElecSolve" "StatElecSolver"
Following are listed four keywords with default values for output control.
Calculate Electric Field Logical [True]
Calculate Electric Flux Logical [True]
Calculate Electric Energy Logical [False]
Calculate Surface Charge Logical [False]
Calculate Capacitance Matrix Logical [False]
Capacitance Bodies Integer
In case of a capacitance matrix computation the number of bodies at different potential must be
given (not accounting the ground).
Capacitance Matrix Filename String
The name of the file where capacitance matrix is being saved. The default is cmatrix.dat.
Constant Weights Logical [True]
Used to turn constant weighting on for the results.
Potential Difference Real
Used to give the potential difference for which the capacitance is calculated, when capacitance
matrix calculation is not performed. This keyword gives thus the voltage between the electrodes
of a simple capacitor. The voltage has to be consistent with the potentials defined in boundary
conditions.
Material mat id
Relative Permittivity Real
Body Force bodyforce id
Charge Density Real
Boundary Condition bc id
Potential Real
If the name of the primary variable is potential then this sets the Dirichlet boundary condition.
Electric Flux Real
Neumann boundary condition in terms of g.
Surface Charge Density Real
Another way to define flux condition. Identical to the previous keyword.
Electric Infinity BC Logical
The spherical approximation for the open boundaries extending to infinity.
The following five keywords are used if a thin oxidation layer is modeled. Note that these are only
active if the Electric Flux BC keyword is set to True.
Layer Thickness Real
Defines the thickness of the oxidation layer. This is presumed to extend on the outside the
boundary.
Layer Relative Permittivity Real
The relative permittivity of the oxidation layer.
Layer Charge Density Real
The volume charge density in the oxidation layer.
Electrode Potential Real
The potential on the conductor behind the oxidation layer.
Capacitance Body Integer i
These should number from i=1 up to Capacitance Bodies. The ground may be given
directly with zero potential or with value 0 for this keyword. This definition is only needed in
the computation of the capacitance matrix where the potential is permuted in a very specific way.
17.1 Note
There is a vectorized and multithreaded version of the solver with almost the same functionality (some more,
some less) as module StatCurrentSolveVec.
17.2 Introduction
The macroscopic electromagnetic theory is governed by Maxwell’s equations. This module solves the elec-
trostatic potential in a conducting medium allowing volume currents and electric power loss (the Joule heat-
ing) to be derived.
17.3 Theory
In the electro-quasistatic approximation Maxwell’s equations are written as
~
∇·D = ρ (17.1)
~
∇×E ' 0 (17.2)
~
∂D
~
∇×H = J~ + (17.3)
∂t
so that the electric field may be expressed in terms of an electric scalar potential φ as
~ = −∇φ.
E (17.4)
In addition, the continuity equation for electric charges is easily obtained from (17.1) and (17.3):
∂ρ
+ ∇ · J~ = 0. (17.5)
∂t
Ohm’s law for conducting material gives the relationship between the current density and the electric
field,
J~ = σ E~ (17.6)
where σ is the electric conductivity. Starting from the continuity equation (17.5) and using the equa-
tions (17.6) and (17.4), we get
− ∇ · σ∇φ = ρt . (17.7)
This Poisson equation is used to solve the electric potential. The source term is often zero, but in some cases
it might be necessary. The vectorized and multithreaded version of the solver can also be used to handle a
generalized equation
∂E~
− ∇ · J~ − ∇ · (ε ) = 0, (17.8)
∂t
where ε is the permittivity. This version is a consequence of (17.3).
The volume current density in a conductor is now calculated by
J~ = −σ∇φ, (17.9)
and the density of electric power loss, which is turned into heat, by
h = ∇φ · σ∇φ. (17.10)
The latter is often called the Joule heating. The total heating power is found by integrating the above equation
over the conducting volume.
The user may also compute the nodal heating which is just the integral of the heating sampled at nodes.
CI = I0 /I, (17.14)
Two ways to visualize the derived quantities are available. The node values can be calculated by taking
the average of the derived values over a collection of neighbouring elements (constant weights). This often
results in visually good images. The other possibility is to weight the average with the size of the elements,
which is more accurate and should be used when some other variable depends on these derived values. The
latter choice is also the default.
17.5 Keywords
Solver solver id
Equation String Stat Current Solver
Variable String Potential
This may be any name as far as it is also used consistently elsewhere.
Variable DOFs Integer 1
Degrees of freedom for the potential.
Procedure File "StatCurrentSolve" "StatCurrentSolver"
18.1 Introduction
This module may be used to solve a version of the Maxwell equations in the A-V form. The approximation
of the associated vector potential variable A is here done by using vector-valued (edge) finite element basis
functions, while the classic Lagrange interpolation is applied to compute the scalar potential V . The use
of edge finite elements limits the applicability of this solver to 3D problems. In addition to performing the
computations in the time domain, the analogous version of the equations may also be solved in the frequency
domain. Several ways to handle stationary equations are also included. Furthermore, an additional solver
may be called to produce nodal and elementwise approximations of derived fields after the two potentials
have been obtained.
The equations over moving media are treated in the case of rigid motion. This implies that the associated
velocity field is divergence-free and the velocity gradient is both constant and skew.
We note that since our definition of the electromagnetic field depends on the notions of force and charge
which are assumed to be invariant quantities (under a change of observer), the electromagnetic field also has
an invariant nature. It is tacit here that if the separation of the known electromagnetic field into its electric
and magnetic components was sought via (18.4), the result would depend on the observer. However, we
shall not need such separation since solving for E 0 is enough to find the current density.
Otherwise the content of electromagnetic equations on a region Ω is here cast into a magnetic version of
Maxwell’s equations
∂B
curl E = − , (18.5)
∂t
1
curl( B) − J = g, (18.6)
µ
div B = 0, (18.7)
div J = 0, (18.8)
where µ is the permeability and g is a divergence-free source satisfying (for ways to ensure this condition
beforehand, see the description of the Helmholtz projection in the context of stationary equations below)
div g = 0. (18.9)
Writing this system in terms of the electromagnetic field defined by (18.4) via eliminating E and using
Ohm’s law (18.3) yields
∂B
− curl(v × B) + curl E 0 = 0, (18.10)
∂t
1
curl( B) − σE 0 = g, (18.11)
µ
div B = 0, (18.12)
div(σE 0 ) = 0. (18.13)
The content of this system is adequate for finding the instantaneous spatial solutions B(x, t) and E 0 (x, t) at
time t simultaneously over both static and moving parts of the model. Here the point x is thus specified by
its coordinates with respect to a single, fixed Cartesian coordinate frame.
If an Elmer model contains moving bodies, the spatial discretization is typically done over an instanta-
neous configuration whose representation is obtained via a rigid motion of the previous mesh into the current
configuration. In this case the time stepping machinery of Elmer by default produces an approximation to
the material time derivative of a spatial field (the material point is held fixed in the differentiation) when the
field is a scalar or vector field. It agrees with the usual definition of the substantial (or total) time derivative
of the spatial field. However, when the field is a one-form and is approximated by using edge finite elements
(here the case of the vector potential), a more subtle approach is needed to show that the computational
procedure leads to an approximation of the Lie derivative [1].
Since the computational procedure does not make it straightforward to evaluate the standard partial
derivatives with respect to time, the need of rewriting the equations in forms which employ other time
derivatives arises as a natural endeavour. To this end, we shall consider the upper convected time derivative
DB ∂B
= + (v · ∇)B − (B · ∇)v + (div v)B, (18.14)
Dt ∂t
which agrees with the Lie derivative Lv B of the vector B with respect to v when the motion is rigid so that
div v = 0. (18.15)
DB ∂B
≡ + (v · ∇)B (18.16)
Dt ∂t
as
DB DB
= − (B · ∇)v + (div v)B. (18.17)
Dt Dt
By using vector identities, the definition (18.14) can also be rewritten as
DB ∂B
= − curl(v × B) + v(div B). (18.18)
Dt ∂t
This immediately implies that, under Gauss’s law for the magnetic field (18.12), the content of the Faraday
law (18.10) can be expressed as
DB
+ curl E 0 = 0. (18.19)
Dt
Although we consider (18.19) to be a convenient way to express the Faraday law for our purposes, we do
not want to assert whether this useful mathematical reduction happens by chance or whether it should be
considered to reflect some theoretical underpinning.
If we think of A as a one-form, the formula for the Lie derivative of A with respect to v should be
written as (see, for example, [1])
∂A
Lv A = + (v · ∇)A + (∇v)T A. (18.20)
∂t
In the case of rigid motion, however, the velocity gradient is skew so that
Hence the vector representations for the Lie differentiation of vectors and one-forms become the same.
When the edge finite element basis functions defined on the reference element give the pull-back of
the basis functions on the physical element by the element mapping (the standard construction followed by
Elmer), evaluating the rate of change of the associated degrees of freedom gives coefficients to approximate
the finite element interpolant of the Lie derivative. That is, if ϕk (·) are linear functionals which define the
degrees of freedom of a one-form, it follows that
. 1
ϕk (Lv A) = [ϕk (A(·, τ + δt)) − ϕk (A(·, τ ))] (18.22)
δt
where τ is a fixed value of time and δt is a time increment. Thus writing the equations such that the Lie
derivatives are employed is seen to be very natural.
In practice the solution is sought in terms of potentials. In the first place we set
B = curl A. (18.23)
It should be noted that this implies some ambiguity, since the resulting set of equations does not have a
unique solution without imposing additional constraints on A(x, t). Otherwise, if A satisfies the equations,
any field Aφ having the decomposition Aφ = A + ∇φ may also be made to be a solution. The uniqueness
of A could be assured for example by seeking A(·, t) ∈ H(curl, Ω) ∩ H(div, Ω) that satisfies additionally
div A = 0
on Ω and
A·n=0
on the boundary ∂Ω.
In the case of the vector potential description (18.23) the Faraday law in the form (18.10) yields
∂A
curl( − v × curl A + E 0 ) = 0,
∂t
so we may automate the satisfaction of the Faraday law by seeking the solution in the form
∂A
− v × curl A + E 0 = −∇ψ, (18.24)
∂t
with ψ being an unknown scalar potential. Switching to the substantial time derivative then gives
DA
− (v · ∇)A − v × curl A + E 0 = −∇ψ. (18.25)
Dt
Straightforward calculation shows that this is equivalent to
DA
− (∇A)T v + E 0 = −∇ψ (18.26)
Dt
and, by using the vector identity
we further obtain
DA
+ (∇v)T A + E 0 = −∇(ψ − v · A). (18.28)
Dt
By setting
ψ = V + v · A, (18.29)
the content of (18.28) can finally be expressed as
Lv A + E 0 = −∇V. (18.30)
The equation (18.30) offers the possibility of eliminating the field E 0 from the set of primary unknowns
while the additional constraint (18.13) serves the determination of V . It should be noted that the scalar
potential ψ is related to the field E via
∂A
+ E = −∇ψ.
∂t
The relation (18.29) can be used to recover ψ after A and V have been solved.
To derive a weak version of the equations, let v be an appropriate test function for V , so that we have v ∈
H 1 (Ω). Multiplying (18.13) with v, integrating by parts and using (18.30) bring us to the weak formulation
Z Z Z
σ(Lv A) · ∇v dΩ + σ∇V · ∇v dΩ = − (σE 0 ) · n v dS. (18.31)
Ω Ω ∂Ω
The determination of the scalar potential V is thus joined with the possibility of specifying either V or the
normal component of the current density σE 0 on the boundary. If the normal component of the current
density is specified on the entire boundary ∂Ω as
− (σE 0 ) · n = jn , (18.32)
On the other hand, by using (18.23) and (18.30), we may rewrite (18.11) as
1
σ(Lv A) + σ∇V + curl( curl A) = g (18.33)
µ
to obtain the weak version
Z Z Z
1
σ(Lv A) · η dΩ + σ∇V · η dΩ + curl A · curl η dΩ
µ
Ω Ω Ω
Z Z (18.34)
1
+ ( curl A) · (η × n) dS = g · η dΩ,
µ
∂Ω Ω
with η an appropriate test function corresponding to A. The weak formulations obtained from (18.34) and
(18.31) generally form the basis for the A-V formulation of the problem.
It should be noted that here we have avoided seeking a unique solution in the space
as only the requirement A(·, t) ∈ H(curl, Ω) appears to be necessary in this derivation. The Elmer im-
plementation relies on this minimal regularity assumption so that a finite element approximation Ah (·, t)
is sought from an edge finite element space X h ⊂ H(curl, Ω). This simplification however leads to the
inconvenience that the uniqueness of the vector potential solution cannot be ensured. Thus, given a solution
(A, V ), we can generate another solution (Aφ , Vφ ) ≡ (A + ∇φ, V − Lv φ), although the associated fields
B and E 0 remain invariant.
The steady state solution of the evolutionary equations. Sometimes the steady state solution of the evo-
lutionary model may be of an interest. For example the steady state solution of a case where a homogeneous
disk is spun with a constant angular velocity in a region in which there is a steady magnetic field without
circumferential variation can be described over a fixed domain. Then (18.24) yields
In this special case the scalar potential variable of the solver is taken to be ψ.
In this connection, we note that when a body makes a rigid rotation about the line through the origin o
spanned by the angular velocity ω, the velocity field is described by the formula
We also note that the term (∇v)T A occurring in the expression for the Lie Derivative has the following
representation in terms of ω
(∇v)T A = −(∇v)A = −ω × A. (18.37)
A Poynting’s theorem for electromagnetic energy. The magnetic energy density is defined by
1
Wm = B · H. (18.38)
2
Let us define a Poynting vector S 0 corresponding to our definition of the electromagnetic field E 0 by
S 0 = E 0 × H, (18.39)
D 1 DB
( B · H) = · H. (18.41)
Dt 2 Dt
We hence come to the conservation principle of the magnetic energy expressed as
DWm
+ div S 0 = −E 0 · (σE 0 + g). (18.42)
Dt
The right-hand side of (18.42) describes the power per unit volume of the heating effect of the electric current
which is called the Joule effect.
Since the displacement current has been neglected in the magnetic version of the equations considered,
the above conservation principle does not contain an electric energy density term. Elmer however calculates
the total electromagnetic energy density as
Wm + We
with
1 0
We = εE · E 0 . (18.43)
2
Here ε is the permittivity.
Solution in the frequency domain. The equations in the A-V form may also be solved in the frequency
domain. In this case the ansatz A(x, t) = A(x) exp(iωt) and V (x, t) = V (x) exp(iωt) is made to obtain
the analogous set of equations for determining the complex-valued amplitudes A(x) and V (x). In addition,
we employ (18.24) with ψ = V .
and Z Z
σ∇V · ∇v dΩ = − (σE 0 ) · n v dS. (18.45)
Ω ∂Ω
As the solution of V and A can then be done sequentially by first solving for V , the basic scenario for
applying the solver to stationary cases is that only the field A is solved by employing the weak formulation
Z Z Z
1 1
curl A · curl η dΩ + ( curl A) · (η × n) dS = g S · η dΩ (18.46)
µ µ
Ω ∂Ω Ω
for any admissible variation q of Q. Integration by parts is used to obtain the version
Z Z Z
∇Q · ∇q dΩ = g U · ∇q dΩ − P(g U ) · nq dS. (18.48)
Ω Ω ∂Ω
g U = −σ∇V s , (18.49)
to obtain a close resemblance of g U and P(g U ) (especially, P(g U ) = g U when g U is already divergence-
free) it is natural to set
P(g U ) · n = g U · n (18.50)
on the boundary where the current density was prescribed. On the remaining part of the boundary where the
Dirichlet constraint was specified for V s the homogeneous Dirichlet constraint for the field Q may be used.
Here M s is referred to as the magnetization. It arises from using a constitutive law of the form
H = µ−1 B − M s . (18.53)
The last terms in (18.51) and (18.52) enable the direct generation of the source electric current density in
terms of the source potential V s without first computing g U from (18.49).
To conclude, we note that it is also possible to solve the stationary equations such that both A and V are
handled as unknowns and solved simultaneously by employing the variational equations
Z Z Z Z
1 1
σ∇V · η dΩ + curl A · curl η dΩ + ( curl A) · (η × n) dS = P(g U ) · η dΩ (18.54)
µ µ
Ω Ω ∂Ω Ω
and Z Z
σ∇V · ∇v dΩ = − (σE 0 ) · n v dS. (18.55)
Ω ∂Ω
A × n = a × n and V = v̂ (18.56)
are not given, we may specify the tangential components of the magnetic field H = (1/µ)B and the normal
component of current density J = σE 0 . These may be defined via giving h to define
1
curl A = n × h × n (18.57)
µ
and
− (σE 0 ) · n = jn . (18.58)
We note that giving a Dirichlet constraint is a useful way to guarantee the uniqueness of the scalar potential
V which would otherwise be determined only up to a constant.
A Robin-like generalization of (18.57) leads to the boundary condition
1
curl A = α(A × n) + n × h × n, (18.59)
µ
with α being a given parameter. We however note that the case α 6= 0 may lack in having a physical
interpretation. On the other hand, a generalized version of (18.58) is written as
σ∇V · n + βV = jn . (18.61)
In addition, a procedural technique may be applied to specify a Dirichlet constraint for A when the normal
component of the magnetic flux density B is given on the boundary.
The surface impedance condition for time-harmonic cases. In the case of time-harmonic analysis it is
possible to generate tangential surface currents via giving a boundary condition
E × n = ZS (H × n) × n (18.62)
with φ ∈ H 1 (Ω)/P0 (Ω) (the definition of the space H 1 (Ω)/P0 (Ω) reflects the fact that φ can be determined
up to a freely chosen constant only) and k being a regularization/stabilization parameter. The choice k = 1
is seen to be natural. Then, if ΠA ≡ A − ∇φ denotes the Helmholtz projection of A, the content of this
formulation can also be cast into the form
Z Z Z
1
curl A · curl η dΩ − (A − ΠA) · (η − Πη) dΩ = P(g U ) · η dΩ,
µ
Ω Ω Ω
Z (18.66)
− ΠA · ∇q dΩ = 0.
Ω
This formulation reflects how the scheme works; the second term in the left-hand side of the first equation in
(18.66) acts as a penalization term to get into the right set of divergence-free solutions. That is, A−ΠA = 0
is enforced by having this term. It is noted that with k = 0 the method reduces to the standard Lagrange
multiplier formulation to impose the Coulomb gauge.
18.6 Keywords
Keywords for WhitneyAVSolver
Here we list the keywords that are relevant to solving the evolutionary and stationary versions of the equa-
tions by calling the solver subroutine WhitneyAVSolver and that may also be common to the other
solvers. Such common keywords relate to specifying material parameters, body forces, and boundary con-
ditions.
Constants
Permeability of Vacuum Real
This constant has the default value 4π · 10−7 .
Material mat id
The following material parameters may be used by all the solvers in the module.
Solver solver id
Equation String WhitneySolver
A describing name for the discrete model handled by this solver may be given by using this
keyword. The name can be changed as long as it is used consistently.
Procedure File "MagnetoDynamics" "WhitneyAVSolver"
This declaration specifies the name of the solver subroutine.
Variable String AV
The name of the variable may be freely chosen provided it is used consistently also elsewhere.
The associated number of degrees of freedom should always be one.
Element
The default initialization routine should give a suitable element type definition automatically, so
that the value of this keyword need not necessarily be given by the user.
Use Piola Transform Logical
Several types of edge finite elements can be used for spatial discretization. This keyword must
be given the value True when the basis functions for the edge element interpolation are selected
to be members of the optimal edge element family or when second-order approximation is used.
The elements of the optimal family provide optimal accuracy even when the physical elements
are not obtained as affine images of the reference elements. The simpler basis functions which
are used otherwise may not provide such accuracy for non-affine element shapes. For the docu-
mentation of the edge element basis functions see the appendices of the ElmerSolver Manual.
Quadratic Approximation Logical
This keyword can be used to activate the approximation with the edge finite elements of second
degree; see also the keyword Use Piola Transform.
Static Conductivity Logical
If the stationary equations are solved such that both A and V are handled as unknowns, this
keyword can be given the value True so that the solver can create an automated value for the
Element keyword.
Fix Input Current Density Logical
To ensure the divergence-freeness of the source term via performing the projection (18.47), the
value True should be given for this keyword.
Automated Source Projection BCs Logical
If the projection (18.47) is applied to the user-specified source g U , the solver has originally
constrained the field Q automatically such that Q is chosen to satisfy the zero Dirichlet condition
on parts where |g U · n| =6 0. This feature can be disabled by giving the value False for this
keyword in order to specify, for example, the homogeneous Dirichlet constraint for Q (known as
the field Jfix) on boundaries where the scalar potential V or V s is constrained by a Dirichlet
constraint.
Use Lagrange Gauge Logical
This keyword must be True in order to switch to the regularized formulation (18.65) which has
a unique vector potential solution.
Lagrange Gauge Penalization Coefficient Real
This keyword defines the stabilization parameter k in (18.65).
Use Tree Gauge Logical
Due to the chosen discretization, the vector potential is not sufficiently constrained to guarantee
the uniqueness. Despite this, the iterative solvers are expected to be able to generate a consistent
solution among many. However, to enable the solution with direct solvers this keyword is by
default given the value True so that a special technique is applied to additionally constrain the
discrete vector potential variable (in the case of iterative solvers the default value is False).
This option is not supported when Use Piola Transform = True is given.
Linear System Refactorize Logical
It is noted that if the refactorization of the system matrix is controlled with this keyword, the
matrix factorization is anyhow recomputed automatically if the time step size differs from the
previous one.
Linear System Preconditioning String
Here the value None may give better performance than the standard ILU preconditioners since
the null space of the system matrix may be non-trivial, leading to a singularity problem in con-
nection with handling the LU decomposition.
Linear System Iterative Method String
The iterative solvers BiCGStab or BiCGStab(L) may work well.
Body Force bf id
In the body force section the user may give various volumetric sources contained in the vector g as
defined in either (18.51) or (18.52). The velocity field related to a rigid motion may also be defined
for cases where this information is explicitly needed to write the equations.
Boundary Condition bc id
As explained, two versions of Dirichlet conditions are possible in connection with the A-V formu-
lation. The first option relates to giving the value of the scalar potential, while the other version is
used for prescribing the tangential components of the vector potential field. Assuming that the solver
variable is AV, we may thus use the following keywords to specify the Dirichlet conditions:
AV Real
This keyword is used to specify the Dirichlet condition for the scalar potential V , which is
approximated by using the standard Lagrange interpolation.
AV {e} j Real
This keyword is used to the give the vector a in (18.56) in order to prescribe the degrees of
freedom corresponding to the edge element interpolation of the vector potential. The value
of this keyword defines the component aj , j ∈ {1, 2, 3}, with respect to the global Cartesian
coordinate system.
Jfix Real
This keyword is used to specify the Dirichlet condition for the scalar potential field Q, which is
defined via (18.47).
The following keywords may be used in order to handle the flux-related boundary conditions:
Finally, the following keywords relate to a procedural technique to determine a tangential constraint
for the vector potential A when the normal component of the magnetic flux density B is specified on
the boundary.
Solver solver id
Equation String WhitneyHarmonicSolver
This gives a describing name for the discrete model handled here. The name can be changed as
long as it is used consistently.
Reluctivity Im Real
The reluctivity ν = 1/µ may be specified to be a complex-valued quantity with the imaginary
part given by using this keyword. An array value may also be given in order to model magnetic
anisotropy.
Electric Conductivity Im Real
The value of this keyword may be used to specify the imaginary part of the conductivity param-
eter. If the material is anisotropic, the electric conductivity may also be defined to be a tensor
function by giving its components with respect to the global coordinate lines.
Body Force bf id
The following keywords are used to specify the imaginary parts of the volume sources:
To give the boundary condition (18.62) the following keywords may be used:
Layer Electric Conductivity Real
This keyword defines the electric conductivity of the surface material.
Layer Relative Permeability Real
The permeability µ of the surface conductor is specified in terms of the value of this keyword
and the permeability of vacuum.
Solver solver id
The fields to be computed are chosen in the solver section. The field Magnetic Flux Density
is computed always, others if requested. The size of a vector field is 3, while a tensor field has the size
6. For the harmonic solution the sizes are doubled as the imaginary components are also present.
If the harmonic loss will be computed, then the following material parameters should be provided. Note
that these are not parameters needed by the primary solver since the loss estimation is just a post-processing
feature. See Chapter 26 for more details.
Material material id
Harmonic Loss Linear Coefficient Real
This keyword is used to define the material parameter C in (26.6) for the losses that are linear
with frequency. Note that the coefficient may be a function of frequency itself.
Harmonic Loss Quadratic Coefficient Real
As the previous keyword except define the material parameter C for the quadratic loss terms.
Component component id
In addition to the field computation, two scalar quantities are always computed by the solver and saved in
the list of the Simulation section values: Eddy current power and Magnetic Field Energy.
The first one is only relevant for time-dependent and harmonic cases.
Bibliography
[1] Jerrold E. Marsden and Thomas J.R. Hughes. Mathematical Foundations of Elasticity. Dover Publica-
tions, Inc., New York, 1994.
19.1 Introduction
It may become necessary to connect a magnetoquasistatic model to circuit equations when modelling elec-
trical devices that are circuit-driven. Even if such model could in theory be handled without introducing
circuits, it can considerably simplify the model setup. In Elmer the circuit equations are added into the
system matrix of a magnetodynamics solver and thus they are solved in a strongly coupled manner together
with the finite element equations. One should note that adding the circuit equations may hinder the parallel
performance of the solver. In case this is a critical concern to the user, one should pay attention to tuning
the model [9] (for example by using the so-called reduced support that can bring great benefits [8]). Here
the module for adding the circuit equations to the system matrix of the magnetoquasistatic solvers is pre-
sented. Note that this solver may (and needs to) be used together with the modules MagnetoDynamics
or MagnetoDynamics2D.
When the CircuitsAndDynamics module is used in a published academic work, please refer to [9]. When
reduced support is used in order to achieve better parallel scalability, one may refer to [8].
19.2 Theory
In Elmer the magnetodynamic problems are currently solved by using the so-called a-v formulation. This
can be done in 2D or 3D and with all simulation types (i.e., steady, harmonic, or transient). The a-v
formulation [7, p. 124] may be presented as follows: find a ∈ We1 and v ∈ We0 such that
(ν∇ × a, ∇ × a0 )Ω + (σ∂t a, a0 )Ωc + (σ∇v, a0 )Ωc − (j 0 , a0 )Ω + hn × h, a0 iΓh = 0 ∀a0 ∈ We,0
1
(19.1)
and
(σ∂t a, ∇v 0 )Ωc + (σ∇v, ∇v 0 )Ωc + hn · j, v 0 iΓc = 0 ∀v 0 ∈ We,0
0
, (19.2)
−1
where ν = µ is the reluctivity, a is the magnetic vector potential, v is the electric scalar potential, j 0 is
the source current density, n is the normal vector to the boundary Γh , and a0 and v 0 are test functions. The
domain Ω is the considered body, Ωc ⊂ Ω consists of a conductive material, and Γh and Γc are boundaries
where the magnetic field and the current density field are imposed, respectively. The edge finite element
discretization [7, p. 93] generates approximations of the magnetic vector potential a and electric scalar po-
tential v functions in discrete versions of We1 and We0 . This formulation thus requires a system matrix with
two types of unknowns for expressing the magnetic vector potential and the electric potential. For more infor-
mation about the formulation in Elmer see the modules MagnetoDynamics or MagnetoDynamics2D.
Aẋ + Bx = f (19.3)
where x is the circuit variable vector, A and B are the coefficient matrices and f is the force vector. In Elmer
this equation can be described in the solver input file (SIF) in MATC language.
Circuit equations can be divided into two categories: 1) the component equations that determine the
behaviour of a component, and 2) the circuit network equations that determine the relationship between the
components (the Kirchhoff I and II laws).
The component equations are further divided into two subcategories: 1) the circuit element equations
that can be used to define ideal components (for example Ohm’s law), and 2) FE component equations that
are coupled to the finite element equations (related to the finite elements which belong to the corresponding
components). During the development of the CircuitsAndDynamics module a new section of keywords,
called "Component", was added. Within this section the user may control the component equation by spec-
ifying which bodies belong to the component and what formulation should be used with it, together with
specific component formulation input data (for example the number of turns).
The circuit network equations are further divided into two categories as well: 1) the Kirchhoff I law
that is the current conservation law (every node in the network graph must conserve the current), and 2) the
Kirchhoff II law that is the conservation of energy (the potential difference over every loop in the network
graph must be zero).
In Elmer the circuit equations are technically divided into two categories: 1) the automatically written
equations, and 2) the manually written equations. This is due to the fact that it is convenient to write the
FE component equations automatically once the formulation and its specific data are known while the rest
of the equations can be manually written without any difficulties. Note that the ideal components could be
automated as well (for example a resistor model); however such components do not exist at the moment and
the user needs to write those equations manually.
In the following sections three supported component formulations (massive, stranded, and foil winding)
are presented. The type of the formulation can be chosen in SIF via "Coil Type" keyword in the "Component"
section.
and
(σ∂t a, ∇si )Ωm + Vjm (σ∇v0i , ∇si )Ωm = Ijm , (19.5)
where Ωm is the massive inductor domain, Γjm lists nodes on the electrode boundaries, Vjm is the voltage
and Ijm is the total current through the electrodes.
The source electric potential v0i can be precomputed with an electrokinetic formulation (the Poisson
equation) by setting it 1 at the positive electrode boundary and 0 at the negative boundary. If the electroki-
netic solver is not executed, then the reduced support is used.
and
(∂t a, j s,js )Ωs + Ijs (σ −1 j s,js , j s,js )Ωs = Vjs , (19.7)
where Ijs is the total current in the coil and Vjs is the voltage in the coil. This is the preferred method for
defining the component equation for the so-called classical stranded inductor model [7, p. 286], but the
resistance of the coil can also be given explicitly [6, 5]. The classical model yields
Z
∂t a · w dΩs + RIjs = Vjs , (19.8)
Ωs
where w is the wire density vector and R is the resistance of the coil.
and Z
Njf
(σ∂t a, V 0 (α)∇si )Ωf + (σVjf (α)∇v0i , V 0 (α)∇v 0 )Ωf = Ij V 0 (α) dα, (19.10)
Ljf f Ωα,jf
where Ωf is the foil winding domain, Γjf lists the nodes on the electrode boundaries, Vjf is the voltage and
Ijf is the total current through the electrodes.
19.3 Keywords
The circuits and dynamics solver adds the circuit equations to the system matrix of the WhitneySolver or the
MagnetoDynamics2D solver. Keywords are needed to both of these solvers.
Component component id
Master Bodies Integer body ids
Body ids of the bodies which constitute a circuit component.
Coil Type String type
If the circuit component is defined as a coil, it can be treated as a "stranded", "massive" or "foil
winding".
Resistance Real resistance
If the coil type is defined as stranded, then the resistance of the coil can explicitly be defined with
this keyword. In case this keyword is not given the resistance is computed by using the electric
conductivity of the associated body materials.
$ nof_circuits = 1
$ nof_variables = 6
$ Circuits = nof_circuits
$ C.1.variables = nof_variables
$ C.1.A = zeros(nof_variables, nof_variables)
$ C.1.B = zeros(nof_variables, nof_variables)
$ C.1.Mre = zeros(nof_variables, nof_variables)
$ C.1.Mim = zeros(nof_variables, nof_variables)
$ C.1.perm = zeros(nof_variables)
$ ! Define variables
$ C.1.name.1 = "var1"
$ C.1.name.2 = "var2"
$ ! Define Sources:
$ C.1.B(0,0) = 1
$ C.1.source.1 = "Source Name"
Bibliography
[1] Patrick Dular and Christophe Geuzaine. Spatially dependent global quantities associated with 2-d and 3-
d magnetic vector potential formulations for foil winding modeling. IEEE trans. magn., 38(2):633–636,
March 2002.
[2] Patrick Dular, F. Henrotte, and W. Legros. A general and natural method to define circuit relations
associated with magnetic vector potential formulations. IEEE trans. magn., 35(3):1630–1633, May
1999.
[3] Patrick Dular, Nelson Sadowski, J.P.A. Bastos, and Willy Legros. Dual complete procedures to
take stranded inductors into account in magnetic vector potential formulations. IEEE trans. magn.,
36(4):1600–1605, July 2000.
[4] H. D. Gersem and K. Hameyer. A finite element model for foil winding simulation. IEEE trans. magn.,
37(5):3427–3432, September 2001.
[5] C. Golovanov, Y. Marechal, and G. Meunier. 3d edge element based formulation coupled to electric
circuits. IEEE trans. magn., 34(5):3162–3165, September 1998.
[6] P. J. Leonard and D. Rodger. Voltage forced coils for 3d finite element method electromagnetic model.
IEEE trans. magn., 24(5):2579–2581, September 1988.
[7] Gerard Meunier, editor. The Finite Element Method for Electromagnetic Modeling. iSTE and Wiley,
2008.
[8] Eelis Takala, Evren Yurtesen, Jan Westerholm, Juha Ruokolainen, and Tommi Peussa. Using reduced
support to enhance parallel strong scalability in 3d finite element magnetic vector potential formulations
with circuit equations. Electromagnetics, 36(6):400–408, August 2016.
[9] Eelis Takala, Evren Yurtesen, Jan Westerholm, Juha Ruokolainen, and Peter Råback. Parallel simula-
tions of inductive components with elmer finite element software in cluster environments. Electromag-
netics, 36(3):167–185, April 2016.
20.1 Introduction
This module is aimed to solve the time-harmonic Maxwell equations in high-frequency regime so that the
curl-curl equation is valid.
20.2 Theory
The time-harmonic Maxwell equations (time factor e−iωt , ω = 2πf ) are given by
where complex scalars µ = µ0 µr and ε = ε0 εr are the permeability and permittivity parameters of the
model, while E, H and J are electric field, magnetic field strength and impressed current distribution,
respectively. The quantities µ0 , ε0 are the permeability and permittivity of vacuum, and µr and εr are the
relative permeability and permittivity.
The elimination of H from the equations (20.1) and (20.2) gives
over a computational domain Ω. The Dirichlet and Robin boundary conditions for (20.3) are
E × n =f × n on ΓE , (20.4)
n × curl E − αn × (n × E) = n × g × n on ΓZ , (20.5)
where the subsets ΓE and ΓZ cover the boundary ∂Ω of Ω, i.e., ∂Ω = ΓE ∪ ΓZ . Note that the Neumann
boundary condition is achieved by setting α = 0.
First-order absorbing boundary condition. Now let the computational domain Ω be BR \ D, where
BR ⊂ R3 is an open ball of radius R and D ⊂ BR . Furthermore, suppose that ΓE ∪ ΓZ covers only ∂D,
while the first-order absorbing boundary condition on ∂BR is given by [2]
√
n × curl E = iω ε0 µ0 n × (n × E). (20.9)
Port feed. Suppose a guided wave E p propagates along the positive z-axis with propagation constant β.
Furthermore, suppose that E p is the only propagating mode at the chosen frequency. The port feed model
can be implemented with the Robin boundary condition by choosing
Surface potential. The differential of a scalar potential φ defined on a boundary can be used to generate
g as
g = (∂α φ)aα (20.12)
where aα give the dual basis of coordinate basis vectors aα on the surface, so that
Z Z
−1
µ (g × n) · (v × n)dS = µ−1 ((∂α φ)aα × n) · (v × n)dS.
ΓZ ΓZ
20.3 Keywords
Constants
The keywords of this section are used to change the values of natural constants.
Permittivity of Vacuum Real
The permittivity of vacuum ε0 , defaulting to 8.854187817 · 10−12 C
Vm .
Permeability of Vacuum Real
The permeability of vacuum µ0 , defaulting to 4π · 10−7 Vs
Am .
Material material id
The material parameters εr and µ−1
r are defined in this section.
E re {e} i Real
The real part of the component data fi to evaluate DOFs corresponding to the edge basis func-
tions.
E im {e} i Real
The imaginary part of the component data fi to evaluate DOFs corresponding to the edge basis
functions.
Electric Robin Coefficient Real
Real part of α.
Electric Robin Coefficient im Real
Imaginary part of α.
Magnetic Boundary Load i Real
The i:th component of the real part of g × n.
Magnetic Boundary Load i im Real
The i:th component of the imaginary part of g × n.
TEM Potential Real
This can be used to define the real part of the scalar potential φ to calculate g.
TEM Potential im Real
This can be used to define the imaginary part of the scalar potential φ to calculate g.
Bibliography
[1] J.D. Jackson. Classical Electrodynamics. John Wiley & Sons, third edition, 1999.
[2] A.F. Peterson. Absorbing boundary conditions for the vector wave equation. Microwave and Optical
Technology Letters, 1(2):62–64, 1988.
Electromagnetic Waves
21.1 Introduction
The module described here is aimed at solving the time-dependent electromagnetic wave equation derived
from Maxwell’s equations. Here the unknown field is approximated by using vector-valued (edge) finite
elements.
21.2 Theory
By assuming time-independent material parameters, the electromagnetic wave equation may be written as
∂2E ∂E ∂J E
curl µ−1 curl E + ε +σ =− (21.1)
∂t2 ∂t ∂t
where µ = µ0 µr and ε = ε0 εr are the permeability and permittivity, E is the electric field and J E is an
impressed current density. The quantities µ0 and ε0 are the permeability and permittivity of vacuum, and µr
and εr are the relative permeability and relative permittivity; respectively.
The Dirichlet and Robin-like boundary conditions for (21.1) are
E × n = f × n on ΓE , (21.2)
∂E
n × curl E + αn × (n × ) = g on ΓZ , (21.3)
∂t
where ΓE and ΓZ give a partitioning of the boundary ∂Ω of the computational domain Ω such that ∂Ω =
ΓE ∪ ΓZ . Note that the Neumann boundary condition is achieved by setting α = 0. An absorbing boundary
condition can be created by choosing
√
α = ε0 µ0 . (21.4)
To obtain the variational formulation of (21.1) integration by parts is carried out. After using (21.3) we
then come to the weak form
∂2E
Z Z
∂E ∂E
(µ−1 curl E · curl v + ε 2 · v + σ · v)dΩ + α µ−1 ( × n) · (v × n)dS
Ω ∂t ∂t ΓZ ∂t
Z Z
=− µ−1 g · vdS − J˙E · vdΩ (21.5)
ΓZ Ω
21.3 Keywords
Constants
The keywords of this section are used to change the values of natural constants.
Permittivity of Vacuum Real
The permittivity of vacuum ε0 , defaulting to 8.854187817 · 10−12 ( Vm
C
).
Permeability of Vacuum Real
The permeability of vacuum µ0 , defaulting to 4π · 10−7 ( Am
Vs
).
Material material id
The material parameters εr , µr and σ are defined in this section.
Relative Permittivity Real
This defines the value of the relative permittivity εr .
Relative Permeability Real
This defines the value of µr .
Electric Conductivity Real
This defines the value of σ.
Equation String
This gives a name for referring to this solver definition.
Procedure File "EMWaveSolver" "EMWaveSolver"
This is used to identify the solver subroutine.
Variable String
The name for the field variable to be solved. If this is not given, the solver defaults this to E.
Use Piola Transform Logical
Utilize modern Piola-transformed edge finite elements. This increases the number of DOFs on
meshes containing hexahedral and pyramidal elements. If the mesh contains elements that are
not affine images of the reference element, then this option should be enabled.
Quadratic Approximation Logical
This keyword can be used to switch to using vector-valued finite elements of second order.
Body Force bf id
The time derivative of the impressed current density J E can be specified in the Body Force section.
Current Density Rate i Real
The i:th component of the time derivative field J˙E .
Boundary Condition bc id
E {e} i Real
In the case of the default variable name this command defines a vector so that its tangential trace
f × n is approximated by E h × n, with E h the finite element interpolating function. The
value of this keyword defines the components of the vector with respect to the global Cartesian
coordinate system.
Electric Damping Coefficient Real
This specifies the value of the parameter α.
Magnetic Boundary Load i Real
The value of this keyword specifies the i:th component of g.
Equation String
This gives a name for referring to this solver definition.
Procedure File "EMWaveSolver" "EMWaveCalcFields"
This is used to identify the name of the postprocessing subroutine.
Calculate Elemental Fields Logical
Calculate an elementwise fit for the primary solution. This is useful especially in cases where
material parameters have discontinuities.
22.1 Introduction
This module may be used to solve a version of the Maxwell equations in 2D special cases (including axially
symmetric problems) when the unknown is the z-component (or φ-component) of the vector potential. In
contrast to the 3D version of the magnetodynamics solver described earlier, the standard Lagrange interpola-
tion is here applied. In addition to performing the computations in the time domain, the analogous version of
the equations may also be solved in the frequency domain. Furthermore, an additional solver may be called
to produce derived fields (for example the magnetic flux density) from the computed vector potential. Also
Joule losses may be computed for harmonic fields.
22.2 Theory
When the current density acts in a direction orthogonal to the plane considered, the scalar potential need
not be considered as an unknown in the A-V formulation of Maxwell’s equations. In the case of Cartesian
coordinates the system is then fully described by the vector potential A ≡ A3 (x1 , x2 )e3 as
∂A3 1
σ e3 + curl( curl A3 e3 ) − σ(v × curl A3 e3 ) = J3 e3 + curl M (22.1)
∂t µ
where J3 e3 is the electric current density and the magnetization current is expressed in terms of a planar
magnetization vector M = M1 e1 + M2 e2 . In addition, v is an optional velocity field describing a motion
of a body. It should be noted that if the motion is modelled via performing a rigid motion of the previous
mesh into the current configuration, the effect of motion may be incorporated in the total time derivative and
v need not be specified explicitly; cf. the discussion in connection with the 3D equations.
When cylindrical coordinates (r, φ, z) are employed, the curl of the vector potential A ≡ Aφ (r, z)eφ
has components (−∂z Aφ , 0, ∂r Aφ + Aφ /r) with respect to the orthonormal basis {er , eφ , ez }. The field
equation is then given by
∂Aφ 1
σ eφ + curl( curl Aφ eφ ) − σ(v × curl A3 e3 ) = Jφ eφ + curl M , (22.2)
∂t µ
with the magnetization vector being M = Mr er + Mz ez .
∂
The harmonic version of the equation is obtained by replacing the operator ∂t by multiplication with iω
and solving the vector potential as a complex-valued field. In the case of a harmonic problem described in
terms of Cartesian coordinates the Joule heat generation in stationary conductors may be computed from
1 2
h= σω |A3 |2 .
2
As the electric conductivity σ may be discontinuous over material boundaries, it is attractive to compute a
field without it and carry out the multiplication within the heat solver where the source term is needed.
A3 = Ab3 . (22.3)
22.3 Keywords
Keywords for MagnetoDynamics2D
Here we list the keywords that are relevant when utilizing the module MagnetoDynamics2D and that
may also be common to the other solvers. Such common keywords relate to specifying material parameters,
body forces, and boundary conditions.
Constants
Permeability of Vacuum Real
This constant has the default value 4π · 10−7 in SI units. In different unit system change this
accordingly.
Material mat id
The following material parameters may be used by all the solvers in the module.
Reluctivity Real
The value of this keyword specifies the reluctivity ν. The permeability is then taken to be µ =
1/ν.
Magnetization i Real
The components of the magnetization vector, i = 1, 2.
H-B Curve Cubic Real
The H-B curve must be given as a cubic spline. This enables that the derivative of the curve is
computed analytically from the spline coefficients.
Solver solver id
Equation String MgDyn2D
This keyword gives a describing name for the discrete model handled by this solver. The name
can be changed as long as it is used consistently.
Procedure File "MagnetoDynamics2D" "MagnetoDynamics2D"
This declaration specifies the name of the solver subroutine.
Variable String Potential
The name of the variable may be freely chosen provided it is used consistently also elsewhere.
The associated number of degrees of freedom should always be one.
Nonlinear System Max Iterations Integer
If the material laws are nonlinear, the equation may need some iterations before reaching the
solution. This keyword gives the maximum number of iterations. The default is one. If a
nonlinear H-B curve is given, then Newton’s linearization is applied after the first iteration.
Nonlinear System Convergence Tolerance Real
This keyword gives the convergence tolerance for the nonlinear iteration.
Body Force bf id
In the body force section the user may give various volume sources.
Boundary Condition bc id
Potential Real
If the variable is given the name Potential, this keyword can be used to specify the Dirichlet
condition for the vector potential.
Infinity BC Logical
Sets far-field conditions for the vector potential assuming spherical symmetry at distance.
Mortar BC Integer
This enforces continuity in the case of rotating boundary conditions by the mortar finite element
method.
Magnetization i Im Real
The imaginary components of the magnetization vector, i = 1, 2.
Solver solver id
Equation String MgDyn2DHarmonic
A name for the solver.
Procedure File "MagnetoDynamics2D" "MagnetoDynamics2DHarmonic"
This declaration specifies the name of the solver subroutine.
Variable String Potential[Potential Re:1 Potential Im:1]
The name of the variable may be freely chosen provided it is used consistently also elsewhere.
The associated number of degrees of freedom should always be two.
Body Force bf id
Current Density Im Real
This keyword is used to specify the imaginary part of the current density.
23.1 Introduction
The magnetic induction equation describes interaction of a conducting liquid or gas with applied and induced
magnetic fields in the low-frequency domain. The induction equation for the magnetic flux density is always
coupled to the Navier-Stokes equation for the movement of the fluid. The magnetic field, in turn, causes the
Lorentz force in the Navier-Stokes equation. The fluid is typically hot, and the Navier-Stokes equation is
often coupled also to the heat equation.
The induction equation solver can also be used in a body without a moving fluid, i.e., when ~v = 0 and the
Navier-Stokes equation is not solved. In this case, the problem belongs to the field of magneto-quasistatics.
23.2 Theory
The magnetic induction equation may be derived from Maxwell’s equations, with the displacement current
in Ampère’s law neglected, and the Ohm’s law for conducting fluids, ~ = σ(E ~ +~v × B).
~ This approximation
for the behavior of electromagnetic fields in conducting, moving fluids is called magnetohydrodynamics.
The magnetic induction equation is given by
~
∂B 1
+ ~ − ∇ × (~v × B)
∇×∇×B ~ = 0, (23.1)
∂t σµ
where σ is the electric conductivity and µ the magnetic permeability of the material. These must be
specified by using the keywords Electric Conductivity and Magnetic Permeability in the
Material section.
The force term induced by the magnetic field for the flow momentum equations is given by
f~m = ~ × B,
~ (23.2)
The magnetic field can also be divided into external, or applied, and induced field, B ~ =B ~e + B
~ i . The
external magnetic field B ~ is created by permanent magnets or currents outside the fluid. The external field
e
may be given to the induction equation solver either from a restart file, e.g., as calculated by the magnetostatic
solver, or defined via the sif file’s keywords Applied Magnetic Field 1, 2 and 3. If the restart file
is used, the components of B ~ e are read from the variables named magnetic flux density 1, 2 and
3. If both methods are used, the two applied fields are summed together. It is assumed that the sources of the
external field are outside the flow region, i.e., ∇ × B~ e = 0, and that the time derivative of the external field
can be ignored. The time derivative ∂ B ~ /∂t can, however, be specified directly by the keywords Magnetic
e
Bodyforce 1, 2 and 3. The induction equation solver gives the components of the induced magnetic field
B~ i.
Both transient and steady-state solvers for the magnetohydrodynamical system (induction, Navier-Stokes
and heat equations) are available. The magnetostatic and time-harmonic solvers for the external magnetic
field are described elsewhere in the Models Manual. In some cases it is also possible that the velocity is a
priori known, for example when studying induction in a rotating body. Then a user defined velocity can be
used instead of computing the velocity from Navier-Stokes equations.
Currently the induction equation can be solved in a cylindrically symmetric or a general three-dimensional
formulation.
23.3 Keywords
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
Equation String [Magnetic Induction]
The name of the equation. It is also possible to use this solver as external procedure. Then the
name of the equation must not be the above (use e.g. Magnetic Field Solver). Also the
following four keywords have to be added with the values give here.
Procedure File "MagneticSolve" "MagneticSolver"
Variable String Magnetic Field
Variable DOFs Integer 3
Exported Variable 1 = -dofs 3 electric current
The above four keywords are to be given only when using the solver as an external procedure.
Nonlinear System Convergence Tolerance Real
This keyword gives a criterion to terminate the nonlinear iteration after the relative change of the
norm of the field variable between two consecutive iterations k is small enough
~k − B
||B ~ k−1 || < ||B
~ k ||,
~ 0 = λB
B ~ k + (1 − λ)B
~ k−1 ,
where λ is the factor given with this keyword. The default value for the relaxation factor is unity.
Steady State Convergence Tolerance Real
With this keyword a equation specific steady state or coupled system convergence tolerance is
given. All the active equation solvers must meet their own tolerances for their variable u, before
the whole system is deemed converged. The tolerance criterion is:
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Body Force bf id
The body force section may be used to give additional force terms for the equations.
Lorentz Force Logical
If set true, triggers the magnetic field force for the flow momentum equations.
Joule Heat Logical
If set true, the Joule heating is added in the heat equation.
Magnetic Bodyforce i Real
This keyword can be used to specify explicitly the time dependence of the external field, i.e., the
term −∂ B~ e /∂t. This is especially useful for time-harmonic fields, where the time derivative can
be calculated and expressed easily.
Initial Condition ic id
The initial condition section may be used to set initial values for the field variables. The following
variables are active:
Magnetic Field i Real
For each magnetic flux density component i= 1, 2, 3.
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be set for the induction equation. They can be a constant or a function of a given variable.
Magnetic Permeability Real
The magnetic permeability is set with this keyword. For most fluids, the vacuum value for µ0
can be used, and the keyword set to 1.25664e-6.
Electric Conductivity Real
The value of the electric conductivity is set with the keyword. For example, for polythermal
flows the conductivity could be a function of the temperature.
Applied Magnetic Field i Real
This keyword can be used to specify the external field, or a part of it, and its contribution to the
~ e ). The field may be a function of, e.g., time or position.
term ∇ × (~v × B
MHD Velocity i Real
The user defined velocity can be given with these keywords with i=1,2,3.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. The ones related to
induction equation are
Magnetic Field i Real
Dirichlet boundary condition for each magnetic flux density component i= 1, 2, 3.
24.1 Introduction
In some applications the geometry is such that the 3D electrostatics may quite accurately be reduced to a 1D
problem. This is the case for nearly aligned planes. If the angle between the planes is ϕ (in radians) the error
of this approximation is roughly 2ϕ2 /3. Therefore we may use an analytical solution that results directly
from the distance of the planes that are in different potential. The ideal model may be further developed by
taking into account perforated structures and dielectric layers.
24.2 Theory
~ may
It is assumed here that the electric field is stationary in the time-scale under study. The electric field E
be expressed with an electric scalar potential φ,
~ = ∇φ.
E (24.1)
If there are no free charges, the scalar potential may be solved from
− ∇ · ε∇φ = 0. (24.2)
When one dimension is much smaller than the other two we may assume that the field is one-dimensional.
Then the electric field resulting from potential difference Φ = ∆φ is
~ = E~n = Φ ~n,
E (24.3)
d
where ~n is the unit normal and d(~r) is the height of the aperture. The energy density per unit area is now,
1 2 εΦ2
e= εE d = . (24.4)
2 2d
which corresponds to a induced charge density on the surface
εΦ
q= . (24.5)
d
∂e εΦ2
f= =− 2, (24.6)
∂d 2d
and the spring constant from the derivative of the force,
∂f εΦ2
k= = 3 , (24.7)
∂d d
The forces and spring constants are always aligned in the direction of the surface normal since any other
direction is incompatible with the original assumptions.
and
fholes = βfideal (24.9)
The correction terms may be precalculated for a given geometry. However, if the relative change in the
aperture is large the correction terms should be modeled in some manner. we would also like to have similar
expressions for the spring constant
kholes = γkideal . (24.10)
If we assume that eholes is proportional to 1/d then the following relations may easily be derived.
β = α − α0 d (24.11)
and
1
γ = α − α0 d + α00 d2 , (24.12)
2
where the derivation is done respect to d.
Now we are only left with the problem of finding a nice functional approximation for α. The holes in
the membrane may be expressed using three dimensionless variables d˜ = d/r, b̃ = b/r and R̃ = R/r. Here
r is the hole radius, b the hole depth, d the aperture and R the distance between holes. When R̃ >> 1 and
b >> 1 the correction depends only on d. ˜
Numerical computations suggest that the correction α(d) ˜ should approach unity as the distance d˜ ap-
proaches unity. On the other hand, it should approach 1 − q for small values of d. Here q is the area fraction
of the holes.
Numerical calculations suggest that a second order rational polynomial gives quite an accurate fit to the
computed results,
1
α(d) = 1 − q . (24.13)
1 + a1 d + a2 d2
Fully analytical formulas are now more tedious but the values for β and γ are easily calculated using the
derivatives
a1 + 2a2 d
α(d)0 = q , (24.14)
(1 + a1 d + a2 d2 )2
and
a2 − 2a21 − 3a1 a2 d − 3a22 d2
α(d)00 = 2q . (24.15)
(1 + a1 d + a2 d2 )3
Least squares fitting to the numerical computations suggest that for cylindrical hole a1 = 4.2523, a2 =
0.4133, for a rectangular slot a1 = 2.3198, a2 = 0.2284 and for a square hole a1 = 3.8434, a2 = 0.3148.
When fitting the model the suggested constant term diverged up to 4 % from unity but the value one was
enforced anyway because it has the nice limiting value properties.
and
Φ
E2 = . (24.17)
ε2 d1 /ε1 + d2
Defining dx = d1 + ε1 d2 /ε2 these become
Φ
E1 = (24.18)
dx
and
ε1 Φ
E2 = . (24.19)
ε2 dx
The total energy density is then
1 d1 1 ε21 2 d2 ε 1 Φ2
e= ε 1 Φ2 2 + Φ 2 = . (24.20)
2 dx 2 ε2 dx 2dx
We assume that the resonator moves so that d1 changes and d2 remains constant. Then the force density is
∂e ∂e ∂dx ε1 Φ2
f= = =− 2 . (24.21)
∂d1 ∂dx ∂d1 2dx
∂f ε1 Φ2
k= = 3 . (24.22)
∂d1 dx
These expressions may be used inside the integral instead of the constant field values to account for the
dielectric layer. It may be noted that the equations are exactly the same as for the case without the layer
except that the aperture d is replaced with the efficient aperture dx = d1 + ε1 d2 /ε2 .
24.4 Keywords
Constants
Permittivity Of Vacuum Real [8.8542d-12]
The default is given in SI units. In other units the constant should be changed appropriately.
Boundary Condition bd id
Poisson-Boltzmann Equation
25.1 Introduction
The macroscopic electromagnetic theory is governed by Maxwell’s equations. In steady state the electric
field may usually be solved from a simple Poisson equation. However, if there are free charges in the domain
that are affected by the electric field the equation is no longer valid. Also the contribution of the free charges
need to be taken into consideration. If the electrostatic force is the only force affecting the distribution of
the electric charges then the potential in the steady-state is given by the Poisson-Boltzmann equation [1].
This equation may find its use in microfluidics and electrochemical applications. Note that if the charge
distribution is affected by the flow distribution of the carrier fluid this equation is no longer valid.
25.2 Theory
The electrostatic equation for the electric potential φ yields,
− ∇ · ε∇φ = ρ, (25.1)
where ε is the permittivity of the medium and ρ is the charge density. Assuming that there is a fixed charge
density and both positive or negative moving ions the charge may be written as
ρ = ρ0 + e(z − n− + z + n+ ) (25.2)
where ρ0 is interior charge distribution of fixed positions of all solute charges, and e is the unit charge of a
electron, and z is the charge number of the positive or negative ions, and n is the corresponding ion density.
The electrochemical potential µ of the ions is defined by µ = ezφ + kB T ln n, where the first term is the
electrostatic contribution and the second term comes from the entropy of the ions at the weak solution limit.
In equilibrium µi is constant over the whole domain and thus the ion density obeys a Boltzmann distribution,
n = n0 e−ezφ/kB T (25.3)
where kB is the Boltzmann constant. Inserting this to the Poisson equation we obtain the Poisson-Boltzmann
equation that determines the potential field self-consistently,
− +
− ∇ · ε∇φ = ρ0 + ez − n−
0e
−ez φ/kB T
+ ez + n+
0e
−ez φ/kB T
. (25.4)
A special case of the equation is obtained if the charge numbers and the concentrations are equal, z =
−z − = z + and n0 = n− +
0 = n0 . Then the equation simplifies to
25.4 Keywords
Constants
Potential Real
Electric Flux BC Logical
Must be set to True if flux BC is used.
Surface Charge Real
Gives the surface charge for the Neumann boundary condition.
Bibliography
[1] D. Andelman. Handbook of Biological Physics, chapter 12. Electrostatic Properties of Membranes: The
Poisson-Boltzmann Theory. Elsevier Science, 1995.
26.1 Introduction
The primary motivation for this solver is the estimation of electromagnetic losses by using the Steinmetz
equation approach. It could have other uses as well. The main idea is to make a Fourier transformation on-
the-fly and compute losses that are proportional to the frequency always when full cycle has been completed.
Given an evolutionary finite element field
N
X
~ h (x, t) =
A ~j (x),
αj (t)ψ (26.1)
j=1
the solver enables to replace the evolution of the scalar degrees of freedom αj (t) for t ∈ [t0 , t0 + T ] by the
Fourier series approximation
K
X K
X
αj (t) ≈ a0j + akj cos[kω(t − t0 )] + bkj sin[kω(t − t0 )], (26.2)
k=1 k=1
where the angular frequency ω may be defined in terms of a period T as ω = 2π/T . The coefficients akj and
bkj are given by
ZT
1
a0j = αj (t0 + t0 )dt0 ,
T
0
ZT
1
akj = αj (t0 + t0 ) cos(2πkt0 /T )dt0 , (26.3)
T
0
ZT
1
bkj = αj (t0 + t0 ) sin(2πkt0 /T )dt0 .
T
0
In practice the time stepping algorithm gives the values of αj (t) at only a discrete set of time values and
linear interpolation is applied to generate αj (t) at the other points.
The use of (26.2) in (26.1) now yields
K
X K
X
~ h (x, t) ≈ ~a0 (x) +
A ~ak (x) cos[kω(t − t0 )] + ~bk (x) sin[kω(t − t0 )] (26.4)
k=1 k=1
where the fields ~ak (x) and ~bk (x) have the finite element expansions
N
X N
X
~ak (x) = ~j (x)
akj ψ and ~bk (x) = ~j (x).
bkj ψ
j=1 j=1
~ =∇×A
If the field of interest is B ~ h , we have similarly
K
X K
X
~
B(x, t) ≈ ∇ × ~a0 (x) + ∇ × ~ak (x) cos[kω(t − t0 )] + ∇ × ~bk (x) sin[kω(t − t0 )]. (26.5)
k=1 k=1
If the problem setup is given in 3D case it is assumed that the solution is obtained using edge element
basis. In the special case of 2D target field and the target variable is expected to be a scalar field Ah (x, t)
and B~ is then generated as
B~ = ∂Ah ~ex − ∂Ah ~ey .
∂y ∂x
where C, α and β are given data and fk = kω/(2π). The total loss P is then obtained as
K
X
P = Pk . (26.7)
k=1
The field variable Ph associated with this solver is the total loss power distribution per unit volume which is
obtained from the weak formulation
Z K
Z X
Ph vh dΩ = Cfkα Bkβ vh dΩ (26.8)
Ω Ω k=1
where vh denotes a suitable test function. The current implementation enables several terms with constant
exponents α and β. The coefficient C, on the other hand varies among materials and may be a function of
frequency.
26.3 Keywords
Solver solver id
Procedure File "FourierLoss" "FourierLossSolver"
This keyword is used to give the Elmer solver the place where to search for the routine producing
the loss estimate.
Equation String [FourierLoss]
A name to the computational version of the loss equation may be given by using this keyword.
The name has no effect but it should be unique.
Target Variable String
The value of this keyword gives the name of the field for which the Fourier series expansion is
produced. It is usually assumed that the field is magnetic vector potential. It may be either nodal
(with 1 component in 2D and 3 components in 3D) or a curl-conforming vector field.
Target Variable AV Logical
The user may enforce the target variable to be one resulting from the AV-solver which uses the
edge degrees of freedom to express the vector potential. If the flag is not given, the existence of
the AV solver is deduced from the size of the permutation vector. Because the detection may be
erroneous, for example when a DG field is used, this may also be given value False to enforce
use of a nodal field.
Target Variable Direct Logical
By default it is assumed that the target variable is the magnetic vector potential and the curl
operator is applied. However, with this flag it is possible to give either scalar field |B| or vector
~ directly. The handicap of this is that the field is not continuous. However, this may be
field B
particularly useful for testing purposes.
Variable String
The primary variable is the loss component for the linear frequency dependence. The default
name is Fourier Loss if all components are summed together and Fourier Loss i if
each component is treated separately.
Separate Loss Components Logical
By setting this flag to True the user may save the different loss components in Steinmetz model
as separate fields for postprocessing. Otherwise they will be merged to one single field.
Inexact Integration Logical
The integration may be performed most accurately by integrating the product of the linear ap-
proximation of the time-dependence and the sines and cosines analytically. Currently this exact
integration is used. However, the user may replace it with inexact version even though this is not
recommended.
Simpsons Rule Logical
If using inexact integration, the default method is the trapezoidal integration. Instead the user
may request the Simpson’s rule for better accuracy. If exact integration is used, this keyword has
no effect.
Discontinuous Galerkin Logical
Instead of the standard Galerkin formulation the user may also choose to compute the post-
processed fields using discontinuous Galerkin (DG) approximation. This enables discontinuities
between elements. However, the cost is often quite large since the matrix structures related to DG
are very large compared to the standard Galerkin method. The lumped quantities are computed
on-the-fly so for them there is no difference.
Average Within Materials Logical
This only applies when the DG method is used to compute the loss fields. When this flag is
turned on the fields within same material are weakly enforced to be continuous. This results to
much smoother fields while still maintaining the discontinuity over material interfaces.
i. The highest existing value i determines the number of terms in the loss model. Note that the
coefficient may only be a function of frequency itself.
27.1 Introduction
Assume that we have been given a geometry of a coil. Now the coil consists of individual wires and there-
fore the direction of the current is basically well defined. Unfortunately it is often difficult to provide the
directional information of the wires. In simple cases (such as ideal cylinder) the user may give the current in
the coil using analytical functions. In general case this is however, not possible.
This solver tries to provide numerical means for setting the coil current. The idea is that the computed
current density (or potential) may then be used in further simulations of magnetic fields.
Now the natural way to create the currents is to solve a static current conduction equation. Unfortunately
for closed loops it is difficult to define the boundary conditions. Rather than trying to make some special
mesh this solver provides a unique strategy to create the currents in two pieces using Dirichlet conditions for
some nodes in the bulk.
27.2 Theory
Our starting point for defining currents in the coil is to use an equation for the static current conduction,
− ∇ · σ∇φ = 0. (27.1)
where φ is the electric potential, and σ is the electric conductivity. For this equation we may either set
Dirichlet boundary conditions
φ = φ0 (27.2)
or Neumann boundary conditions
∂φ
−σ = jn . (27.3)
∂n
If we solver the equation with the standard Galerkin method in FEM the volume current density may then
be calculated using the same finite element spaces from
~j = −σ∇φ. (27.4)
If the current density over the boundary area A is constant this gives the current density, jn = J0 /A. Often
it is more ideal to define Dirichlet conditions and normalize the potential afterwords to give the desired total
current,
J0
φ := φ (27.6)
J
and similarly for the current,
~j := J0 ~j. (27.7)
J
If we know that the cross section of the coil is constant and thereby also the current density is constant
j0 we may normalize the current density also locally taking only the direction from the initial current,
~
~j := j0 j . (27.8)
|~j|
Now this normalization should not be done light-heartedly since after this the solution might not be divergence-
free any more. When the magnitude of the solution is known a priori we could use also other means of
obtaining the direction field.
−∇ · cσ∇φ = 0. (27.9)
c|σ∇φ| = j0 . (27.10)
This may be iteratively solved by solving φ from the 1st equation and c from the 2nd equation. Unfortunately
numerical tests showed that the resulting field for c that is prone to numerical oscillations. Therefore we add
some regularization to the 2nd equation by adding some diffusion
where D is the numerical diffusion. Unfortunately the equation does not necessarily have any solution. In
fact real tests showed that increasing value of D will make the solution smoother but at the same time it will
be more difficult to find a solution that would fulfil both equations. Still the current density may be closer to
the real current density than in the homogeneous case. Just a small number of iterations will get the most of
the benefits of the scaled conductivity field.
We may also look at the conductivity in an anisotropic form. One idea is to use the knowledge that in the
true coil the conductivity is only in the direction of the gradient. We may therefore look at the conductivity
in the form
∇φ
σ = σ0 (27.12)
|∇φ|
Now without the multiplier c this would not lead to an improvement because then the direction does not have
an effect as the flux is always in the direction of the gradient only. However, the combined effect of these
two could improve the accuracy of the direction of the current density.
There can be also partially geometric means for setting the direction of the conductivity field. Basically
the distance from the coil surface, s, defines a field the gradient of which defines a direction with zero
conductivity. So we take a isotropic conductivity as a starting point and eliminate the conductivity in the
direction of the normal i.e.
1
σ = σ0 √ [I − abs(∇s)] (27.13)
3
Unfortunately this formulation has some difficulties at the center of the coil where the the distance function
is poorly defined.
For structured and extruded meshes one could also use the directions of the element edges to directly set
the direction of the current. Starting from a rough information for the current direction the edges aligned
with the current could be detected and thereafter the current direction could be refined accurately with the
geometry. This method has not been implemented.
27.3 Keywords
The solver includes some internal definitions which eliminates some keywords. For example, the variable
related to the solver is internally created and also the boundary conditions related to it are set internally so
the user does not need to know of it.
Solver solver id
Equation String CoilSolver
Potential Real
Dirichlet BC for the potential.
Current Density BC Logical
Must be set to True if Neumann BC is used.
Coil Start Logical
Defines a boundary where coil starts. Not needed if coil is closed.
Coil End Logical
Defines a boundary where coil ends. Not needed if coil is closed.
The user can use the united potential also for closed coils by using a special subroutine. The calling conven-
tion would then be, for example, in the MagnetoDynamics module in the Body Force section
Electric Potential = Variable time
Real Procedure "CoilSolver" "CoilPotential"
Here time is just a dummy variable. Similarly for coil potential normalized on-the-fly within each element,
Electric Potential = Variable time
Real Procedure "CoilSolver" "CoilPotentialNormalized"
Electrokinetics
28.1 Introduction
If dealing with electrolytic fluids constrained to small volumes, surface forces caused by electric surface
charges in combination with externally applied electrostatic fields are sufficient strong to affect the fluid
volume. If these effects are utilized to attenuate the fluid volume, we talk of Electrokinetics. The term
Electroosmotic Flow (EOF) is used in connection with the attenuation of a net charge inside a originally
neutral electrolyte caused by separation induced by a surface charge of a wall.
28.2 Theory
Chemical reactions between the contents of a liquid and the wall material may lead to a net charge of the
containment at the wall-liquid interface. If the liquid is an electrolyte (i.e., it contains free ions), ions of
opposite charge align along the wall creating the Stern layer. Adjacent to the Stern layer, a charge separation
- called the diffuse layer of the initially neutral electrolyte takes place. Due to the two layer structure the
whole are area of charge separation in the vicinity of a wall is called the Electric Double layer (EDL).
all. In this case simple considerations of a force balance between shear stress and electric force lead to a slip
condition for the fluid [2]. At the boundary, the tangential velocity is set to the Helmholtz-Smoluchowski
velocity
E~ tang. f 0 ζ
~utang. = ~uH−S = , (28.2)
µf
with µf standing for the local fluid viscosity. The zeta potential, ζ – a property depending on the electric
properties of the wall material as well as the electrolyte – usually is determined experimentally. From a
physical point of view it can be interpreted as the value of the solution obtained by (25.4) at the Stern layer.
The tangential component, E ~ tang. , of the external electric field, E,
~ is evaluated from the outward pointing
surface normal ~n, applying the following relation
~ tang. = E
E ~− E ~ · ~n ~n (28.3)
Alternatively, the resulting slip velocity may be related to the tangential field using the Electroosmotic Mo-
bility, µEOF
~uH−S = µEO E ~ tang. . (28.4)
A combination of (28.2) and (28.4) leads to the following identity
f 0 ζ
µEO = . (28.5)
µf
28.3 Limitations
• The Helmholtz-Smoluchowski velocity should not be applied if the non-dimensional group L defined
in 28.2.1 is of unity order or larger. Then the potential- and charge density distribution as well as the
dynamics of the electrolyte inside the EDL has to be resolved.
• In a strict sense, the Helmholtz-Smoluchowski theory applies only to configurations where the normal-
component of the external field, E ~ · ~n, is small. If dealing with electric insulating wall materials – as
it is usually the case in microfluidic applications – this condition is implicitly complied with.
• The assumption of a Newtonian fluid underlies the derivation of the Helmholtz-Smoluchowski veloc-
ity.
• The function helmholtz_smoluchowski can only be applied on boundaries of two-dimensional
domains, where the tangential direction is uniquely defined.
28.4 Keywords
Keywords for helmholtz_smoluchowski
Constants
Permittivity Of Vacuum Real [8.8542e-12 C2 /Nm2 ]
permittivity of vacuum, only needed if Helmholtz-Smoluchowski velocity is defined using ex-
pression (28.2)
Equation equation id
Electric Field String [computed, constant]
the option for how to evaluate the electric field should be set to one of these values.
If set to computed, the function will search for Electric Field {1,2,3} in the list
of solver variables. If set to constant, the function will search for Electric Field
{1,2,3} in the section Material material id, where material id is the id-number
associated with the material parameter list of the electrolyte
Material material id
If the Helmholtz-Smoluchowski velocity is defined using expression (28.2), then the following key-
words have to be provided in this section
Viscosity Real
viscosity of the electrolyte
Density Real
volumetric density of the electrolyte
Relative Permittivity Real
relative permittivity of the electrolyte
Boundary Condition bc id
In two-dimensional configurations the Helmholtz-Smoluchowski velocity directly can be assigned to
the tangential component of the velocity field
Normal Tangential Velocity Logical True
Velocity 2 = Variable Dummyargument
Real Procedure "Electrokinetics" "helmholtz_smoluchowski"
Sets tangential EO slip velocity
The argument Dummyargument can be any existing variable, since it is not used to evaluate the
velocity.
In three-dimensional configurations (and as an alternative also in two-dimensional), the velocity has
to be defined for each component
Normal Tangential Velocity Logical False
Velocity 1 = Variable Dummyargument
Real Procedure "Electrokinetics" "helmholtz_smoluchowski1"
Velocity 2 = Variable Dummyargument
Real Procedure "Electrokinetics" "helmholtz_smoluchowski2"
Velocity 3 = Variable Dummyargument
Real Procedure "Electrokinetics" "helmholtz_smoluchowski3"
The argument Dummyargument can be any existing variable, since it is not used to evaluate the
velocity.
If the Helmholtz-Smoluchowski velocity is defined using expression (28.2), then the zeta potential, ζ,
for the specific boundary region has to be defined
Zeta Potential Real
Sets the zeta-potential for this boundary
Bibliography
[1] G.E. Karniadakis and A. Beskok. Micro flows : fundamentals and simulation. Springer-Verlag, New
York, Berlin, Heidelberg, 2001.
[2] R.-J. Yang, L.-M. Fu, and Y.-C. Lin. Electroosmotic Flow in Microchannels. J. Colloid and Interface
Science, 239:98–105, November 2001.
electrolyte E
y
ζ
neutral
bulk
diffuse
layer
Stern layer
φ
σe
wall
Figure 28.1: Structure of the EDL. The value of the induced potential, Φ at the Stern layer usually is referred
to as the zeta-potential, ζ
29.1 Introduction
In some cases obtaining an accurate approximation of the flux connected with the solution of the Poisson
equation may be of a particular interest. To this end, the flux may be introduced as an additional independent
variable which is solved simultaneously with the associated scalar variable. Such approximations where two
finite elements spaces are employed at the same time are generally known as mixed methods.
The mixed problem considered here also provides a basic example of the application of divergence-
conforming finite elements. They are also known as face finite elements and offer a natural choice when just
the continuity of the normal component of the solution can be assumed. It should be noted that the selection
of face finite elements is not complete yet, so discretizations over simplicial (i.e., triangular or tetrahedral),
quadrilateral and hexahedral meshes are only supported currently.
− div(a∇u) = f on Ω,
u=g on Γ1 , (29.1)
a∇u · n = q on Γ2
as
q − a∇u = 0 on Ω,
− div q = f on Ω,
(29.2)
u=g on Γ1 ,
q·n=q on Γ2 .
Here a is a material parameter and the physical interpretations of the fields u and q depend on a case. For
example, u may be the temperature or a potential variable, while q may represent the heat flux, electric field,
current density, etc.
If U ≡ L2 (Ω) denotes the set of square-integrable scalar functions over the d dimensional body Ω, we
are thus led to seeking the weak solution of the flux in the space of divergence-conforming functions defined
by
Q = {v ∈ L2 (Ω)d | div v ∈ L2 (Ω) and v · n = q on Γ2 }.
By defining µ ≡ 1/a, multiplication with test functions and integration by parts lead us to seeking (q, u) ∈
Q × U such that
Z Z Z
µq · v dΩ + u div v dΩ = g(v · n) dS,
Ω Ω Γ1
Z Z (29.3)
div q w dΩ = − f w dΩ,
Ω Ω
for any (v, w) ∈ Q0 × U , with the test space of fluxes being defined by
As a generalization, the scalar parameter µ can be replaced by a tensor of order 2. In addition the total time
derivative may be added to the model. The weak formulation (29.3) is then replaced by
Z Z Z
µq · v dΩ + u div v dΩ = g(v · n) dS,
Ω Ω Γ1
Z Z Z (29.4)
∂p
div q w dΩ − ( + a · q)w dΩ = − f w dΩ,
∂t
Ω Ω Ω
where µ is a second-order tensor and a is the convection velocity treated as a model parameter.
It is worth noting that the standard Neumann boundary condition is now built in the construction of the
solution space, i.e., it is specified as an essential boundary condition in the mixed formulation. On the other
hand the standard Dirichlet condition is handled as a natural condition. The boundary conditions of the
standard and mixed formulation have thus opposite roles to another.
Finite element approximations to the solution of (29.3) are constructed in the standard manner by ex-
pressing the weak formulation in terms of finite element versions of the solution and test spaces. For the
available face finite elements a natural finite dimensional version of U is based on functions which are con-
stants elementwise. For additional details on the construction of divergence-conforming finite elements see
also the Appendix “Face and edge elements” of the ElmerSolver Manual.
29.3 Keywords
Material mat id
Variable
The name of the solver variable can be chosen freely (but it is must be used consistently else-
where).
Variable DOFs Integer
The value of this keyword should be 1.
Second Kind Basis Logical
This keyword specifies whether the Brezzi-Douglas-Marini space or the Nédélec face elements
of the second kind are used in two or three dimensions, respectively.
Element String
A special element definition is needed to obtain a suitable set of degrees of freedom. The solver
should be able to create an automated value for this keyword provided the value of the key-
word "Coordinate System" specifies the dimension of coordinate system basis. That is,
one should use the value "Cartesian 2D" or "Cartesian 3D" to specify the coordinate
system.
Body Force bf id
30.1 Introduction
The discretization of the incompressible Navier–Stokes equations usually leads to large linear systems which
cannot be solved efficiently with the standard iterative methods. Special preconditioning strategies should
therefore be employed to obtain rapid convergence of iterations. In this section we describe a special solver
for the steady state Navier–Stokes equations which has utility when the Reynolds number is moderate. The
development of the solver was originally motivated by needs to solve the full Stokes equations in connection
with glaciological simulations. Therefore, the possibility to utilize parallel computation has been in mind
from the very beginning (the module name comes from Parallel Stokes solver).
The speciality of the solver is that it contains an in-built two-level iteration scheme to handle the linear
systems arising from the linearization and discretization. Inner iterations can be associated with precon-
ditioning and they provide search directions for the outer iterative method (GCR) applied to the primitive
problem. The preconditioning strategy is here based on the idea of block preconditioning via utilizing the
natural block structure of the discrete system. In practice simpler auxiliary problems need to be solved in
order to find the update directions for the velocity and pressure unknowns in a decoupled manner. In this way
the door is opened to utilizing other efficient methods, such as multigrid methods for the discrete Poisson
problems, in connection with the solution of the more complicated problem.
The alternate flow solver contained in the ParStokes module basically mimics the standard Navier–
Stokes (NS) solver of Elmer. However, it does not provide all features available in the standard NS solver.
ρ0 (u · ∇)u − div[2µ(D)D(u)] + ∇p = ρ0 g,
(30.1)
− div u = 0
or
− div[2µ(D)D(u)] + ∇p = ρ0 g,
(30.2)
− div u = 0
when the effect of convection is neglected to obtain the Stokes equations. Here D(u) is the symmetric
part of the velocity gradient, the constant ρ0 is the fluid density and µ is the fluid viscosity. For example,
in the case of Glen’s flow law we have µ(D) = 1/2A−k [I2 (D)](k−1)/2 , with A and k parameters and
I2 (D) = 1/2(D · D).
Common boundary conditions may be expressed as
u = û on ΓD ,
2µ(D)D(u)n − pn = ŝ on ΓN , (30.3)
u·n=0 and n × [2µ(D)D(u)n] × n = −βn × u × n on ΓS .
Here û is the specified velocity, ŝ is the specified traction, and also the friction coefficient β > 0 is given as
initial data.
30.3 Linearization
Either Newton’s method or the strategy of Picard type can be used to linearize the effect of viscosity. The
possible convection term is always linearized with the Picard method.
where x(0) is the initial guess. In this setting, the preconditioner is considered to be an operator P which,
given the previous iterate, produces the new search direction s(k+1) .
Here the search directions are found as approximate solutions of systems
T BT
P= (30.6)
0 Q
where T approximates A and Q = µ−1 M , with M the pressure mass matrix. By default the choice T = A is
used. An alternate is to select T to be the block diagonal approximation of A or the scaled vector-Laplacian
matrix, which is the discrete version of the operator −µ div ∇ subject to suitable boundary conditions.
To apply the preconditioner via performing approximate solves of (30.5), the user must define methods
for solving subproblems of the type
(k) (k)
QδP (k+1) = RP and T δV (k+1) = RA − B T δP (k+1)
and
(k)
(T P−1
T )δ V̂
(k+1)
= RA − B T δV (k+1) . (30.8)
The efficiency of the block-preconditioned solver depends heavily on how these auxiliary problems are
solved (the solves associated with the coefficient matrix T are the most critical). A crucial aspect of the
methodology is that these subsidiary problems can be considerably easier to solve than the original fully
coupled system. They may also be solved inexactly without impairing the performance of the preconditioner.
In addition, it is noted that performing highly accurate solutions of the linearized systems (30.4) is not needed
in the beginning of the nonlinear iteration when the iterates are not accurate. The solver provides an option
to employ adaptive stopping criteria so that the solution accuracy for (30.4) is adapted automatically based
on the size of the current nonlinear error.
Solver 1
Equation = "Velocity Preconditioning"
Procedure = "VelocityPrecond" "VelocityPrecond"
Variable = "V"
Variable DOFs = $d
! Potential commands to adjust the solution of velocity
! preconditioning problems:
...
End
Solver 2
Equation = "Pressure Preconditioning"
Procedure = "PressurePrecond" "PressurePrecond"
Variable = "P"
Variable DOFs = 1
! Potential commands to adjust the solution of pressure
! preconditioning problems:
...
End
The first solver section is needed for creating the velocity preconditioning system (30.8), while the second
solver section corresponds to the pressure preconditioning system (30.7). Each of these sections may also
contain additional keyword commands to change the default linear solver and its parameters. The default
variable names V and P can be changed freely.
If a boundary condition u = û of Dirichlet type is specified, the variable of the velocity preconditioning
equation δV (the Elmer variable V above) must also be constrained similarly by using the homogeneous
Dirichlet condition. Usually there is no need to specify boundary conditions for the pressure preconditioning
variable.
30.7 Examples
The solver described here has for example been applied to simulate flows of ice sheets. To obtain an example
in this field, see the ISMIP HOM A test case
.../elmerfem/fem/tests/ParStokes_ISMIP_HOM_A010/
30.8 Keywords
Material material-id
Density Real
This keyword is used to define the density ρ0 .
Viscosity Model String
This keyword can be used to select a more advanced viscosity model such as Glen’s law. For
available options see the documentation of the standard Navier–Stokes solver.
Viscosity Real
This keyword is used to define directly the viscosity µ.
Constant-Viscosity Start Logical
In some cases it may be useful to start the nonlinear iteration with a constant viscosity although
the intention is eventually to use another model. Starting with a constant viscosity can be avoided
by giving the value False for this keyword.
Solver solver-id
Equation String
This keyword declares the name of the equation.
Procedure File ”ParStokes” ”StokesSolver”
The name of the file and procedure.
Variable String
This keyword is used to declare the name of the solution.
31.1 Introduction
The basic incompressible flow solver of Elmer uses the standard formulation of the Navier–Stokes equations.
This section describes an alternative solver based on the rotational form of the Navier–Stokes system. In
addition, some iterative methods that utilize splitting strategies in the solution of the associated discrete
problems are represented.
31.4 Linearization
The linearization of the equation of motion in (31.2) can be done by utilizing the Newton iteration. This
iteration strategy is based on approximating the rotational convection term as
where ~a is the previous velocity iterate. In this connection, the nonlinear boundary condition corresponding
to the outflow condition (31.5) is linearized as
1
−P + ρ(2~a · ~u − ~a · ~a) + 2µε(~u)~n · ~n = 0.
2
An alternative linearization strategy is to apply Picard’s method. Here this method corresponds to lin-
earizing the convection term and the outflow boundary condition as
(∇ × ~u) × ~u ≈ (∇ × ~u) × ~a
and
1
−P + ρ~a · ~u + 2µε(~u)~n · ~n = 0.
2
The convergence of the Newton method can be considerably faster than that of Picard’s method. Our
experience is that this can be the case, especially, when the steady solutions are sought for moderately large
Reynolds numbers. However, a difficulty with the Newton method is that the iteration may not be convergent
for arbitrary initial guesses. This trouble can often be avoided by performing some Picard updates before
switching to Newton’s method. In the case of time-accurate simulations this is usually unnecessary since
suitably accurate initial guesses are often available from the previous time levels.
• A hierarchic version of P2 -P1 approximation for triangular and tetrahedral elements. If the ba-
sic mesh consists of linear elements (element type 303 or 504), giving the element type definition
Element = "p:2" in the Equation section switches to the P2 -P1 approximation where the ve-
locity approximation is enhanced by using hierarchic basis functions associated with the mid-edge
nodes.
• A hierarchic version of Q2 -Q1 approximation for rectangular and brick elements. Analogously to
the previous case, if the basic mesh consists of bilinear or trilinear elements (element type 404 or
808), giving the element type definition Element = "p:2" in the Equation section switches to
the Q2 -Q1 approximation where the velocity approximation is enhanced by using hierarchic basis
functions.
• A hierarchic version of bubble-stabilized methods. The velocity approximation may also be enhanced
relative to the pressure by using elementwise bubble functions. The richness of velocity approximation
depends on how many bubble basis functions are constructed. For example, the set of basis functions
for the linear triangular and tetrahedral elements can be augmented with one interior bubble function
by giving the element type definition Element = "p:1 b:1" in the Equation section. Analogous
rectangular and brick elements may also be constructed, but our experience is that more than one
bubble function may be necessary to obtain stability, making this strategy less attractive. The Q2 -
Q1 and P2 -P1 approximation methods may generally require less computational work, especially for
three-dimensional problems where the number of interior bubble functions can be large (notice that in
the case of the time-dependent equations the interior degrees of freedom are not eliminated by using
the method of static condensation).
It is noted that other instabilities may arise when the flow is convection-dominated. A potentially useful
aspect of using the rotational formulation is that, as compared with the standard convection form, instabilities
relating to dominating convection may be more benign.
A BT
U F
= , (31.6)
B 0 Π 0
where A is the coefficient matrix for the velocity unknowns and B is the divergence matrix. The solution
strategy we consider is based on applying a preconditioned Krylov subspace method to (31.6). Given a
previous iterate (Uk , Πk ), the preconditioning is performed via solving approximately systems of the form
F − AUk − B T Πk
A 0 0 Uk+1 − Uk
B M 0 ψk+1 = −BUk . (31.7)
B H S Πk+1 − Πk −BUk
Here M is the pressure mass matrix, while H and S are approximations of (scaled) Laplacian operators. In
practice the approximate solution of this block triangular system is generated by applying linear solvers to
systems with the coefficient matrices A, M and S. A crucial aspect of the methodology is that these sub-
sidiary problems can be considerably easier to solve than the original fully coupled system. They may also
be solved inexactly without impairing the performance of the preconditioner. Moreover, to our experience
the performance of the preconditioner is insensitive to discretization parameters and depends only mildly on
the Reynolds number, especially in the case of the evolutionary equations. The method is also suitable for
finding the steady solutions via using large time step sizes.
The outer iterative method applied to the primary system (31.6) is based on GCR, while the user can
specify linear solvers which are used to solve the subsidiary problems related to the preconditioning. It
should be noted that boundary conditions associated with the preconditioning operators are built-in, so the
user need not specify these constraints.
31.7 Restrictions
Currently, only homogeneous surface force conditions can be imposed on the boundary. If Q2 -Q1 or P2 -P 1
approximation is used, the boundary conditions are set by employing the linear interpolation of boundary
data. As a result, optimal accuracy may not be realised. If the preconditioning is done via solving (31.7), the
time discretization must be done using BDF(1) and viscosity should be constant.
If decoupled solution strategies are employed, parallel computations are possible only with the version
that does not involve performing the outer Krylov iteration update.
31.8 Keywords
Material material-id
Density Real
This keyword is used to define the density ρ.
Viscosity Real
This keyword is used to define the viscosity µ.
Solver solver-id
Equation String
This keyword declares the name of the equation.
Procedure File ”Stokes” ”StokesSolver”
The name of the file and procedure.
Variable String
This keyword is used to declare the name of the solution.
Variable DOFs Integer
The value of this keyword defines the number of unknown scalar fields and must hence equal to
d + 1 where d is the spatial dimensionality of the computational domain. The unknown scalar
fields are always numbered in such a way that the highest running number is associated with the
pressure solution.
Convective Logical
If the value ”False” is given, the convection term will be neglected so that the generalized
Stokes equations are solved.
If the preconditioning is done via solving (31.7), three additional solver sections need to be written to define
linear solvers for subsidiary problems with the coefficient matrices A, M and S. In this connection special
equation names (given as values of Equation keyword) have to be used. These solver sections should be
written as follows.
Solver 1
Equation = "Velocity Preconditioning"
Procedure = "VelocityPrecond" "VelocityPrecond"
Exec Solver = "before simulation"
Variable Output = False
Variable DOFs = $ d
Variable = "VelocityCorrection"
...
End
Solver 2
Equation = "Divergence Projection"
Procedure = "DivProjection" "DivProjection"
Exec Solver = "before simulation"
Variable Output = False
Variable DOFs = 1
Variable = "DivField"
...
End
Solver 3
Equation = "Pressure Preconditioning"
Procedure = "PressurePrecond" "PressurePrecond"
Exec Solver = "before simulation"
Variable Output = False
Variable DOFs = 1
Variable = "PressureCorrection"
...
End
The first solver section defines a linear solver for the preconditioning system with the velocity matrix A,
while the second solver section defines a solver for the system involving the pressure mass matrix M . Finally,
the third section is related to the system with the coefficient matrix S arising from the discretization of the
Laplacian operator. Each of these sections should also contain the standard keyword commands that actually
define the linear solver. Some examples of such definitions can be found in the tests subdirectory of the fem
module.
Level-Set Method
32.1 Introduction
There are a number of problems involving free surfaces in continuum mechanics. There are two main strate-
gies to solve them using the finite element method: Lagrangian and Eulerian approach. In the Lagrangian
approach the free surface is solved exactly so that it is also an interface between the individual elements. This
requires that the computational mesh is distorted in a way that this is possible. However, often the changes
in geometry may be too drastic or even the whole topology may change and the Lagrangian approach is no
longer feasible. The Eulerian approach describes the interface in a fixed mesh using some additional variable
to describe the position of the interface. One possible Eulerian technique is the level-set method (LSM).
In the level-set method the free surface is given as a zero level-set of a higher dimensional variable. E.g.
for 2D surfaces the level-set function is defined in 3D space. The level-set function is usually defined to
be a signed distance so that inside the domain it obtains a positive value and outside a negative value. The
changes in the value of the level-set function mean also that the interface changes the position.
This module includes several different subroutines that may be used when applying the level-set method.
Currently there is no reinitialization strategy for 3D problems. Also some other procedures are not fully
optimized for the best performance. Therefore the current implementation is best applied to quite simple 2D
problems.
32.2 Theory
The interface is defined by a marker function φ so that at the interface φ = 0, inside the fluid of interest
φ > 0 and elsewhere φ < 0. The interface is update by solving the equation
∂φ
+ ~u · ∇φ = a (32.1)
∂t
where ~u is the convection field and a is the normal flux on the interface. It is quite challenging to solve
the differential equation above without diffusion effects playing a significant role. It is advisable to use 2nd
order time-discretization schemes and short timesteps. More precisely, the Courant number C = |~u|dt/h
should be below unity.
It is desirable that the absolute value of function equals the shortest distance to the zero level-set. How-
ever, as the level-set function is advected this property may be gradually lost. Therefore a process called
reinitialization may be evoked. In 2D the reinitialization may easily be done by geometric procedure. First
the zero level-set is formed by going through all the elements and finding the line segments that make the
zero level-set. Then the minimum distance of all the nodes is computed by a brute-force search. Assuming
there are N nodes and M line segments, the search algorithm is N ×M which is quite acceptable complexity
for small cases but may become computationally costly in large cases.
The line segments may be assumed to go with the flow and thereby they form an on-the-fly Lagrangian
mesh. Therefore it is also possible to advect the line segments when the velocity field is given since for
any node ~r = ~r + ~u dt. After the advection the shortest distance is computed. In the case of no advection
the sign of the distance is inherited from the original level-set function. However, when the level-set is also
convected the sign must be deduced from the geometric information as well. In the current implementation
each line segment is given a flag telling on which side of the element the fluid of interest is located. This
directional information is then used in giving the correct sign for the distance.
The volume of the fluid of interest in the level-set method may be computed over an integral that obtains
a value one inside the fluid and value zero outside the fluid. The Heaviside function H(φ) has this desired
property. However, as the interface does not follow the element division the numerical integration would
result into spurious fluctuations depending on the position of the interface within the elements. To obtain a
smooth behavior the Heaviside function must be regularized.
0,
x < −α
Hα (x) = f (α/x) |x| ≤ α (32.2)
1, x > α,
the Courant number is bound. If ds is the maximum allowed change in the position of the zero level-set the
corresponding time-step is dt = ds/ max |un |.
In the Eulerian approach to the free surface problems the surface tension force must be smeared out to a
volume force within a narrow band from the interface. The transformation is achieved by using a regularized
delta function, Z Z
σκ dΓ = σκδ(φ)∇φ dΩ, (32.9)
Γ Ω
where σ is the surface tension coefficient and κ the curvature of the interface given by
∇φ
κ=∇· . (32.10)
|∇φ|
In the finite element approach the force cannot be estimated directly since it involves three derivatives of the
level-set function. Therefore we must solve an additional equation for the curvature κ,
κ − cκ ∇2 κ = ∇ · ∇φ̃. (32.11)
Here cκ is an ad hoc diffusion coefficient that may be used to smooth the resulting curvature field. Otherwise
the sharp corners may result to very large peak values of the curvature. The weak formulation of the above
equation introduces surface fluxes which are evaluated from the normal derivatives of the level-set function.
Once the level-set function and the corresponding curvature have been computed the surface tension may be
applied as a volume force in the flow equations.
32.3 Keywords
LevelSetSolver
This subroutine uses the finite element method to solve the equation (32.1). The implementation is valid in
2D, 3D and axisymmetric problems.
Solver solver id
LevelSetDistance
This solver uses the geometric information to compute the signed distance and, if desired, to advect the
zero level-set at the same time. This solver does not solve an equation and hence it does not need to have a
variable of its own. The solver is limited to 2D and axisymmetric cases.
Solver solver id
Equation String "Level Set Distance"
Procedure File "LevelSet" "LevelSetDistance"
The subroutine for renormalizing (and advecting) the level-set function.
LevelSet Variable String "Surface"
This keyword should refer to the name of the level-set variable that is used to advect the field.
The default is Surface.
Exported Variable 1 String "Surface"
In case the level-set variable does not exist it must be introduced. This may be the case if this
subroutine is also used for advecting the level-set function.
LevelSet Convect Logical
Whether to also convect the level-set function. Default is False.
Extract Interval Integer
When this function is used to extract the zero level-set function the user may choose the interval
how often this is done. The default is one. Just extracting the level-set may be useful if one just
wants to save the zero level-set without activating reinitialization.
Reinitialize Interval Integer
When this function is used to reinitialize the level-set function the user may choose the interval
how often this is done. The default is one but often this results to excessive smoothening of the
level-set field. If reinitialization is asked the zero level-set will also be automatically extracted.
Reinitialize Passive Logical
If this keyword is set True the reinitialization is not applied to the level-set field. The field is
only used to extract the zero level-set and compute the corresponding signed distance but this
information is not used to change the original field.
Narrow Band Real
In case that also the convecting is done by this solver there is the possibility to introduce a
narrow band which gives the distance at within the level-set function is recomputed. Default
is ∞. Typically this should be larger that the level-set bandwidth α used to evaluate surface
integrals.
Filename File
The zero level-set may also be saved. It consists of a number of line segments that are defined
elementwise. The results from the file may be used for visualization, for example, in MatLab. If
no filename is given the zero level-set is not saved.
File Append Logical
If the above is given this flag enforces the results to be appended on the same file rather than
writing over the old results.
Material mat id
LevelSet Velocity 1 Real
LevelSet Velocity 2 Real
If also convection is accounted in this solver the convection field is given by the above expres-
sions. Currently it is not possible to give the desired surface flux as it is not uniquely defined for
the line segments having different normals even at the same point.
LevelSetIntegrate
This subroutine computes the integrals (32.5) and (32.6). In addition of computing volume and surface
integrals this subroutine may also be used to set the absolute level of the level-set function so that volume is
conserved using equation (32.8). The implementation is valid in 2D, 3D and axisymmetric problems.
Solver solver id
Equation String Level Set Integrate
Procedure File "LevelSet" "LevelSetIntegrate"
The subroutine for computing the integrals.
LevelSet Variable String "Surface"
This keyword gives the name of the level-set function used for computing the integrals. The
default is Surface.
LevelSet Bandwidth Real
When computing the values over the domain the interface is treated a with smooth functions.
How smooth the functions are depends on the value of this keyword. Typically the bandwidth
should be such that the interface is extended over a few elements.
Conserve Volume Logical
The volume in the level-set formulation is not conserved by construction. To that end the level
of the level-set function may be tuned so that conservation is enforced. The default is False.
Conserve Volume Relaxation Real
If conservation is enforced it may be done only partially as there are inaccuracies in the evalua-
tion of the volume integrals. The default is one.
Initial Volume Real
If conservation is enforced the target volume is given by this keyword. Otherwise the volume
from the first timestep is used as the target value.
LevelSetCurvature
This solver computes the value of the curvature give the level-set function using equation (32.11).
Solver solver id
Equation String Level Set Curvature
Procedure File "LevelSet" "LevelSetCurvature"
The subroutine for computing the curvature.
Variable String "Curvature"
The name of the curvature variable.
LevelSet Variable String "Surface"
This keyword gives the name of the level-set function used for computing the integrals. The
default is Surface.
Curvature Diffusion Real
Artificial diffusion may be used to control the singularities of the curvature field around sharp
corners. The default is zero.
Curvature Coefficient Real
A constant that is used to multiply the curvature field before the solver is exited. This may be
used for example to change the sign of the curvature if the material of interest is on the outside
and not an the inside.
LevelSet Bandwidth Real
The delta function for the volume force may be applied to the curvature field also within this
solver directly. This has the disadvantage that the evaluation is done at nodal points rather than
at the integration points. However, if the flow solver used may not be modified this may be the
best alternative. If this keyword does not exist, no delta function is used to filter the curvature
field.
Boundary Condition bc id
LevelSetTimestep
The solution of the level-set function is accurate only if the timestep is limited so that the local Courant
number along the zero level-set is in the order of one or smaller. A tailored function for setting the timestep
is given in this module. This solver assumes that the level-set variable is named Surface and that this
variable is related to some solver. The velocity needed for setting the timestep should be given by the
keywords LevelSet Velocity i, where i=1,2,3.
Simulation
The function call and the needed parameters reside in the Simulation block of the command file.
Timestep Function
Real Procedure "LevelSet" "LevelSetTimestep"
Other solvers
Basically the user may give user defined material parameters where the values are computed as a function of
the level-set function. Unfortunately this approach generally uses nodal points for the smearing whereas it
is optimal to use the Gaussian integration points for doing this. There is one exception to this model that has
been implemented for the MaterialModels module, namely the viscosity may be computed at Gaussian
integration points.
Material mat id
Viscosity Model String levelset
This uses the level-set methodology to smear out the viscosity between inside and outside values.
Viscosity Real
The value of the viscosity outside the domain (negative level-set function values).
Viscosity Difference Real
The difference between the inside and outside viscosity values.
Levelset bandwidth Real
The bandwidth at which the viscosity is smeared out between the extreme values.
33.1 Introduction
Flows with a free surface are to be found in geophysical as well as technical applications. On large scale
flows the free surface usually is governed by a kinematic boundary condition given as a partial differential
equation. This equation then is solved on the specific boundary in combination with the (Navier)-Stokes
equation and the mesh update solver.
33.2 Theory
The implicit equation describing the free surface is given by
with the explicit position of the free surface h(x, y, t). Mass conservation implies that, with respect to the
velocity of the surface, ~um , F has to define a substantial surface, i.e.,
∂F
+ ~um ∇F = 0. (33.2)
∂t
The net volume flux through the free surface then is given by the projection of the difference between the
fluid velocity at the free surface, ~u and the velocity of the free surface with respect to the surface normal
In Geophysical context (e.g., Glaciology), a⊥ often is referred to as the net accumulation. With the surface
unit normal defined as
∇F
~n = , (33.4)
k∇F k
this leads to
∂F
+ ~u∇F = −k∇F ka⊥ . (33.5)
∂t
Using the definition in (33.1), (33.5) can be rewritten in its explicit form
" 2 2 #1/2
∂h ∂h ∂h ∂h ∂h
+u +v −w = 1+ + a⊥ , (33.6)
∂t ∂x ∂y ∂x ∂y
with the components of fluid velocity vector at the free surface given as ~u = (u, v, w)T . The variational
formulation of (33.6) reads as
Z Z " 2 2 #1/2
∂h ∂h ∂h ∂h ∂h
+u +v ϕ dV = w+ 1+ + a⊥ ϕ dV, (33.7)
∂t ∂x ∂y ∂x ∂y
Ω Ω
where the occurrence of h in the right hand side is inserted from the previous time-step/non-linear iteration,
hence linearizing the equation. In case of a horizontally moving mesh, the contribution in form of an arbitrary
Lagrangian-Eulerian (ALE) formulation has to be included (by default is is omitted). With the horizontal
mesh velocity components, umesh and vmesh , the ALE version of equation (33.6) then reads
" 2 2 #1/2
∂h ∂h ∂h ∂h ∂h
+ (u − umesh ) + (v − vmesh ) −w = 1+ + a⊥ , (33.8)
∂t ∂x ∂y ∂x ∂y
33.2.1 Limiters
In certain cases the free surface is constrained by an upper hmax (x, y, t) and/or a lower hmin (x, y, t) limit.
For instance, the free surface of a fluid contained in a vessel cannot penetrate the vessel’s walls. This adds
the constraint
hmin ≤ h ≤ hmax (33.9)
to (33.7) converting the variational formulation into a variational inequality. In order to obtain a with (33.9)
consistent solution a method using Dirichlet constraints within the domain is applied. The exact procedure
is the following:
1. construct the linear system: Ah = f , with the system matrix A and the solution vector h on the
left-hand side and the force vector f on the right hand side
2. set nodes as active if (33.9) is violated
3. for active nodes the matrix and force vector are manipulated such that effectively a Dirichlet condition
h = hmax/min is applied
4. the manipulated system is solved: Ãh̃ = f˜
5. a residual is obtained from the un-manipulated system: R = Ah̃ − f
6. an active node is reset if the residual is R < 0 (for lower limit) and R > 0 (for upper limit)
The whole algorithm is iterated (within the non-linear iteration loop) until the limit given in Nonlinear
System Convergence Tolerance is reached. In the converged solution the residual represents the
needed accumulation/volume flux (on matrix level, hence not in physical units) needed in order to obtain the
limited solution. Consequently, the system not necessarily is volume conserving if the Dirichlet method is
applied. As the solver in principle works with second order elements, the limitation procedure only converges
with only the between elements shared nodes being subject to the algorithm described in this section. This
is done automatically by the code.
33.3 Constraints
The code only works in Cartesian coordinates and – by the nature of the differential equation – effectively
converges only in a transient simulation. Although, technically, it also can be run in steady state simulations.
33.4 Keywords
Solver solver id
Equation String "Free Surface Limited"
Variable String Varname
The change in the free surface coordinate. This may be of any name as far as it is used consis-
tently also elsewhere, as Varname is used as a preceding keyword for the exported variable of
the residual, as well as for the accumulation
Variable DOFs Integer 1
Degrees of freedom for the free surface coordinate.
Procedure File "FreeSurfaceSolver" "FreeSurfaceSolver"
The following four keywords are used for output control.
Velocity Implicitness Real
Determines the level of implicitness in the velocity field. Values shall be in the interval cv ∈
[0, 1]. The velocity is interpolated between the current and the previous time level such that
u = (1 − cv ) un−1 + cv un . Thus, unity corresponds to complete implicitness (default).
Maximum Displacement Real
This limits the maximal local displacement in a time-step. If exceeded, relaxation automatically
is applied in order to limit the displacement.
Apply Dirichlet Logical
Takes the variational inequality method (here referred to as Dirichlet method) into use. The user
should be aware that if the method is applied (value True) this implies setting the Nonlinear
Max Iterations to a value large enough for the method to converge. The default value is
False.
ALE Formulation Logical
If set to True, the mesh horizontal mesh velocity is taken into account in the convection term.
The default value is False.
Relaxation Factor Real
The changes in the free surface may be relaxed. The default is no relaxation or value 1.0
Stabilization Method String
Sets stabilization method. Either Stabilized or Bubbles can be set.
Nonlinear System Convergence Tolerance Real
This keyword gives a criterion to terminate the nonlinear iteration after the maximum change in
the free surface coordinate is small enough
Convection String
The type of convection to be used: None (default), Computed, Constant. In the last case,
the keyword Convection Velocity is expected to be found in the Material section.
Body Force bf id
Boundary Condition bc id
Body ID Integer
usually, the solver is run on a lower dimensional boundary of the model. Then a separate body-
id has to be defined and all component of the solver (Equation, Body Force, Equation,
Initial Condition and Material) defined accordingly.
Varname Real
Dirichlet condition of the free surface variable (makes really sense only on dimension - 2 bound-
aries, e.g. lines in case of a three dimensional run)
Mesh Update i Real
usually, the free surface evolution should have a feedback on the domain’s geometry. This usually
is achieved by running the MeshUpdate Solver and linking the variable of the free surface with
the corresponding component of the Mesh Update (i=1,2,3). For instance, in a 3-dimensional
case with the variable name FreeSurf this could read as: Mesh Update 3 = Equals
FreeSurf
34.1 Introduction
The determination of free surface is often an essential part of solving a fluid dynamics problem. Usually the
surface is found by solving a free surface equation resulting from force balance, or by finding the free surface
from zero flux condition. In some extreme cases both of these methods were found to fail and therefore an
alternative approach was taken. The method can only be applied to stationary 2D or axisymmetric flows
where the total flux is conserved. This is the case, for example, in many coating and drawing processes.
34.2 Theory
The determination of the free surface takes use of the conservation of mass. If the flow is stationary the mass
flux through all planes cutting the flow must be same. In the following we concentrate on the axisymmetric
case which has more applications than the 2D case.
In the axisymmetric case the mass flux is obtained from
Z R
f (R, z) = (~u · ~n) rds. (34.1)
R0
The free surface is set by finding a surface profile R(z) such that the integral is constant for all nodes on the
surface, or
f (R, zj ) = f (R1 , z1 ) ∀j ∈ [1, M ]. (34.2)
Note that the factor 2π has been consistently omitted since it has no bearing to the shape of the free surface.
The subroutine uses simple heuristics to determine the direction of the flow on the free surface. The first
upwind node z1 on the free surface is assumed to be fixed and the corresponding flux is f1 . The new radius
is set approximately by assuming that the added or removed flow has the same velocity as the velocity on
the surface. Then the corrected radius is found from
or
f (R(m) , z) − f (R1 , z1 )
R(m+1) = R(m) + . (34.4)
un R(m)
After the new profile is being found the element nodes are moved to the new positions. The nodes that are
not on the surface may be mapped in many different ways. The straight-forward strategy is to use linear 1D
mapping. Also more generic 2D mapping may be used.
The free surface and the fluid flow must be consistent and therefore the system must be solved iteratively.
When convergence of the coupled system has been obtained the suggested dR vanishes and the free surface
solver does not affect the solution.
Sometimes the free surface solver overshoots and therefore it may be necessary to use relaxation to
suppress the large changes of the solution.
Note that the free surface solver is simple based on mass conservation. No forces are applied on the free
surface. If surface tension needs to be taken into account it may be done while solving the Navier-Stoke
equation.
• If there is back-flow within the free surface flow the correctness of the solution is not guaranteed.
Some limitations result from the current implementation:
• The free surface must be oriented so that the flow is on its negative side.
• There may be several free surfaces of this type but they must be directed the same way.
• The line integral from R0 to R may cause some difficulties in unstructured meshes. Therefore struc-
tured meshes are favored.
• At the moment density is assumed to be constant and therefore only incompressible fluids may be
considered.
34.4 Keywords
Solver solver id
Equation String "Free Surface Reduced"
Variable String dx
The change in the free surface coordinate. This may be of any name as far as it is used consis-
tently also elsewhere.
Variable DOFs Integer 1
Degrees of freedom for the free surface coordinate.
Procedure File "FreeSurfaceReduced" "FreeSurfaceReduced"
The following four keywords are used for output control.
Perform Mapping Logical
If this keyword is True the coordinate mapping is done locally by using linear 1D mapping.
This is also the default. Also 2D mapping is possible by using a separate mesh update solver.
Then the keyword should be set to False.
Nonlinear System Relaxation Factor Real
The changes in the free surface may be relaxed. The default is no relaxation or value 1.0
If mapping is not performed within the solver also boundary conditions for the mapping are required.
Surface tension may be taken into account while solving the Navier-Stokes equation. The proper
keywords for activating the surface tension are explained in the manual of the Navier-Stokes solver.
Particle Dynamics
35.1 Introduction
Note: this is an initial version of the dynamic particle tracker. For real applications it probably requires some
additional effort.
The ability to follow single or statistical particles within a finite element can be used in a variety of appli-
cations. A common application is to follow particles along streamlines for the purpose of flow visualization.
Accounting for electrostatic forces opens the field to microfluidics and accounting for the gravitational force
enables applications in sedimentation, for example. If also particle-particle interaction is accounted for also
granular flow phenomena may be studied.
This module depends on the many library routines related to particle transport in Elmer. In this module
it is assumed that there may be particle-particle interactions. This choice fixes the time-stepping strategies
of the different particles together, at least without heroic timestepping schemes. In other words, the same
timestep size is applied to the whole particle set.
The particles are located in the finite element mesh using a marching routine where intersections with
element boundaries are checked for. The nearest boundary on the way is crossed until there is no boundary
to cross. Then the right element has been reached. The algorithm is fast when the stepsize with respect to
elementsize is smaller or of the same order. Therefore for the initialization the octree-based search may be
more economical and also more robust regarding geometric shapes.
The particle-particle interaction is based on the knowledge of nearest neighbours. Currently the neigh-
bours are determined using the closeness to the nodes if the parent element. This means that the interaction
distance needs to be smaller than h/2 where h is the mesh parameter. Further, it means that the mesh must
be rather uniform.
As the name implies, this module assumes the particles to be dynamic i.e. they have an acceleration.
However, the user may also use the module neglecting the inertial forces and requiring a force balance
between the drag force and external forces.
35.2 Theory
Forces acting on the particle
Assume that we have a particle in position ~r. The corresponding velocity is
d~r
~v = (35.1)
dt
f~ = m~g , (35.3)
where ~g is the acceleration due to gravity. The electrostatic force is simply proportional to the electric field
f~e = q E
~ = q∇φ (35.4)
where ~v0 is the velocity of the fluid. If the change is estimated to be d~r then the estimate may be improved
by the gradient of velocity, i.e. ∇~v0 · d~r. For Stokes flow the proportionality coefficient scales with viscosity,
for example for spheres b = 6πηd where η is the fluid viscosity and d the radius of the sphere.
Collision model
Two particles may collide with one-another. Assume that the initial particle positions are ~r1 and ~r2 . Velocity
vectors are ~v1 and ~v2 and lets define δ~r = ~r1 − ~r2 and δ~v = ~v1 − ~v2 . Now the condition for a collision is
Contact model
In general the contact between particles depends on their relative position, relative velocity, and relative
angular velocity. Generally the contacts should include some damping (negative feedback from velocity)
since otherwise the system is prone to flow up. In molecular dynamics, for example, also interaction with
more than two particles should be considered. The current treatment is quite limited and we here assume
that the contact results just to a spring force in the form
f~k = k max(R1 + R2 − |d~r|, 0)~nr , (35.11)
where k is the spring coefficient.
A similar particle contact model may be present with the wall but possibly with different value for the
spring coefficient.
Time evolution
For particles with mass the basic update sequence of velocity and position is
dt
~vi+1 = ~v + Σf (35.12)
m
~ri+1 = ~r + dt~vi+1 (35.13)
while for massless particles it is assumed that the particle drag is in balance with the other forces given
explicitly
1
~vi+1 = Σf (35.14)
b
~ri+1 = ~r + dt~vi+1 (35.15)
The timestep dt may be given explicitly, or it may be defined from the characteristic velocity V . If the
change in distance dS is given then
dS
dt = , (35.16)
V
and when the Courant number C is given
h
dt = C , (35.17)
V
where V is either the maximum absolute velocity, or the mean absolute velocity.
Also other timestepping schemes could be used but that’s something for later.
35.2.1 Postprocessing
The possibility to use each particle as an integration point in data fitting problem makes it possible to couple
the particles back to a continuous field. The following kinds of information could be abstracted from the
particles, for example.
Kinetic energy of particles
1
Ek = mv 2 . (35.18)
2
Potential energy associated to gravity field
Eg = m~g · ~r. (35.19)
Potential energy associated to electrostatic field The corresponding potential energy is
Ee = qφ. (35.20)
Etc. In practice sufficient amount of data may not be present at every node if the data is used only after
appropriate smoothing.
35.3 Keywords
Solver solver id
Equation String [ParticleDynamics]
The name of the equation.
Procedure File "ParticleDynamics" "ParticleDynamics"
The name of the procedure.
Keywords related to the actual physical interaction models chosen within the particles and with particles
and walls.
Particle Particle Collision Logical
Is there some collisions between particles.
Particle Particle Contact Logical
Is there contact between particles resulting to additional forces.
Keywords related to the physical properties of the particle and to the joint physical properties of the
particle-particle and particle-wall contacts.
Particle Mass Real
There are a number of particle properties needed in different interaction models and particle mass
is one of them. In principle these could be altered to be variables but currently they are assumed
to be the same for all particles.
Particle Radius Real
The particle raidus used in particle-particle interaction, and in evaluating the density of the par-
ticle.
Particle Gravity Logical
Should gravity be accounted for. If yes, use the gravity defined in the
Particle Lift Logical
The background fluid has a density that results to a lift (buoyancy) that may be accounted for.
Should gravity be accounted for. If yes, use the gravity defined in the Constants section.
Particle Damping Real
Particle damping proportional to velocity only.
Particle Drag Coefficient Real
Particle drag coefficient in fluid field.
Particle Bounciness Real
Defines, when particles collide is the collision totally elastic or totally inelastic. Corresponding
extreme values are 1 and 0. This relates only to collision models.
Particle Spring Real
Spring constant in the force model between particles. This relates only to contact models.
Particle Charge Real
The electric charge of the particle.
Keywords related to saving and echoing information. No effect to the actual computations.
Output Interval Integer
The internal output interval of the solver. If not given the particle data will be saved within the
solver. The alternative is to save particle data with an external solver.
Output Format String
Output format which may be either table or vtu.
Table Format Logical
Vtu Format Logical
Alternative way of giving the output format. Has the nice property that several formats may be
given at the same time.
Filename Prefix String
The prefix of the filename used for saving. Depending on the chosen format an appropriate suffix
is attached to the prefix.
Filename Particle Numbering Logical
If possible in the format, use particle indexes for the numbering of files.
Filename Timestep Numbering Logical
If possible in the format, use timestep indexes for the numbering of the files. This is the default
in vtu format.
Particle Info Logical
Optionally print out on the screen information on the number of particles and time steps taken.
Statistical Info Logical
Optionally print out on the screen some statistical information on the coordinate positions and
velocities. May be useful for debugging purposes, for example.
36.1 Introduction
This solver utilizes the particle tracker features of Elmer to advect scalar fields diffusion-free on the mesh.
For each node of the field one particle is sent backwards in time and the field value is restored from the
location where the particle is found.
For more details on the particle tracking look at the other modules utilizing the same features in a more
generic way.
36.2 Theory
In particle advection we assume that the fields are transported diffusion-free carried by a velocity field ~v .
The particle are initialized at the nodes of the mesh. Thereafter each particle is followed −δt in time i.e. the
following integral is evaluated
Z −δt
~r = ~r0 + ~v dt. (36.1)
0
Currently the integral may be evaluated using first order explicit scheme or a second order Runge-Kutta
scheme. In the first order scheme a quadratic correction term is available making the scheme effectively
comparable with the Runge-Kutta scheme. There the following approximation is used
1
< ~v >= ~v0 + (∇~v0 ) · ~v0 dt. (36.2)
2
When the particles have been transported the field may be evaluated from
f (~r0 , t) = f (~r, t − δt) (36.3)
The treatment of boundaries results to some additional complication. It is assumed that if the particles
vanishes in the upstream boundary then the boundary values of f are used.
The particles may have some properties along the path integral. For this purpose the user may evaluate
evolution over time, Z
It = c(t) dt (36.4)
36.4 Keywords
Solver solver id
Boundary Condition bc id
Particle Wall T
his will mark the wall which the particle cannot go though and by default stops at.
Particle Fixed Condition Real
We may want to freeze the particles on the boundary depending on the physics. This is done if
this condition has a positive value.
37.1 Introduction
The purpose of this solver is to allow accurate solution of ordinary differential equations in moving mesh.
The approach is limited meshes that could be extruded being drawn to the direction of the extrusion. The
idea is that then in moving coordinates we have a direct correspondence between mesh parameter h, draw
velocity v and timestep dt, by dt = h/v.
All the equation could basically also be solved in an eulerien mesh where the velocity is presented as
convection term in the transport equation. The problem with this kind of approach is that such convec-
tion terms require some kind of stabilization schemes. In extreme cases when diffusion tends to zero such
equations easily become hard to solve. The current approach cannot consider diffusion. Only convection,
reaction and diffusion terms are possible.
37.2 Keywords
Solver solver id
Equation String MarchingOde
The name of the equation.
Procedure File "MarchingODESolver" "MarchingODESolver"
The name of the procedure.
Variable String
Name of the variable used for the marching.
Nonlinear System Max Iterations Integer
If the system is nonlinear we may solve it for each node until convergence or number of iterations
has been reached.
Nonlinear System Convergence Tolerance Real
Convergence tolerance if several iterations are used..
Draw Velocity Real
Speed of the drawing process in the direction of the extrusion.
38.1 Introduction
Moving boundaries are often encountered in different types of computations, e.g. in Fluid-Structure Inter-
action (FSI) problems. Moving boundaries pose the problem of mesh adaptation to the boundaries. With
this solver, instead of generating the whole mesh afresh when a boundary is moved, the current mesh nodes
are moved so that the mesh hopefully remains ’good’. This type of solution only applies to cases where
the changes in geometry are relatively small. It is, however, often cheaper in terms of CPU time to use this
module in contrast to regenerating the whole mesh.
For time dependent simulations the mesh deformation velocity is also computed. The name of this
variable is Mesh Velocity.
38.2 Theory
The equation for elastic deformation of the mesh, given displacement of the boundaries, may be written as
− ∇ · τ = 0, (38.1)
Here d~ is the mesh displacement field, µ and λ are the first and second Lame parameters, respectively, and I
is the unit tensor. The linearized strains are given as
~ = 1 ~ ~ T ).
ε(d) (∇d + (∇d) (38.3)
2
The Lame parameters in terms of Young’s modulus Y and the Poisson ratio κ read
Yκ Y
µ= , λ= . (38.4)
(1 − κ)(1 − 2κ) 2(1 + κ)
Note that in this context the values of the material parameters are fictional, and may be chosen to help
convergence or quality of the resulting mesh.
di = dbi (38.5)
may be given. Usually the displacement is given a priori or computed by, for example, the elasticity solvers.
38.3 Keywords
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
Equation String [Mesh Update]
The name of the equation. If different from the default name Mesh Update, then the following
two keywords must be defined as well.
Procedure File "MeshSolve" "MeshSolver"
Name of the solver subroutine.
Variable String
Name of the variable.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Mesh Update Logical
If set to True, solve the mesh adaptation equations.
Material mat id
The material section is used to give the material parameter values. The following material parameters
may be set for the Navier equations.
Poisson Ratio Real
For isotropic materials the Poisson ratio must be given with this keyword.
Youngs Modulus Real
The elastic modulus must be given with this keyword.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. Those related to the
Navier equations are
Mesh Update i Real
Dirichlet boundary condition for each displacement component i= 1, 2, 3. The boundary dis-
placement may be computed with some other solver. The computed displacement field may then
be used in the setting in the following way:
Mesh Update i Equals Displacement i
Including such lines with i=1,2,3 in the boundary condition setting will give the position of
the updated mesh on the boundary directly in terms of the solution of the displacement solver.
38.4 Examples
38.4.1 A Simple FSI computation using MeshSolver
In this simple computation Navier-Stokes equations are solved in the domain shown in the two pictures
below. On the left there is an inflow boundary, and on the right an outflow boundary. In the block inside the
flow domain (the mesh is not shown for the block), the elasticity equations are solved. The block is fixed at
the bottom, and is otherwise deformed by the fluid pressure and flow fields. The whole system is iterated as
follows:
• Solve fluid flow,
Figure 38.1: The original computational mesh (up), and the mesh of the converged solution (down) of a FSI
computation.
39.1 Introduction
This solver is a variation of the MeshSolver for cases where the true mesh velocity is not of concern and
more liberties can be used in the mesh adaptation. Also it may be used as the mesh adaptation solver in
conjunction with MeshSolver. For example, in shape optimization of fluid-structure interaction problems
two mesh adaptation solvers may be needed simultaneously.
39.2 Theory
For the equation to be solved look at the theory section of the MeshSolver. In addition to that, also weak
ways of giving boundary conditions is implemented, namely
τ · ~n = kd + f + c(d − d0 ) (39.1)
where k is a spring coefficient, f is a given force, and d0 is the target configuration. When c goes to infinity,
this condition approaches the Dirichlet conditions.
39.3 Keywords
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
Procedure File "NonphysicalMeshSolve" "MeshSolver"
Name of the solver subroutine.
Variable String [-dofs 3 Mesh Deform]
The name of the displacement field. It should be different from Mesh Update in order to avoid
conflicts in its interpretation. Here we use the name Mesh Deform. The dimension should be
the same as that of the mesh.
Cumulative Displacements Logical
If the same solver is called multiple times, then this flag controls whether the displacements are
added each time to the initial or previous mesh shape. The default is False.
40.1 Introduction
Sometimes there is a need to transform meshes without generating a new mesh. The most simple case is
that of a rigid motion where some bodies move according to prescribed rotations and translations. Typically
this could be a preprocessing step in a parametric study of some problem. Then this solver may be used to
perform the mesh transformation.
In addition to applying rigid transformations to bodies followed by a stretching, this solver includes also
a relaxation parameter which may be used to define which fraction of the node coordinates is taken from the
suggested coordinates, and which part from the original coordinates.
It should be noted that the usage of this solver is rather limited. It cannot handle cases where bodies
move with respect to one another if there is a mesh between the bodies. Then the MeshUpdate solver
should be used instead.
40.2 Theory
Given original coordinate ~x0 the solver applied first a rotation, then a translation, and finally a scaling
operator such that the suggested new coordinates yield
where ~t is the vector of translation, ~o is the origin, S the scaling matrix, and R is the rotation matrix. Rotation
may currently be performed only around one main axis.
Often it is desirable that the rigid transformations are performed only for some objects and while some
stay fixed. Between them the transformation degree should vary smoothly. To this aim the solver may be
used to compute a degree of transformation field from the Poisson equation
− ∇ · (1 + c|∇Φ|)∇Φ = s (40.2)
where c is an optional coefficient which may be used to increase the mesh rigidity around singularities. A
suitable boundary condition is Φ = 0 for fixed objects and Φ = 1 for moving objects.
Usually the rigid mesh mapper does not have a source term. However, for different testing purposes there
is also the possibility to give a source term s which may be used to distort the mesh in a continuous way.
Upon request the deformation may then be normalized to unity.
When the rigid mesh mapping is applied together with the relaxation, the end result is
40.3 Keywords
Solver solver id
Equation String [RigidMeshMapper]
The name of the equation.
Procedure File "RigidMeshMapper" "RigidMeshMapper"
The name of the procedure.
Variable String
Optionally the solver may be used to compute a relaxation field whose values are on the interval
[0, 1]. The final displacement is then obtained as a product of the field and the suggested rigid
body motion. The name is arbitrary since it is not referenced elsewhere.
Mesh Rotation Axis Order(dim) Integer
The user may specify the order in which the mesh is rotated around the axes with this keyword.
By default first rotation is around x-axis, then around y, and finally around z. Different order
will give a different end result.
Translate Before Rotate Logical
If this keyword is given value True, then the translation is carried out before rotations. The
default is vice versa.
Cumulative Displacements Logical
The displacement resulting from this solver may be either absolute or cumulative. For example,
for rotating problems if the mode is cumulative only the incremental angle is given. If the
cumulative mode is not enforced, then the full angle from the start of the simulation should be
given. The default is False.
Calculate Mesh Velocity Logical
If this keyword is enforced, then the solver will compute the mesh velocity resulting from rigid
body deformation in a transient case. The name of the resulting vector field will be Mesh
Velocity.
Mesh Relax Normalize Found
Normalize the mesh relaxation field such that the maximum value is one.
Body Force bf id
The mesh transformations are defined in this section.
Boundary Condition bc id
The boundary conditions that define the moving and fixed walls.
Moving Boundary Logical
Gets relaxation field multiplied by one.
Fixed Boundary Logical
Gets relaxation field multiplied by zero.
41.1 Introduction
For structured meshes some operations may be done much more effectively than for generic meshes. One
such operation is the mapping of mesh so that it is fitted for given top and bottom surfaces. For example,
the mesh for the computational glaciology could be deduced from a uniform initial mesh when its top and
bottom surfaces would be known in terms of some given fields.
41.2 Theory
The algorithm used for the mapping has two sweeps. Assume that we would like to perform mapping in
direction ~ez . At the first sweep over all elements we would deduce pairwise information over nodes on which
nodes are in up and down directions from each other. Then using this directional information recursively
one can easily deduce which nodes are the top and bottom representatives of any node in the mesh. With
this information any node between the top and bottom surface may be mapped as the linear combination of
the top and bottom displacements. In the end the top surface of the mesh is mapped to the given top position
and the bottom surface of the mesh to the given bottom position, correspondingly.
41.3 Keywords
Solver solver id
Equation String [StructuredMeshMapper]
The name of the equation.
Procedure File "StructuredMeshMapper" "StructuredMeshMapper"
The name of the procedure.
Active Coordinate Integer
The direction in which the structured mapping is performed i.e. 1, 2 or 3.
Displacement Mode Logical
The values may be either used either directly as absolute coordinate values, or as displacement
adding them to the original coordinate values. With this keyword the latter may be chosen.
42.1 Introduction
There are many different kinds of free surface problems. It is difficult to create a generic algorithm that
would be optimal for all problems. Therefore specific cases may need specific solvers. This solver is
intended for steady-state drawing and pulling problems where the mesh is structured in the direction of the
forced flow. Then it is possible to follow the streamlines of the flow and map element edges with the flow.
When converged the streamlines will then coincide with the element edges providing an optimal solution for
the problem.
The solver can be used by itself as a free surface solver, or together with a mesh adaptation solver so that
the current solver only gives the suggested displacement at the boundaries.
42.2 Theory
Assume that we want to map the coordinates ~ri so that they coincide with the streamlines. Then
|dri,k |
~ri+1 = ~ri + ~va (42.1)
|va,k |
where k is the active coordinate direction of the pulling or drawing process. The average velocity may be
computed from
1
~va = (~vi + ~v (~ri + 1)) (42.2)
2
or from
1
~va = ~v (~ri + ~ri+1 ) . (42.3)
2
When ~ri+1 is updated the information may be used to derive on improved estimate of ~va . This requires
as an operation that the velocity must be evaluated within an arbitrary position. For this purpose an octree
structure for the elements is used to speedup the search. Typically even one corrector step will improve the
results significantly.
42.3 Keywords
Solver solver id
Equation String [StructuredFlowLine]
The name of the equation.
Procedure File "StructuredFlowLine" "StructuredFlowLine"
The name of the procedure.
Velocity Variable Name String
Name of the variable used to define the streamlines.
Active Coordinate Integer
The drawing direction i.e. 1, 2 or 3.
Dot Product Tolerance Real
When determining the structure of the mesh in the active direction this tolerance is used to decide
that an element edge is aligned with the direction of the action.
Displacement Mode Logical
The values may be either used either directly, or saved to a field. If this flag is set True the
coordinate values will be changed directly. The default is False.
Hard Displacement Name String
The name of the field for the suggested displacement. These values may be used in a soft way in
mesh deformations in order to avoid singularities that often appear at corners.
True Flow Line Iterations Logical
When computing the drawing shapes the first iterations lead to larger displacements and set
higher demands to the numerical methods. Close to convergence the velocity may be more
accurately defined at the existing flow line. This flag determines the number of the more costly
iterations. The default is zero.
Averaging Order Integer
Order of iterations in evaluating the new position. Default is one.
Averaging Method Integer
Whether to use velocity at the average point (1), or average of the velocity (2).
Nonlinear System Relaxation Factor Real
Relaxation may be used to relax already the suggested displacement field.
Boundary Condition bc id
Flow Line Logical
By defining this keyword the solver is applied only to the those boundary nodes where the flag
is active. This reduces the computational time required.
Body Force bf id
Flow Line Logical
By defining this keyword the solver is applied only to the those bulk nodes nodes where the flag
is active.
43.1 Introduction
This module is used to calculate provide information on the mesh. The quality of the mesh will have a great
effect on the solution. This solver may help the user to determine whether the mesh is suitable for the need.
Currently three different operations are performed:
• element size
This is the metric determinant given by the ElementInfo.
• element skew
This is the skewness (in degrees) of the mesh, if applicable. Only quadrilaterals, pyramids, wedges
and hexahedrons may be skewed.
• element ratio
This refers to the ratio between maximum and minimum edge lengths of an element.
The operations are performed separately for bulk and boundary elements.
It is available currently only in serial.
43.2 Keywords
Solver solver id
Equation String ElementStats
Procedure File "ElementStats" "ElementStats"
Create Histogram Logical
When analyzing the mesh the results may be shown also as a histogram with an even distribu-
tion between min and max values. This flag activates the classification of the statistics into a
histogram.
Histogram Intervals Integer
The number of intervals in the histogram when classifying the element properties.
Streamline Computation
44.1 Introduction
Streamline is a line in flow whose tangent is parallel to velocity field ~u of the flow in every point ~x. It should
be noted that the path of material is generally not the same as streamlines. There is also third set of closely
related lines, namely streak lines. On certain streak lines lie all those flow elements that at some earlier
instant passed through a certain point in domain. Of course, the streak lines are generally different than
streamlines but when the flow is steady all three set of lines coincide.
Streamlines are mainly used in providing a picture of the flow field. Drawing streamlines so that neigh-
bouring streamlines differ by the same amount, gives a picture where direction and magnitude change of
flow are clearly prescribed.
44.2 Theory
We are restricted here to the incompressible, steady flow in 2D geometry. The geometry may be 3D, but it
must effectively be 2D as in axis symmetric geometry.
In 2D Cartesian geometry stream function ψ is defined
∂ψ ∂ψ
u = , v = − . (44.1)
∂y ∂x
Here the geometry is (x, y) and the corresponding flow is ~u = (u, v). Let Ω be the domain of the flow and
~v a test function for the flow. Definition (44.1) leads to finite element approximation
Z Z
∇ψ · ~v dΩ = ~u⊥ · ~v dΩ (44.2)
Ω Ω
In axis symmetric geometry the mass conservation calculated in a different way. This leads to following
definition for stream function.
1 ∂ψ 1 ∂ψ
u = , v = − (44.3)
r ∂r r ∂z
where the cylindrical coordinates are (z, r, φ), velocity components are (u, v, w) and axis of symmetry is z
i.e. r = 0. This function is sometimes called the Stokes stream function and it is not as informative as the
stream function in Cartesian case. Of course the finite element approximation is a bit different.
Z Z
∇ψ · ~v dΩ = ~u⊥ · ~v r dΩ (44.4)
Ω Ω
44.3 Limitations
Some limitations of the current implementation:
• Solver gets the velocity field from user defined variable. In Cartesian case it assumes that first degree
of freedom is the x-component and the second is the y-component of the velocity. In axis symmetric
case it assumes that the first degree of freedom is the r-component and the second is the z-component
of the velocity field.
• User can define the node whose value is first set to zero. This shouldn’t have affect on results if the
normal stream function is used in Cartesian coordinates and Stokes stream function in axis symmetric
coordinates. However, if used stream function is forced to something else, the position of the first node
usually has a large effect on results. This is because the mass conservation is calculated differently.
44.4 Keywords
Simulation
Equation String
The name you want to give to the solver, for example StreamSolver.
Procedure File "StreamSolver" "StreamSolver"
The name of the file and subroutine.
Variable String
The name you want to call the solution, for example StreamFunction.
Variable DOFs Integer 1
The degree of freedom of the variable. Stream function is scalar so this must be set to 1.
Stream Function Velocity Variable String
The name of the velocity field variable. FlowSolvers solution is called Flow Solution and
this is also the default value.
44.5 Example
This example computes the streamlines from a 2D incompressible flow field assuming the default name for
flow field
Solver 4
Exec Solver = after all
Equation = "streamlines"
Procedure = "StreamSolver" "StreamSolver"
Variable = String Stream
Flux Computation
45.1 Introduction
This module is used to calculate the fluxes resulting usually from Poisson kind of equations. These include,
for example, the heat equation, the electrostatic equation, and the pressure equation for Darcy’s flow. There
are also flux computation subroutines that are built in the solvers but this provides a generic approach that
should be easy to combine with most solvers.
45.2 Theory
Given a potential φ it is often interesting to know its gradient or the resulting flux. The gradient may be
computed from ∇φ. The flux resulting from a potential field is assumed to be proportional to the gradi-
ent. The proportionality coefficient c may be conductivity, permeability, diffusivity, etc., depending on the
application field. It may be a scalar or a tensor of second kind. The flux may now be expressed as
~q = −c∇φ. (45.1)
For the heat equation the potential would thus be the temperature and the conductivity would be the heat
conductivity.
The magnitude of a flux (or gradient) may be defined as
The computation of magnitude may be done before or after the numerical discretization giving slightly
different results.
implementation. In the solver it is also possible to choose just one component as could be sometimes
desirable.
The main limitation of the current version is that it does not take into account any boundary conditions.
Therefore, if there is an internal boundary over which the flux is not continuous, the calculated value does
not make sense.
45.4 Keywords
Solver solver id
Equation String Flux Solver
Procedure File "FluxSolver" "FluxSolver"
Discontinuous Galerkin Logical
For discontinuous fields the standard Galerkin approximation enforces continuity which may be
unphysical. As a remedy for this, the user can enforce Discontinuous Galerkin (DG) formulation.
Then the result may be discontinuous, and may even be visualized as such if the postprocessing
format supports it.
Average Within Materials Logical
This keyword enforces continuity within the same material in the DG discretization using the
penalty terms of the DG formulation.
Calculate Flux Logical
This flag controls the computation of fluxes. The default is False.
Calculate Flux Abs Logical
In conjunction with flux computation this flag may be used to compute the absolute value of the
flux vector. It requires that the previous flag is active.
Calculate Flux Magnitude Logical
This flag can be used to compute the magnitude of the vector field. Basically it is the same in
continuous level as the previous but this requires less memory and solves the matrix equation
only once. The downside is that even negative values may be introduced.
Calculate Grad Logical
This flag turns on gradient computation. The default is False.
Calculate Grad Abs Logical
In conjunction with gradient computation this flag may be used to compute the absolute value of
the gradient. It requires that the previous flag is active.
Calculate Grad Magnitude Logical
This flag can be used to compute the magnitude of the gradient field. Basically it is the same
in continuous level as the previous but this requires less memory and solves the matrix equation
only once. The downside is that even negative values may be introduced.
Enforce Positive Magnitude Logical
If this is active, then the negative values of the computed magnitude fields are a posteriori set to
zero.
Target Variable String "Temperature"
This gives the name of the potential variable used to compute the gradient. By default the variable
is Temperature.
Flux Coefficient String "Heat Conductivity"
This gives the name of the proportionality coefficient to compute the flux. By default the coeffi-
cient is Heat Conductivity.
The resulting linear system is easily solved even without preconditioning. Fox example, the following
linear system control may be applied.
45.5 Example
This example computes the diffusive heat flux in the whole domain after the whole solution has been per-
formed.
Solver 3
Exec Solver = after all
Equation = "flux compute"
Procedure = "FluxSolver" "FluxSolver"
Calculate Flux = Logical True
Flux Variable = String Temperature
Flux Coefficient = String "Heat Conductivity"
Vorticity Computation
46.1 Introduction
This module is used to calculate the vorticity of vector fields. Vorticity may be of interest mainly in the post-
processing of flow fields or electromagnetic fields. The default name for the vorticity is Curl varname.
46.2 Theory
The vorticity w
~ of a vector field ~v is obtained simply as the curl of the field,
~ = ∇ × ~v .
w (46.1)
46.3 Keywords
Solver solver id
Equation String Vorticity Solver
Procedure File "VorticitySolver" "VorticitySolver"
46.4 Example
This example computes the vorticity field after each timestep. Some resources are saved by reusing the same
bulk matrix.
Solver 5
Exec Solver = after timestep
Equation = "vorticity"
Procedure = "VorticitySolver" "VorticitySolver"
Constant Bulk Matrix = True
Divergence Computation
47.1 Introduction
This module is used to calculate the divergence of vector fields. Divergence may be of interest mainly in the
postprocessing to check how well incompressibility constraints are honored.
47.2 Theory
The divergence d of a vector field ~v is obtained simply from
d = ∇ · ~v . (47.1)
The most consist ant method for computing the divergence in conjunction with the finite elements is to
solve the equation (47.1) using the Galerkin method. The resulting matrix is diagonally dominated and may
be computed easily with iterative methods even with poor preconditioners.
47.3 Keywords
Solver solver id
Variable String
By default the variable is obtained from the divergence variable by adding a prefix Div to the
field name. Naturally the name of the resulting field may also be given as desired.
The solver is easily solved even without preconditioning. Fox example, the following linear system
control may be applied.
48.1 Introduction
This module is an auxiliary solver that may be used to compute the scalar potential that results to a given
flux. The flux is assumed to be a vector field resulting from some computation. This solver is the dual of the
FluxSolver. Computing first the flux of a given potential and thereafter resolving for the potential that
creates the flux should give approximately the original potential.
48.2 Theory
The flux resulting from a potential field is assumed to be proportional to the gradient of the field, φ. The
proportionality factor is here called conductivity, c. The flux may therefore be expressed as
q = −c∇φ. (48.1)
For heat equation the potential would be the temperature and the conductivity would be the heat conductivity.
This solver handles the equation in the reverse form, i.e. given the flux the potential is solved. The weak
formulation is created by choosing the test functions to be the gradients of the shape functions. This results
to the standard discretization of the Poisson equation.
The potential is not defined uniquely unless the level is fixed at least at one point. Therefore the user
should set a Dirichlet condition at least at one node.
48.3 Keywords
Solver solver id
Equation String ScalarPotentialSolver
Procedure File "ScalarPotentialSolver" "ScalarPotentialSolver"
Variable String "Scalar Potential"
The desired name of the resulting scalar field.
Boundary Condition bc id
Scalar Potential Real
The defined field variable must be set to be a constant at least at one point.
Target Nodes Integer
The user may also define a target node on-the-fly at which the condition is set.
49.1 Introduction
When fluid-structure interaction (FSI) problems are solved with a loosely coupled iteration strategy there is
a risk of applying unphysical boundary conditions that lead to severe convergence problems. The reason for
this is that initially the fluid domain is unaware of the constraint of the structural domain, and vice versa. If
the iteration converges this discrepancy will be settled, but sometimes the initial phase is so ill posed that
convergence is practically impossible to obtain [4, 3].
The problem may be approached by applying the method of artificial compressibility to the fluid-
structure interaction. Previously artificial compressibility has mainly been used as a trick to eliminate the
pressure from the Navier-Stokes equations or to improve the convergence of the solution procedure [2, 6, 1].
Here the compressibility is defined so that it makes the fluid imitate the elastic response of the structure.
The method is best suited for cases where there is a direct correspondence between the pressure and the
volume. Inertial forces and traction forces should be of lesser importance. The method might, for example,
boost up the modeling of human arteries.
49.2 Theory
49.2.1 Fluid-structure interaction
The theoretical model with some results is thoroughly presented in
We look at the time-dependent fluid-structure interaction of elastic structures and incompressible fluid.
The equations of momentum in the structural domain is
∂ 2 ~u
ρ = ∇ · τ + f~ in Ωs , (49.1)
∂t2
where ρ is the density, ~u is the displacement, f~ the applied body force and τ = τ (~u) the stress tensor that
for elastic materials may be locally linearized with ~u. For the fluid fluid domain the equation is
∂~v
ρ + ~v · ∇~v = ∇ · σ + f~ in Ωf , (49.2)
∂t
where ~v the fluid velocity and σ the stress tensor. For Newtonian incompressible fluids the stress is
σ = 2µε(~v ) − pI, (49.3)
where µ is the viscosity, ε(~v ) the strain rate tensor and p the pressure. In addition the fluid has to follow the
equation of continuity that for incompressible fluid simplifies to
∇ · ~v = 0 in Ωf . (49.4)
For later use we, however, recall the general form of the continuity equation,
∂ρ
+ ∇ · (ρ~v ) = 0 in Ωf . (49.5)
∂t
The fluid-structure interface, Γf s , must meet two different boundary conditions. At the interface the fluid
and structure velocity should be the same,
On the other hand, the surface force acting on the structure, ~gs , should be opposite to the force acting on the
fluid, ~gf , thus
~gs (~r, t) = −~gf (~r, t), ~r ∈ Γf s . (49.7)
A widely used iteration scheme in FSI is the following: First, assume a constant geometry and solve the
Navier-Stokes equation for the fluid domain with fixed boundary conditions for the velocity. Then calculate
the surface forces acting on the structure. Using these forces solve the structural problem. Using the resulting
displacement velocities as fixed boundary conditions resolve the fluid domain. Continue the procedure until
the solution has converged.
The above described iteration usually works quite well. However, in some cases the boundary condi-
tions (49.6) and (49.7) lead to problems. The elasticity solver is not aware of the divergence free constraint
of the velocity field. Therefore the suggested displacement velocities used as boundary conditions may well
be such that there is no solution for the continuity equation. A proper coupling method makes the solution
possible even if the velocity boundary conditions aren’t exactly correct. Further, if the Navier-Stokes equa-
tion is solved without taking into account the elasticity of the walls, the forces in equation (49.7) will be
exaggerated. The pathological case is one where all the boundaries have fixed velocities. Then even an in-
finitely small net flux leads to infinite pressure values. A proper coupling method should therefore also give
realistic pressure values even with inaccurate boundary conditions. The method of artificial compressibility
meets both these requirements.
dV
= c dP. (49.8)
V
This assumption limits the use of the model in highly nonlinear cases.
The change in the volume should be the same as the net volume flux into the domain. As this cannot be
guaranteed during the iteration, some other way to enable the material conservation must be used. A natural
choice is to let the density of the fluid vary so that is has the same pressure response as the elastic walls,
dρ
= c dP, (49.9)
ρ
where c is the artificial compressibility. This is interpreted locally and inserted to the continuity equa-
tion (49.5) while neglecting the space derivative of the density, thus
dp
c + ∇ · ~v = 0, (49.10)
dt
where dp is the local pressure change. Here the time derivative of pressure must be understood as an iteration
trick. A more precise expression is
c (m)
p − p(m−1) + ∇ · ~v (m) = 0, (49.11)
∆t
where m is the current iteration step related to fluid-structure coupling. When the iteration converges p(m) →
p(m−1) and therefore the modified equation is consistent with the original one. The weak form of the
equation for finite element method (FEM) may easily be written,
Z Z
(m) 1
(∇ · ~v )ϕp dΩ + c p(m) − p(m−1) ϕp dΩ = 0, (49.12)
Ωf ∆t Ωf
1 dV
c= . (49.13)
V dP
The change in volume may be calculated by comparing it to initial volume, thus
V − V0 1
c= . (49.14)
V0 dP
For small deformations ds = ~u · ~n, where ~n is the surface normal. Therefore we may use an alternative
form convenient for numerical computations,
R R
Γf s
(~u · ~n) dA Γf s dA
c= R R . (49.15)
Ωf
dV Γf s
dp dA
A suitable test load for computing compressibility is the current pressure load on the structure. However,
for the first step the compressibility must be predefined. It is safer to over-estimate it since that leads to too
small a pressure increase. Too large a pressure increase might ruin the solution of the elasticity solver and
by that also the computational mesh used by the flow solver would be corrupted. Therefore some sort of
exaggeration factor exceeding unity might be used to ensure convergence.
where the superscript e refers to the volume of an element. This may also be solved using finite element
strategies to get nodal values for c.
49.3 Keywords
Keywords of FlowSolve
Material mat id
In the material section the compressibility model and the initial artificial compressibility field is given.
Solver solver id
Equation String CompressibilityScale
The name of the solver.
Procedure File "ArtificialCompressibility"
"CompressibilityScale"
The subroutine in the dynamically linked file.
Steady State Convergence Tolerance Real
How much the relative value of the compressibility may change between iterations, abs(ci −
ci−1 )/ci < ε.
Nonlinear System Relaxation Factor Real
Relaxation scheme c0i = λci + (1 − λ)ci−1 for the compressibility. By dafault is λ = 1.
Boundary Condition bc id
Force BC Logical
The elastic response is calculated over the surface(s) which has this definition as True.
Solver solver id
Equation String CompressibilitySolver
Procedure File "ArtificialCompressibility"
"CompressibilitySolver"
Variable String ac
The name of the artificial compressibility field variable.
Displacement Variable Name String "Mesh Update"
The name of the displacement field variable that is used to compute the the volume change.
Displaced Shape Logical True
Flag that defines whether the current shape is the displaced or original shape.
Reference Pressure Real
The value of pressure used for the test loading.
The computed field should then be given as the value in the material section.
Material mat id
Artificial Compressibility Equals ac
The initial value of artificial compressibility given by the solver.
49.3.1 Examples
The examples show a 2D square and a 3D cube being gradually filled. The fluid comes in from one wall and
the opposing elastic wall makes room for the fluid so that the continuity equation is satisfied. Here the value
of artificial compressibility is scaled every timestep to account for the nonlinear elasticity.
Figure 49.1: Snapshots of an elastic square being gradually filled by incompressible fluid.
Bibliography
[1] F. D. Carter and A. J. Baker. Accuracy and stability of a finite element pseudo-compressibility cfd
algorithm for incompressible thermal flows. Num. Heat Transfer, Part B, 20:1–23, 1991.
Figure 49.2: Snapshots of an elastic cube being gradually filled by incompressible fluid.
[2] A. J. Chorin. A numerical method for solving incompressible viscous flow problems. J. Comput. Phys.,
135:118–125, 1997.
[3] L. Formaggia, J. F. Gerbeau, F. Nobile, and A. Quarteroni. Numerical treatment of defective boundary
conditions for the navier-stokes equations. EPFL-DMA Analyse et Analyse Numerique, 20, 2000.
[4] E. Järvinen, M. Lyly, J. Ruokolainen, and P. Råback. Three dimensional fluid-structure interaction
modeling of blood flow in elastic arteries. In Eccomas Computational Fluid Dynamics Conference,
September 2001.
[5] Kris Riemslagh, Jan Vierendeels, and Erik Dick. An efficient coupling procedure for flexible wall fluid-
sructure interaction. In Eccomas Congress on Comp. Meth. in Appl. Sci. and Eng, September 2000.
[6] S. E. Rogers, D. Kwak, and U. Kaul. On the accuracy of the pseudocompressibility method in solving
the incompressible navier-stokes equations. Appl. Math. Modelling, 11:35–44, 1987.
Fluidic Force
50.1 Introduction
This module is used to calculate the force that a fluid flow induces on a surface. The fluidic force can
be divided into two main components: force due to pressure and viscous drag force. The fluid can be
compressible or incompressible and also non-Newtonian with the same limitations that there are in the Elmer
Navier-Stokes Equation solver. The force calculation is based on a flow solution (velocity components and
pressure) which has to be present when calling the procedure. Also the torque with respect to a given point
can be requested.
50.2 Theory
The force due to fluid is calculated as a product of the stress tensor and normal vector integrated over the
surface Z
F~ = σ · ~n dS. (50.1)
S
The stress tensor is
2
σ = 2µε − µ(∇ · ~u)I − pI, (50.2)
3
where µ is the viscosity, ~u is the velocity, p is the pressure, I the unit tensor and ε the linearized strain rate
tensor, i.e.
1 ∂ui ∂uj
εij = + . (50.3)
2 ∂xj ∂xi
50.4 Keywords
Solver solver id
Equation String Fluidic Force
Procedure File "FluidicForce" "ForceCompute"
Calculate Viscous Force Logical [True]
Setting this flag to false disables the viscous drag force, and only the surface integral of pressure
is calculated.
Sum Forces Logical [False]
By default the solver calculates the fluidic force by boundaries. Setting this flag to True applies
summing of each individual boundary force in to a resultant force which is the only force vector
in output.
Shear Stress Output Logical [False]
Setting this flag to True activates writing shear stress values on disk.
Shear Stress Output File String [shearstress.dat]
Defines the name of the shear stress file.
Velocity Field Name String
The name of the velocity field variable. This keyword may be necessary if some other flow
solver than the built-in Navier-Stokes solver of Elmer is used. Normally this keyword should be
omitted.
Material mat id
Viscosity Real
Boundary Condition bc id
Electrostatic force
51.1 Introduction
This solver calculates the electrostatic force acting on a surface. The calculation is based on an electrostatic
potential which can be solved by the electrostatic solver (see Model 16 of this Manual).
51.2 Theory
The force is calculated by integrating the electrostatic Maxwell stress tensor [1] over the specified surface.
Using the stress tensor T the total force on the surface S can be expressed as
Z
F~ = ~
T · dS. (51.1)
S
The components of the Maxwell stress tensor for linear medium are
1 ~ ~
Tij = −Di Ej + δij D · E, (51.2)
2
~ and electric displacement field D
where electric field E ~ are obtained from the electric potential Φ
~ = −∇Φ,
E (51.3)
and
~ = −ε0 εr ∇Φ,
D (51.4)
where ε0 is the permittivity of vacuum and εr is the relative permittivity of the material, which can be a
tensor.
51.3 Keywords
Constants
Permittivity Of Vacuum Real [8.8542e-12]
Solver solver id
Material mat id
Relative Permittivity Real
Boundary Condition bc id
Bibliography
[1] J. Vanderlinde. Classical electromagnetic theory. John Wiley & Sons, 1993.
52.1 Introduction
This module is used to reduce and simplify the computation of a displacement solver when the problem
includes rigid blocks. In such a case, it is often difficult for iterative solvers to find a solution for the full
system, and direct solvers become obsolete when the system is large enough. The convergence and also the
speed of the solution can be substantially improved when the degrees of freedom corresponding to the nodes
belonging in the rigid blocks are reduced onto the 6 DOFs (3 in 2D) of the corresponding rigid body. In the
module, the reduction is achieved via a projection matrix.
Additionally, the routine automatically eliminates the degrees of freedom corresponding to the Dirichlet
boundary conditions. It is also possible to request the elastic regions to be extended into the rigid blocks.
There is also possibility to reorder the reduced matrix elements to decrease its bandwidth.
52.2 Theory
The module starts with normally constructed matrix equation for the unknown displacements x, Ax = b.
Let us assume that the nodes are ordered in such a way that the first n elements of the vectors correspond to
the elastic parts of the structure and the remaining m elements correspond to the rigid parts of the structure.
The goal is to reduce the (n + m) × (n + m) matrix A to a (n + αk) × (n + αk) matrix B, where k is 3
for 2D and 6 for 3D problems and α is the number of rigid blocks present. Reductions are made also for the
vectors so that finally the matrix equation reads Bu = f .
The relation between the unknowns is
x = P u, (52.1)
where the projection matrix P ties the nodes in the rigid bodies to the same displacements in coordinate
directions and the same rotations about the coordinate axis. The rotations are defined with a coordinate
system whose origin is at the center of each rigid body. For the right hand sides we can write
f = Qb, (52.2)
where the matrix Q sums the forces and torques present at the nodes in rigid bodies for a resultant force and
torque of the center point of the corresponding rigid body. In both mappings, the rotations are linearized so
the module is valid only for cases where the rotations are small.
B = QAP. (52.5)
Q = P T ≡ C, (52.6)
and
B = CAC T . (52.7)
The matrix C has a identity matrix block of size n × n which keeps the elastic nodes intact, and a projection
block of size αk × m.
The reduced order solution u is transformed back to the original nodes by the same mapping
x = C T u. (52.8)
52.4 Keywords
Body body id
Rigid Body Logical
Value True defines the rigid body.
Solver solver id
The module does not need a separate solver but a call in the stress analysis, or the elasticity solver in
the linear mode.
Equation String Stress Analysis
Variable String Displacement
Variable DOFs Integer
It is important to give the DOFs right, either 2 or 3 depending on the dimension.
52.5 Examples
90
80
70
Cpu time in seconds
60
50
40
30
20
10
0
0 0.5 1 1.5 2 2.5 3
Number of degrees of freedom 5
x 10
Figure 52.1: The cpu time required for the matrix reduction operations depends linearly on the degrees of
freedom in the system.
53.1 Introduction
The module includes auxiliary utilities for filtering time-series data. Supported filters include various aver-
aging possibilities and Fourier series, for example. The solver does not introduce any new physics. However,
it may be useful in analyzing time-dependent data to be used in conjunction with time-harmonic models, or
in studying phenomena with different timescales (turbulence).
53.2 Theory
Mean of a function
The solver is built so that an estimate for the filtered data may be obtained at all times i.e. the normalizing
is done after each timestep. As an example let’s consider taking a simple mean over a period of time. The
starting point is the time averaged mean,
Z T
1
< f >T = f (t) dt. (53.1)
T 0
Weighted mean
It’s also possible to take a weighted mean with a user defined function g(t) depending on time only. Then
similarly,
Tn−1 < f g >n−1 +fn gn dtn
< f g >n = . (53.5)
Tn−1 + dtn
Fourier series
Using the weighted mean as starting point its possible to present the solution in terms of sine and cosine
series. In order to obtain normalized Fourier series components the function g is internally replaced by sine
and cosine functions defined as 2 sin(2πkwt) and 2 cos(2πkwt), where k is the degree of the term, and w is
the user defined frequency. After each full cycle the inner product then includes the Fourier coefficients and
the transient solution may hence be approximated by
ms
X mc
X
f≈ sk sin(2πkwt) + ck cos(2πkwt), (53.6)
k=1 k=1
Continuous average
Sometimes it may be useful that the new solution is given a relatively higher weight than the old solution.
This is achieved by relaxing the weight (elapsed time) related to the old solution by
where τ is the time scale when decay to fraction 1/e is desired. If the decay time is short compared to the
overall simulation time this provides a continuous mean that represents only the recent results. The fraction
of the last timestep in solution will always be dt/τ .
Computing variances
It is not possible to compute the variance directly with one sweep as computing the variance from the
functional values requires the knowledge of the mean. However, computing the mean of the square of the
solution enables that the variance is computed a posteriori since the following holds for any field variable,
53.3 Keywords
Solver solver id
Procedure File "FilterTimeSeries" "FilterTimeSeries"
Variable i String
The names of the variables to be filtered. There can in principle be up to 99 variables. Note that
the keywords with the same i form a set which define one filtering. If the Variable is not
redefined the previously defined variable with a lower i is used.
Operator i String
Normally the variable is treated as its plain value. There are however different options for using
the field value in a modified manner. These include length (L2 norm), abs, and square.
Start Time i Real
The start time for performing the integration. Note that for Fourier series this is used to reset the
zero time i.e. t := t − t0 .
54.1 Introduction
This subroutine may be used fit data to a continuous field. In principle just a simple identity equation with
some diffusion for regularization is solved. The origin of the data could be from a particle trace of a Monte-
Carlo simulation, measurement data read from an external file, etc.
54.2 Theory
Galerkin method minimizes the L2 norm of the solution and is therefore a good choice also for problems
where a regular field must be fitted into data. Imagine a case where we have an initial field fˆ and want to a
field f on it. Then we need to solve an equation f = fˆ with the Galerkin method. Now if the initial data
is noisy the fitting should include some regularization. The natural way to introduce regularization in this
context is to add artificial diffusion such that we are really solving for
− ∇ · D∇f + f = fˆ (54.1)
Also the user may know the weight w that was accumulated when the data was generated.
The data may not always be accurate or even given. Therefore using the given data in all fields might not
be a good idea. We may introduce a masking field, say p ∈ [0, 1], that picks the values that are considered
as accurate. On the other hand diffusion, might not be needed for those points.
Adding these generalizations we obtain the following form
Z Z Z Z
∂f
(1 − p)D∇f · ∇ψ dΩ − D(1 − p) ψ dΓ + p w f ψ dΩ = p fˆψ dΩ + p F̂ . (54.4)
∂n
This formulation enables the use of various techniques for data fitting.
54.3 Keywords
Below are the dedicated keywords for the solver. In addition generic keywords such as many of those related
to Linear System solution methods may be used.
Solver solver id
Equation String [DataToFieldSolver]
The name of the equation.
Procedure File "DataToFieldSolver" "DataToFieldSolver"
The name of the procedure.
Variable String [FieldName]
The name of the resulting field.
Target Variable String
Name of the scalar field to be used as input data. This is either fˆ or F̂
Diffusion Coefficient Real
The value of the diffusion constant used in the regularization.
Normalize by Nodal Weight Logical
Normalize the particle properties with nodal weight i.e. the standard mass matrix. This would
be a good choice if the right-hand-side is a result of an integral i.e. F̂ .
Normalize by Given Weight Logical
Normalize the particle properties i.e. divide the trace with the corresponding weight. Basically
this corresponds to the integral over w. Here an integral data set is assumed such that it is
consistent with the given weight.
Weight Variable String
If there is a weight associated to the data the name of it should be given with this function.
Set Constant Weight Sum Logical
If the weights are provided by the user and this flag is set True then the given weights are
normalized so that their sum is always the same as the sum of nodal weights. The idea is that
the solution will be independent on the given level of the weight, and only depend on the relative
sizes.
Mask Variable T
he data points may selectively chosen to be considered. If a mask variable is given it may have
both lower and upper boundaries. Only if the mask variable is between these bounds will the
data be considered. Effectively p = 1 in the interval, and p = 0 outside the interval.
Max Mask Value Real
Maximum value for the mask interval. Default is +HUGE.
Min Mask Value Real
Minimum value for the mask interval. Default is -HUGE, except if the maximum interval is not
given either. Then the default is 0.
Mask Diffusion Logical
If the mask is true, should diffusion be neglected. Default is False.
Boundary Condition bc id
FieldName Real
The user may set Dirichlet conditions for the field to be fitted if they are known.
FieldName Continue Logical
Enforce boundary conditions with constant slope. The default boundary condition is otherwise
the natural boundary condition with zero gradient.
Projection to plane
55.1 Introduction
Sometimes the solution of a complex problem calls for a dimensional reduction of some field variables. A
possible scenario for using the solver is in extracting some useful information from DNS or LES type of
flow simulations. This module offers the subroutines needed in such a cases.
There are currently a serial and a parallel version of the subroutine which are both located in this module.
The reason for the fork is that the parallel version uses techniques that are not optimal in the serial problem.
Therefore the user should herself choose the correct version. Optimally these two approaches should of
course be fused.
55.2 Theory
In principle the dimensional reduction is performed taking on average of a 2D (or axisymmetric) nodal point
~r2D when it travels through the 3D mesh.
Z
1
f2D (~r2D ) = f (~r3D ) dS. (55.1)
S
In practice this is implemented with the following steps
1. Create a list of faces for the 3D mesh
2. Loop though each nodal point in the 2D mesh
(a) Loop through each face in the 3D mesh
i. Check if there is an intersection between the integration line and face
ii. If intersection found memorize the point of intersection
(b) Order the intersection points in the integration direction
(c) Take a weighted average over the ordered list, (fi , ri )
The algorithm is accurate for linear elements. For higher order elements it is suboptimal in accuracy. Also
in axisymmetric mapping the elements should be small enough so that the curvature of the line segment is
not significant. Near the origin there may be few hits and then the averaging is done by just taking a small
number of values around the center axis.
55.3 Keywords
Solver solver id
Equation ProjectToPlane
The arbitrary name of the equation.
Procedure File "ProjectToPlane" "ProjectToPlane"
or
Procedure File "ProjectToPlane" "ParallelProjectToPlane"
Convert From Equation Name String
The solver needs a 3D mesh which is associated determined by the association to the solver given
by this keyword.
Convert From Variable String
The variable to be converted.
Volume Permutation Integer
The algorithm is build so that integration direction is the second coordinate (y). This is typically
valid for axisymmetric cases, for example. If the integration should be performed with respect
to some other direction the volume coordinates may be permuted by this keyword.
Plane Permutation Integer
Permutation of the plane coordinates.
Rotate Plane Logical
Should rotation be performed.
Max Relative Radius Real
For the axisymmetric projection the outer radius may be difficult since the 3D mesh typically
may have faces that do not quite extend to the surface. This is a result of finite sized linear
elements. To ease this problem the user may give the maximum relative radius that is used when
trying to find the point of intersection.
Minimum Hits At Radius Integer
The number of hits needed for a accepted integration. The default is one.
Integration Points At Radius Integer
If no minimum number of hits is achieved then a few points around the axis are used to determine
the value. The default is two.
56.1 Introduction
For structured meshes some operations may be done much more effectively than for generic meshes. One
such operation is mapping some values within the mesh to the reduced dimensional surface of the mesh.
In practice this could mean, for example, mapping the values at the bottom of mesh to the top of mesh to
determine the difference in value. Or to map some isosurface values to the top of the mesh.
56.2 Theory
The algorithm used for the mapping has two sweeps. Assume that we would like to perform mapping
in direction ~ez . At the first sweep over all elements we would deduce pairwise information over nodes
on which nodes are in up and down directions from each other. Then using this directional information
recursively one can easily deduce which nodes are the top and bottom representatives of any node in the
mesh. With this information mapping information to top or bottom nodes, or to the whole mesh becomes
extremely cheap.
56.3 Keywords
Solver solver id
Equation String [StructuredProjectToPlane]
The name of the equation.
Procedure File "StructuredProjectToPlane" "StructuredProjectToPlane"
The name of the procedure.
Velocity Variable Name String
Name of the variable used to define the streamlines.
Active Coordinate Integer
The direction in which the structured mapping is performed i.e. 1, 2 or 3.
Project To Bottom Logical
Instead of projecting to the top of the active direction, project to the bottom.
57.1 Introduction
This solver is an auxiliary solver for optimization problems. As input it requires a cost function computed
with the previous parameter values, and as output it gives the new parameters for which the cost function will
be computed for. Typically the cost function depends on the solution of one or several differential equations.
Based on this solution a measure of goodness for the solution is computed.
The routine is still in its development phase but is provided as a skeleton that may be further developed.
57.2 Theory
The optimization routines must be slightly modified from their standard form since the solver is not in a
ruling position in respect to the simulation. Therefore its difficult to plug in existing optimization packages
to this solver.
Currently the solver includes some very basic optimization routines. Of these the Simplex algorithm
(Nelder-Mead) and the differential GA (Genetic algorithm) are the only ones that may be used for a number
of design variables.
For just one design variables there is the choice of simple scanning, bisection search and the secant
method. Secant method finds roots making it better suited for problems where the target is known i.e. design
problems.
57.3 Keywords
Simulation
Simulation Type String ”scanning”
The natural mode used for optimization problems is scanning. If the problem is really time-
dependent the current internal solution is not probably the optimal solution.
Timestep Intervals Integer
The maximum number of optimization rounds is in the case of scanning defined by the timestep
intervals.
Solver solver id
This shows just a couple of examples how the design parameters could be used in the simulation. The
variables may be referred in a similar manner as other global variables such as time or timestep size.
Body Force 1
Heat Source = Equals OptPar 1
End
Boundary Condition 1
Heat Flux = Equals OptPar 2
End
58.1 Introduction
This subroutine may be used to compute derived quantities and saving scalar values to external file. The
results are easily then utilized by MatLab, Excel or any other program that can read ASCII data. In addition
to the number values also an additional file with the suffix .name is saved. It tells what variables are at each
column.
58.2 Theory
The equations and algorithms needed for the computation of scalar values are relatively simple. Here some
of them are introduced.
When saving statistical information there are two possibilities. We may use normal number statistics
where each node is given an equal weight. Then, for example the mean becomes,
Pn
fi
< f >= i=1 . (58.1)
n
The other possibility is to treat the variable as a continuous function and compute the statistical values as
averages over the domain. Now the mean is
R
f dΩ
< f >= R . (58.2)
dΩ
In addition to the mean we may compute the mean deviation, < |f − < f > | >.and the variance δf =
p
< f 2 > − < f >2 .
It is possible to compute energy type of lumped quantities by integrating over the domain. The energy
of the field f resulting from a diffusion equation is
Z
1
Edif f = ∇f · c∇f dΩ, (58.3)
2 Ω
where c may a tensor or a scalar. Kinetic energy related to convection is of type
Z
1
Econ = c~v · ~v dΩ, (58.4)
2 Ω
Currently the code automatically detects the dimension of the given variable. If it is scalar f then ~v is
assumed to be the velocity computed by Navier-Stokes equation. If the given variable is vector then it is
used as the velocity field and f is not present. Here ~n is the surface normal.
Diffusive fluxes may be computed from
Z
Fdif f = c∇f · ~n dΓ, (58.7)
Γ
58.4 Keywords
Solver solver id
Procedure File "SaveData" "SaveScalars"
Filename String
Name of the file where results are to be saved. If no filename is given then the results will only
be echoed on output.
Output Directory String
Name of the directory where results are to be saved, relative to the case directory. By default the
results are saved in the case directory.
Scalars Prefix String
Save constants starting with this prefix. The default is res:.
Variable i String
The names of the variables to be saved. There can be up to 99 variables. In addition to field
variables there are some special variables. The scalar variables. e.g. Time, are saved as is.
There are also variables CPU Time and CPU Memory that may be used to save execution
details.
Target Variable i String
This is an optional keyword that for each entry computed by the subroutine may give an alter-
native name that is placed as a proper variable in the model. This variable may then be used
similarly to time in functional expressions. Note that if the operator creates several output val-
ues the numbering of this is not the same as that of Variables. So check the output file for
correct entries when in doubt.
square, and int variance the variance of the variable. The volume used by a given variable
is obtained by operator volume. If a name for the coefficient, is given for the operator, the
integral is taken over the coefficient. One can for example obtain the weight from a integral over
Density. Three different energy type of energy quantities may be computed by diffusive
energy, convective energy, potential energy, volume.
By default the statistical and integral operators are performed over the whole mesh. However,
the user may apply the operator only to some parts of the mesh that are related to the logical
entities of the sif file. Currently these entities are body, body force, and material. If the
user wants to select some of these parts then the standard operator should be preceded by the
name of the section. For example, there could be operators body max or body force int.
There are also a number of similar operators that only operate on the boundary. These are invoked
by boundary sum, boundary dofs, boundary mean, boundary max, boundary
min, boundary max abs, boundary min abs, area, boundary int, and boundary
int mean. Also boundary integrals are possible using operators diffusive flux, convective
flux, boundary int, boundary int mean and area. These require that in the bound-
ary conditions the active boundaries are defined. Also here there may be an optional coefficient.
Some operators do not work on the solution itself but use other info related to that. Operator
dofs simply returns the length of the variable under study. Operator norm returns the last com-
puted norm of the field variable, and operators nonlinear change and steady state
change return the last computed convergence measures at the nonlinear and steady state levels.
Operator nonlin iter returns the number of nonlinear iterations, while operators nonlin
converged and coupled converged which tell whether or not the simulation has con-
verged. Note that these operators most operate on the primary variable for which the matrix
equation is solved for.
Operator bounding box returns the minimum and maximum coordinate value of each coor-
dinate i.e. six values in 3D mesh.
Finally for parallel runs the operator partitions may be useful in creating parallel scaling
results in automated manner.
There is no upper bound to the number of operators or variables. If the variable is a vector the
statistics is performed on its length.
Coefficient i String
Even though only limited number of operators are given almost any energy or flux kind of quan-
tity may be computed since the coefficient c may be defined by the user. The idea is that the
same data that is already used as a material parameter can be simple referred to by its name. The
coefficient may be, Heat Conductivity, Permittivity, Density, for example. Usu-
ally the coefficient is the same that was used in computing the field variable under integration.
For the diffusive energy and diffusive flux the coefficient may even be a matrix.
This parameter is optional and the default is one.
Parallel Operator i String
Sometimes the default parallel reduction method is not the desired one. Therefore the user may
define the parallel reduction method by this keyword. The alternatives are min, max and sum.
Polyline Coordinates(n,DIM) Real
This keyword may be used to create line segments that are defined by points x1 , y1 , x2 , and y2 .
For each line different kinds of fluxes through the elements may be computed. This makes it
possible, for example, to check the mass flux even though no boundary has a priori been defined.
Save component results Logical
Save results arising from component sections.
Boundary Condition bc id
Save Scalars Logical
The flag activates the computation of boundary-related information. The results are treated inde-
pendently for each boundary. The keyword replaces the previously used Flux Integrate.
Also if Mask Name is given this arbitrary string may be used instead.
If the user only wants a basic functionality of SaveScalars it is possible to let the system create
automatically an instance simply by:
Simulation
Scalars File File
Name of the file where the results are saved.
scalars: Keyword Type
Any keyword with the suffix scalars: is passed to the solver instance without the suffix.
By default the solver is executed after saving. With the namespace it is possible to include all keywords
(with the keyword type given) also in the simulation section. At some point the Simulation section will
get crowded making it justified to create a separate solver instance.
58.5 Examples
In the following examples it is assumed that the SaveScalars solver gets the first free index.
Range of solution
The following example shows how to deduce after each converged timestep the minimum and maximum
values of temperature to an external file.
Solver 2
Exec Solver = After Timestep
Equation = SaveScalars
Procedure = "SaveData" "SaveScalars"
Filename = "temprange.dat"
Variable 1 = Temperature
Operator 1 = min
Operator 2 = max
Operator 3 = int mean
End
Solver 2
Exec Solver = After Timestep
Equation = SaveScalars
Procedure = "SaveData" "SaveScalars"
Filename = "forces.dat"
Boundary Condition 3
Name = no_slip
...
Save Scalars = Logical True
End
Benchmark information
The following example shows how benchmark information from the computation of some potential equation
is gathered to one file. Different runs will append the results to the same file and in parallel runs the degrees
of freedom, number of partitions and consumed cpu time will be automatically gathered.
Solver 3
Exec Solver = After all
Equation = SaveScalars
Procedure = "SaveData" "SaveScalars"
Filename = timing.dat
File Append = Logical True
Variable 1 = Potential
Operator 1 = dofs
Operator 2 = partitions
Operator 3 = cpu time
Parallel Reduce = Logical True
End
59.1 Introduction
The subroutine saves lines that pass through higher dimensional computational meshes. The data is saved
in simple matrix format thereby allowing the easy postprocessing of data by MatLab, Excel or any other
program that can read ASCII data. In addition to the number values also an additional file with the suffix
.name is saved. It tells what variables are at each column.
59.2 Theory
One mildly theoretical problem in saving data comes from the fact that the data should be saved in lines
that were not a priori defined. If there are relatively few points the dummy algorithm where each element
is checked for including the node may be used. For the lines, however, this algorithm might become quite
expensive as there may be many points that constitute the line and faster choices are needed.
Therefore we only look for intersections of element faces and the lines. Each element face is divided
into triangles. The triangle has points ~e1 , ~e2 and ~e3 . The line is drawn between points ~r1 and ~r2 . Therefore
the line goes through the point only if
which may be easily solved with standard methods linear algebra. Because the face element is a triangle
there is an additional condition that b + c ≤ 1.
59.3 Keywords
Solver solver id
node ordering does not work properly. However, if we cut the loop at one point, the resulting
connectivity enables us to create a continuous loop. So use this only when you know that your
line creates a full loop.
Parallel Reduce Logical
By default the output is written independently for each partition in parallel runs. By enabling
this, however, the information is reduced to just one file when using predefined lines. The data
is communicated to the partition that owns most data to start with and it does the writing to the
file.
Boundary Condition bc id
59.4 Examples
In the following examples it is assumed that the 1st solver is the primary solver and the SaveLine solver
gets index two.
The following example shows how to save a line that extends from point (0,0,0) to point (1,2,3) in 3D
mesh after the whole simulation has ended using 100 divisions for both line segments.
Solver 2
Exec Solver = After Simulation
Equation = SaveLine
Procedure = "SaveData" "SaveLine"
Filename = "line.dat"
Polyline Coordinates(2,3) = 0.0 0.0 0.0 1.0 2.0 3.0
Polyline Divisions(2) = 100 100
End
60.1 Introduction
These subroutines creates fields from material parameter entries or boundary conditions that normally cannot
accessed as a field, as they are expressions that are evaluated when needed. The SaveMaterials may be
used to create additional field variables from the material parameters. A similar procedure SaveBoundaryValues
stores parameters defined on boundaries as variables for the whole mesh. This can be of help if a boundary
condition that is not directly accessible from the variables (like a normal component of a vector field) should
be evaluated in the post-processing step.
60.2 Keywords
Keywords of subroutine SaveMaterials
Solver solver id
Procedure File "SaveData" "SaveMaterials"
Parameter i String
The user may choose a number of parameters (i=1,. . . ,99) which will be save as variables. This
may be particularly handy if one wants to visualize how the parameters depend on the position
over the domain. Values in bodies with the assigned material list not containing the keyword of
the parameter are set to zero by default.
Parameter i String
The user may choose a number of parameters (i=1,. . . ,99) which will be save as variables. These
parameters will then be stored as variables with the values assigned as they were found on the
specific boundary. Bulk values and values on boundaries with the parameter not being defined
are set to zero by default.
Body Force Parameters Integer
The user may also save parameters given in body force section by giving the number of these
parameters by this keyword. Note that the body force parameters must be first in the list followed
by the material parameters. The default is zero.
61.1 Introduction
This subroutine is intended for saving data in other than the native format of Elmer – ElmerPost. The reason
for using another postprocessing tool might be that some feature is missing in ElmerPost, or that the user is
more acquainted with some other visualization software. Currently supported formats include GiD, Gmsh,
VTK legacy, XML coded VTK file bearing the suffix VTU and Open DX.
The recommended 3rd party visualization tool of Elmer results is Paraview and the corresponding format
for it is the Vtu format. The old VTK format is not recommended.
61.2 Keywords
Solver solver id
Equation String "ResultOutput"
The name of the equation. This is actually not much needed since there are no degrees of freedom
associated with this solver.
Procedure File "ResultOutputSolve" "ResultOutputSolver"
The name of the file and subroutine.
Output File Name File
Specifies the name of the output file.
Output Format String
This keyword the output format of choice. The choices are gid, gsmh, vtk, vtu, and dx.
Gid Format Logical
Gmsh Format Logical
Vtk Format Logical
Vtu Format Logical
Dx Format Logical
The user may also use the above logical keywords to set which of the formats is saved. This
has more flexibility in that there may be several formats that are saved simultaneously where the
Output Format keyword may only be used to activate one solution type.
Geometry Id Integer
May be used to remap the default body index to a new value for VTU output.
Boundary Condition bc id
Geometry Id Integer
May be used to remap the default boundary condition index to a new value for VTU output.
If the user only wants a basic functionality of VtuOutputSolver it is possible to let the system create
automatically an instance of the solver simply by adding a Post File with suffix .vtu to the Simulation
section.
Simulation
Post File File [filename.vtu]
Name of the file where the unstructured XML based VTK results are to be saved.
vtu: Keyword Type
Any keyword with the suffix vtu: is passed to the solver instance without the suffix.
By default the solver is executed after saving. With the help of the namespace it is possible to include
any keyword (with the keyword type given) also in the Simulation section. At some point the section
will get crowded making it justified to create a separate solver instance.
61.3 Example
This example saves the results of a computation in binary unstructured VTK XML format following the
Output Intervals definition in the Simulation section. The variables to be saved are hand-selected.
Solver 3
Exec Solver = after saving
Equation = "result output"
Procedure = "ResultOutputSolve" "ResultOutputSolver"
Output File Name = "case"
! In the Vtu format all fields are saved if the user does not list them explicitly.
Scalar Field 1 = String Temperature
Scalar Field 2 = String Pressure
Vector Field 1 = String Velocity
End
62.1 Introduction
This subroutine is intended for saving data in a uniform grid. One possible use of the feature is to combine a
boundary representation and a glyph representation (velocity vectors) in the same visualization. This routine
would then save the data for the glyphs. The routine may also be used so that the resolution in two other
directions is set to a high value which will then effectively create uniform line plots.
The algorithm goes through all the elements and checks whether the element could include some of the
uniform grid nodes. If so then these are tested for. The algorithm should scale linearly with mesh size.
Optionally one may check for duplicates to eliminate the same nodes being repeatedly saved. Currently no
particular order is guaranteed for the nodes.
The routine works currently only in VTU, VTI and ASCII table formats, but other format may be possible
in the future.
62.2 Keywords
Solver solver id
Equation String "SaveGridData"
The name of the equation. This is actually not much needed since there are no degrees of freedom
associated with this solver.
Procedure File "SaveGridData" "SaveGridData"
The name of the file and subroutine.
Filename Prefix File
Specifies the name of the output file. A appropriate suffix is added to the given name.
Output Format String
This keyword the output format of choice. The choices are vtu, vti and table.
Vtu Format Logical
Vti Format Logical
Table Format Logical
The user may also use the above logical keywords to set which of the formats is saved. This
has more flexibility in that there may be several formats that are saved simultaneously where the
Output Format keyword may only be used to activate one solution type.
62.3 Example
The following example saves the results in the VTK XML image data format at the end of simulation. A
mesh parameter h = 0.1 is used for every direction and the lower left corner is taken as the base of the finite
uniform mesh.
Solver 5
Exec Solver = after all
Equation = SaveGrid
Procedure = "SaveGridData" "SaveGridData"
63.1 Introduction
This subroutine extract isosurfaces from 3D meshes or isolines from 2D meshes. The intended use of the
routine is in heavy simulations where the standard output could result to an I/O bottle-neck. If the desired
isosurface is known in advance then this can be used to reduce the amount of data to be written. The solver
does not itself write the data. It is expected that there is some external strategy for writing the data. It could,
for example, be the ResultOutputSolver for VTK XML output.
63.2 Keywords
Solver solver id
Equation String "Isosurface"
The name of the equation. This is actually not much needed since there are no degrees of freedom
associated with this solver.
Procedure File "Isosurface" "IsosurfaceSolver"
The name of the file and subroutine.
Output Directory File
Specifies the name of the output directory. Output file name will be determined in the normal
manner.
Isosurface Variable String
The name of the variable for which the isosurface is determined. This must be a scalar variable.
Isosurface Values Real
The isosurface values used to extract the surfaces. If this is a vector then a number of isosurfaces
will be defined.
Isosurface Values Real
The isosurface value used to extract the surfaces. For constant values this is the scalar variant
of the previous keyword. However, this may also have a functional dependency on some scalar
variable, such as time, for example.
Variable i String
Name of the variable to be outputted on the isosurface (or isoline), i=1, 2, 3, . . .
63.3 Example
This solver extracts the 1D isolines from 2D temperature field and stores them to a mesh called isosurf at
the three given isosurface values. If the original mesh would be 3D then the resulting isosurface mesh would
be 2D. Note that if saving of results is desired then this solver should be performed prior to the saving of
results.
Solver 8
Exec Solver = after all
Equation = "isoline"
Procedure = "Isosurface" "IsosurfaceSolver"
IsoSurface Variable = Temperature
IsoSurface Values(3) = 0.25 0.5 0.75
Variable 1 = Temperature
Variable 2 = stream
Variable 3 = vorticity
End
64.1 Introduction
These solver modules provides the possibility to transfer field values from Elmer into OpenFOAM and
back. The data transfer is done via file IO and has therefore some limitations regarding speed of operation.
However, the approach also has some flexibility since it does not set any additional constraints to how Elmer
and OpenFOAM have been compiled.
The solvers assume a working Elmer case and OpenFOAM case directory. The solvers assume that the
OpenFOAM directory 0 includes the cell centers computed with writeCellCenters in file C. For a
multiblock case the mesh directory will include subdirectories and then the cell centers should be available
at least in one subdirectory. Note that the Elmer field will only be mapped if the cell center file C is provided.
The Elmer2OpenFoamIO solver first reads the cell centers, then creates a temporal mesh structure from
them, and interpolates the desired field using the standard interpolation routines within Elmer. The interpo-
lation uses octree search tree and therefore it should be rather fast – in serial. The interpolated field is written
into the same directory where cell centers C were found. The format is a one that can be used to initialize
object from class volScalarField.
The coupling from OpenFOAM to Elmer is performed with the OpenFOAM2ElmerFit routine. It again
read the cells centers from files C. The solution with a given name is not fetched from directory 0 but rather
from the time step given by the user. The resulting values are not interpolated using the basis function since
there is no OpenFOAM mesh available at Elmer. Rather a procedure similar to DataToFieldSolver
is used. There diffusivity may be given as a regularization parameter. A good choice may be the physical
diffusivity related to the solver. I.e. if you’re reading in temperatures they may be regularized by heat
conductivity.
In case the performance of the routines is not satisfactory or one needs parallel operation then the MPI
coupler EOF library mainly written by Juris Vencels could be a better choice for the problem.
64.4 Example
This example is used to map the field joule heating from Elmer to the OpenFOAM initialization file
fieldSolidHS.dat to be used in temperature distribution computations.
Solver 2
Equation = ElmerToOpenFOAM
Procedure = "Elmer2OpenFoamIO" "Elmer2OpenFoamWrite"
Reading Data
65.1 Introduction
This subroutine can read results provided in simple Gmsh ASCII output format and use the results to initial-
ize Elmer fields. Gmsh format is handy as it is relatively simple and has supporting software that can deal
with it. Also the Gmsh result format includes both the mesh geometry, topology and results. Hence it can be
used to read old results and interpolate them into a new mesh
This solver is not intended to replace the fully fledged restart format of Elmer. However, this tool may be
nice if we need to interpolate results in a workflow in a flexible manner. Note that the ResultOutputSolver
includes also a Gmsh writer and may therefore be used in conjunction with this module in workflows coupled
via saving and reading files.
65.2 Keywords
Solver solver id
Equation String "GmshReader"
The name of the equation. This is actually not much needed since there are no degrees of freedom
associated with this solver.
Procedure File "GmshOutputReader" "GmshOutputReader"
The name of the file and subroutine.
Filename File
Filename to read the results from. This file should currently be in Gmsh 2.2. format ASCII file.
Align Coordinate Logical
When reading the mesh into ElmerSolver should we align the mesh with some coordinate direc-
tion. The possible values are 1, 2, 3 to align in maximum coordinate direction. If negative value
is used then the mesh will be aligned with the minimum coordinates.
Mask Name String
If we want to interpolate results only on part of the mesh we may use a mask. Only where the
mask is present interpolation will be performed. The possible sections where the mask should
exist are Body Force and Boundary Condition.
66.1 Introduction
This subroutine is intended for repeated loading of existing results during simulation. An example of a
typical application is to use previously computed fluid flow as a convection field for the transfer of a passive
scalar variable. The module is implemented as a dummy solver which is defined in the command file just as
the ’normal’ solvers.
This module offers extended features compared to the Restart File option in the Simulation
section. The module reads a new solution step from the solution file on each timestep, whereas the restart
file option reads only the initial state for a simulation.
The module reads in all the available variables from the solution file. The solution file should be in the
mesh directory. If the simulation takes more than a single steady state iteration per time step it is advisable
to use Exec Solver = Before Timestep for this module.
66.2 Keywords
Solver solver id
67.1 Introduction
This subroutine is intended for cases where the user wants to have run-time control over the solution. The
control is obtained by reloading the command file (.sif-file) during the solution. This is done with an addi-
tional solver that is called similarly as any other solver during the solution process.
The most likely usage of the solver is in cases where the user realizes during the solution process that
the some parameters were not optimally chosen. For example, the convergence criteria may have been set
too tight for optimal performance. Then the user may set looser criteria by editing the command file during
the computation. Once the new value is read the solver will apply the new criteria thereafter.
67.2 Limitations
The solver should not be used for things that need allocation. For example, the number of solvers or bound-
aries may not change. Also the computational mesh must remain the same.
67.3 Keywords
Solver solver id
68.1 Introduction
This solver provides the possibility to read in data in uniform grid into Elmer mesh. The supported format
includes currently only NetCDF.
Currently following features are supported:
• Bilinear (in 2D) or trilinear (in 3D) interpolation
• Possibility to have a multiplicator and offset in the target field
• Linear interpolation in time
• Multiple possibilities to define the time instant or index
The module requires the netcdf library. Because of this, it has been isolated from the main build system.
The source code for XdmfWriter can be found from the source tree in misc/netcdf2 and it should be
compiled by the user as follows:
elmerf90 -I$HDF5/include -L$HDF5/lib -o GridDataReader.so GridDataReader.f90 -lnetcdff -lnetcdf
The environment variable $NETCDF defines the installation directory for the NetCDF-library.
68.2 Theory
In structured data the finding of grid cell where a certain node belongs to is trivial. Assume that the grid is
defined by coordinates ai and bi so that any coordinate xi is presented by
xi = ai ni + bi (68.1)
where ni ∈ [1, Ni ] and i ∈ [1, DIM]. Now the finite element node with coordinate x̂i may be interpolated
using the cell with indexes mi = ceiling((x̂i − bi )/ai ) and mi + 1 using linear interpolation with weighing
factor qi = mi − (x̂i − bi )/ai .
fˆ = qi fmi + (1 − qi )fmi +1 . (68.2)
This generalizes into multiple dimensions using recursion. For example, in 2D the bilinear interpolation
reads
fˆ(x1 , x2 ) = q1 q2 f11 + (1 − q1 )q2 f21 + q1 (1 − q2 )f12 + (1 − q1 )(1 − q2 )f22 . (68.3)
The current implementation provides bilinear and trilinear interpolation in space, and linear interpolation in
time.
The algorithmic complexity of the reader and interpolation routine is linear in time. However, the current
implementation assumes that each partition do their own interpolation routines which means that there may
be a large number of files open in parallel runs introducing potential bottle-necks.
68.3 Keywords
Solver solver id
Equation String [GridDataReader]
The name of the equation.
Procedure File "GridDataReader" "GridDataReader"
The name of the procedure.
Filename File
Full aame of the target file (with the suffix).
X Name String
Name of the 1st coordinate.
Y Name String
Name of the 2nd coordinate.
Z Name String
Name of the 3rd coordinate.
Time Name String
Name of the time coordinate.
X Epsilon A
ccuracy of the 1st coordinate assumed in interpolation. Default is machine epsilon.
Y Epsilon A
ccuracy of the 2nd coordinate assumed in interpolation. Default is X Epsilon.
Z Epsilon A
ccuracy of the 3rd coordinate assumed in interpolation. Default is X Epsilon.
Time Epsilon A
ccuracy of time assumed in interpolation. Default is machine epsilon.
Time Point Real
Value of time used in this calling. If this is not found the Elmer time will be used.
Time Offset Real
Offset used to add to the Elmer time.
Time Multiplier Real
Coefficient used to multiply the Elmer time.
Is Time Index Real
If this flag is turned on then the time instance given with the previous keywords will be under-
stood as being the index of time in the NetCDF file (starting from 1) rather than actual time.
Is Time Counter Logical
If this flag is turned on, the time index of the NetCDF file will be increased by one each time the
routine is called. This makes it ideal for looping over each timestep.
Coordinate Transformation String
Optional coordinate transformation that is applied on the Elmer coordinate prior to finding its
value on the grid.
Enable Scaling Logical
If this flag is turned on the bounding box of Elmer mesh will be made compatible with that of
the grid.
Variable i String
Variable of the NetCDF file. There is no upper limit to the number of variables.
Target Variable i String
Optional name for the target variable. If this is not given then the Variable i value will be
used for the FE variable as well. If the target variable is not present it will be created the first
time it is needed. Also, if different variables that follow each other have the same target variable
these will be summed up. With the multiplication and offset features this makes it possible to
derive new variables as a linear combination of any fields given in the NetCDF file.
Interpolation Offset Real
A constant that will be added to the value of the interpolated field. If there are many fields with
different offsets use Interpolation Offset i instead.
Interpolation Multiplier Real
A constant that will be used to multiply the interpolated field. The default value is one. If there
are many fields with different offsets use Interpolation Multiplier i instead.
69.1 Introduction
This module can be used to solve a set of conservation equations that govern lithium-ion battery cycling
behaviour. The macroscopic model follows multiphase porous electrode and concentrated solutions theories
that describe the transfer of mass and charge between solid electrodes and liquid electrolyte [2] [3].
The current implementation provides perhaps a starting point for continued work. There is still some
challenges in the robustness of the solver. It has been verified against literature but the number of coupled
system iterations needed seems often excessive.
If you’re interested in continuing the work, please contact the authors for more details. In the partial
differential equations we have followed closely the references while the numerical solution is very different,
probably both in good and bad.
69.2 Theory
For the equations we mainly follow the Master’s Thesis of A. Borakhadikar [1]. For other relevant references
see, for example, [3].
The model for the battery includes two coupled equations for both electrostatic potential and concentra-
tion. These are closed by chemical kinetics described by the Butler-Volmer equation. The special feature
of the equations is that the solid phase concentration is to be solved within each solid phase particle. The
multiscale nature is captured by solving the 1D diffusion equation in spherical coordinates in each node of
the distributed system. The other equations follow pretty much standard procedures.
Conservation of species in solid phase is written as
∂cs Ds ∂ ∂cs
− 2 r2 = 0, (69.1)
∂t r ∂r ∂r
where cs (~x, r, t) is the concentration, Ds is solid phase Li diffusion coefficient. At the boundary of each
sphere the flux condition is given by
∂cs 1
Ds r=r0
=− JLi , (69.2)
∂r as F
where as = 3εs /Rs is the active interfacial surface area, F is Faraday constant and Rs is the radius of the
solid particle. JLi is the lithium ion flux between the solid and electrolyte phases. The coupling to other
fields takes place only at the surface where we define C(~x, t) = cs (~x, r0 , t).
Conservation of species in electrolyte phase leads to a diffusion equation
∂ 1 − t+
(εe Ce ) − ∇ · Deef f ∇Ce = JLi , (69.3)
∂t F
where t+ is transference number of lithium ions and Deef f is effective electrolyte phase Li+ diffusion coeffi-
cient. The effective diffusivity depends on the electrode porosity which is described by Bruggeman relation
Deef f = De εpe where εe is electrolyte phase volume fraction. At the current collectors, no-flux boundary
conditions are imposed,
∂Ce ∂Ce
= = 0. (69.4)
∂x x=0 ∂x x=L
Conservation of charge in solid phase defines the solid phase potential,
where the σ ef f refers to effective conductivity of an electrode. It is defined as σ ef f = σεs where εs is active
particle volume fraction. The boundary condition for solid phase potential at the current collectors reads as
ef f ∂ϕs ef f ∂ϕs I
− σ− x=0
= σ+ x=L
= , (69.6)
∂x ∂x A
where I(t) is applied current and A is the plate area of an electrode. The boundary conditions at the
electrode-electrolyte interface are defined as follows,
∂ϕs ∂ϕs
x=LN eg
= x=LN eg +LSep
= 0. (69.7)
∂x ∂x
Conservation of charge in electrolyte phase defines the potential in the electrolyte phase,
where κef f is the effective ionic conductivity, which is calculated by using Bruggeman’s relation κef f =
κεpe . The electrolyte phase ionic conductivity κ can respectively be defined as
Ce 1.4
κ = 15.8e−4 Ce exp(0.85( ) ). (69.9)
1000
The second term of the equation gives rise to numerical challenges since it may be difficult to evaluate
accurately. Here κef
d
f
is effective diffusional conductivity which is evaluated as
2RT κef f
κef
d
f
= (t+ − 1), (69.10)
F
where R is gas constant and T is ambient temperature. At the current collectors, the boundary conditions
are defined as
∂ϕe ∂ϕe
= = 0. (69.11)
∂x x=0 ∂x x=L
The system of equation is closed by Butler-Volmer kinetic equation
αa F αc F
JLi = as i0 exp η − exp η . (69.12)
RT RT
where k0 is kinetic rate constant, Cs,max is the maximum solid phase concentration of an electrode while
the αa and αc are anodic and cathodic charge coefficients. Overpotential η may be written as
η = ϕs − ϕe − U, (69.14)
where empirical expressions are used for the equilibrium potential U . The equilibrium potential is a material
property and for the particular material used in this module, the potential for negative electrode it given by
1 1 3
Un (x) =8.0029 + 5.0647 x − 12.578 x 2 − 8.6322e-4 + 2.1765e-5 x 2
x
− 0.46016 exp(15(0.06 − x)) − 0.55364 exp(−2.4326(x − 0.92)) (69.15)
where x = Cs /Cs,max .
69.2.1 Postprocessing
Once the conservation equations have been solved, the solution can be transformed into more readable
format. The cell voltage of the battery can be expressed as
Rf
Vcell = φs (t, L) − φs (t, 0) − I(t), (69.17)
A
where φs (t, L) and φs (t, 0) are solid phase potentials at cathode and anode current collectors, Rf is resis-
tance of current collectors and A is electrode plate area.
The battery state of charge can be estimated in variety of ways. In this module, the SOC is evaluated by
default as
C
( Cs,surf
s,max
) − x0%
SOC(t) = , (69.18)
x100% − x0%
where x0% and x100% are stoichiometric coefficients at 0% and 100% state of charge. Alternatively, the state
of charge can also be calculated by Coulomb counting which goes as follows
Z t
1
SOC(t) = SOC(0) − I(t)dt, (69.19)
Qrated 0
where Qrated is rated cell capacity. The cell capacity during cycling is given by
Z t
Qcell = I(t)dt. (69.20)
0
69.3 Keywords
The module includes five different solvers. Usually order of solvers is arbitrary. However, here a specific
order is given that has been found to be most successful.
Solver 1
Poisson equation for the solid phase potential, ϕs . The equation is solved in both anode and cathode.
Equation String SolidPhasePot
The name of the equation.
Procedure File "BatterySolver" "SolidPhasePot"
The name of the solver file and subroutine.
The following keywords are used by 1D submeshes located in the nodes of the main mesh.
1D Mesh Create Logical [True]
Creates 1D submesh if set to True.
1D Element Order Integer
The order of elements in 1D submesh can be specified here.
1D Number Of Elements Integer
The number of elements in 1D submesh can be specified here.
1D Mesh Ratio Real
Here the ratio of 1st and last element in the 1D submesh can be specified.
1D Mesh Length Real
This keywords is used to specify the length of the 1D submesh.
1D Active Direction Integer
Specifies the direction of the 1D submesh. This is set to 1 by default.
1D Body Id Integer
This keyword is used to set the body id.
Solver 4
Diffusion equation for the electrolyte concentration, Ce . It is solved in the whole domain.
Equation String ElectrolyteCons
The name of the equation.
Procedure File "BatterySolver" "ElectrolyteCons"
The name of the solver file and subroutine.
Variable String [Ce]
This is the default name for Ce assumed by other solvers.
Linearize Flux Logical [False]
Linearize the flux JLi with respect to ce .
Number of Passive Visits Integer
Specifies the number of solid phase iterations for only electrostatic solver.
Use Solid Phase Relaxation Logical [True]
If set to True, the solver inherits relaxation factor from solid phase concentration solver.
Fixed Overpotential Logical [True]
The strategy when the overpotential in Butler-Volmer equation is computed affects the con-
vergence. It may sometimes be advantageous to skip the re-computation overpotential. This
keyword may also be applied for any of the solvers.
Skip Butler Volmer Logical [True]
The strategy when Butler-Volmer equation is computed affects the convergence. It may some-
times be advantageous to skip the re-computation.
Use Effective Diffusion Logical [False]
It can sometimes be advantageous to use non-effective diffusion where the electrolyte volume
fraction is not taken into account. This is due to numerical difficulties risen from the second term
in solver 2.
Calculate Cs sensitivity Logical [False]
If set to True, the solver calculates Cs sensitivity for solver 4.
Solver 5
Solver for performing postprocessing information after convergence is obtained.
Equation String BatteryPost
The name of the postprocessing equation.
Procedure File "BatterySolver" "BatteryPost"
The name of the solver file and subroutine.
Study Jli Balance Logical
This keyword is used to toggle on an option to save error values in the Cs solution to study JL i
balance.
Soc Model String
State of charge model to be used. The Default model evaluates SOC in terms of the solid phase
concentration while taking the stoichiometric coefficients into account. Selecting Simplified,
on the other hand, makes the model to ignore them. Alternatively, selecting Coulomb evaluates
SOC using Coulomb counting method.
SOC on surface Logical
If set to True, the solver uses the surface values for SOC instead of true average.
Initial SOC Real
The initial SOC can be specified here if the simulation starts in conditions other than fully
charged or discharged.
Cutoff Voltage Real
This keyword is used to set a lower-limit for the cell voltage at which the battery cell is considered
fully discharged.
Stoichiometric Limit Real
This keyword is used to set a lower-limit for solid phase concentration after which a warning is
issued.
Applied Current Real
This keyword is used to define the value of applied current that is only used in postprocessing.
Here, negative sign refers to charge current and vice versa.
Cell Capacity Real
This keyword is used to define value of rated capacity of the battery cell, which is used in
evaluation of state of charge by Coulomb counting method.
Use Average Cell Voltage Logical
We may either use extremum potential to compute the cell voltage or take average over anode
and cathode. The first one is the default.
Calculate Charges Logical
Toggle to calculate addition information about the charges and potentials of anode, cathode and
electrolyte.
Constants
Material mat id
Materials parameters for anode and cathode.
Anode Logical
If material is anode set True, otherwise False.
Cathode Logical
If material is cathode set True, otherwise False (default).
Particle Radius Real
This keyword is used to define the radius of the solid phase particles, Rs .
Active Particle Volume Fraction Real
This keyword is used to define the volume fraction of particles in an electrode, εs .
Maximum solid phase concentration Real
This keyword is used to define the value of maximum lithium concentration in an electrode,
Cs,max .
Kinetic Constant Real
This keyword is used to define the value of kinetic rate constant, k0 .
Anodic charge transfer coefficient Real
This keyword is used to define the anodic charge transfer coefficient, αa .
Cathodic charge transfer coefficient Real
This keyword is used to define the cathodic charge transfer coefficient, αc .
Solid Phase Diffusion Coefficient Real
The value of lithium diffusivity in solid phase, Ds .
Solid Phase Electrical Conductivity Real
This keyword is used to define the electrical conductivity of an electrode in solid phase, σ.
Stoichiometry at Full Charge Real
Stoichiometry when the battery cell is considered fully charged, x100% .
Stoichiometry at Nill Charge Real
Stoichiometry when the battery cell is considered fully discharged, x0% .
Material parameters for electrolyte.
Initial Condition ic id
Initial conditions are used to set the state of the battery at start of the simulation. We may initialize
Cs , Ce , ϕs , ϕe and JLi .
Cs Real
Ce Real
Phis Real
Phie Real
Jli Real
Boundary Condition bc id
Current Density Real
Neumann boundary condition for the current density. During discharge, current density has a
positive sign at anode current collector and negative sign at cathode current collector.
Bibliography
[1] Ashwin S. Borakhadikar. One dimensional computer modeling of a lithium-ion battery. Master’s thesis,
Wright State University, 2017.
[2] M Doyle, T F Fuller, and J Newman. Modeling of galvanostatic charge and discharge of the
lithium/polymer/insertion cell. Journal of the Electrochemical Society; (United States), 140:6, 6 1993.
[3] K. A. Smith, C. D. Rahn, and C.-Y. Wang. Control oriented 1D electrochemical model of lithium ion
battery. Energy Conversion and Management, 48:2565–2578, 2007.
70.1 Introduction
Richards equation is a non-linear partial differential equation that represents the movement of fluids through
porous media.
The current implementation of the Richards equation uses normal Lagrange elements and therefore the
conservation of flux cannot be guaranteed. Dense meshes are required if the variations in the permeability
are high.
This version should not yet be considered a production version. However, it provides a suitable starting
case for more serious testing and further development.
70.2 Theory
The transient, incompressible, variably saturated, isotropic flow of water in non-swelling porous media is
expressed by the combination of Darcy’s law and the continuity equation, i.e. Richards equation. The
modern form of Darcy’s law can be written as
~q = −kw ∇H (70.1)
where ~q is the unit flux, or Darcy velocity (L/T), kw is the fluid hydraulic conductivity of water (L/T), and H
is the total head (L). Since the velocity component of total head can be treated as negligible in porous media,
and air pressure can be considered as constant, total head can be expressed as H = p + z where p is pressure
(F/L2 ) (note that p = −ψ = ua − uw ), ψ is matric suction (F/L2 ), uw is the water pressure in pores (F/L2 ),
ua is the air pressure in pores (F/L2 ), z is elevation from a datum (depth coordinate of the geometry).
The continuity equation is expressed as
∂θ
= −∇ · ~q + Sw , (70.2)
∂t
where θ is the volumetric water content (L/L), t is time (T), Sw is a source/sink term (L/T). Richards equation
may now be written as,
∂θ
= −∇ · (kw ∇H) + Sw , (70.3)
∂t
since θ = f (ψ) and kw = f (ψ) the latter equation can be expressed using a pressure form,
∂θ ∂ψ
= −∇ · (kw ∇H) + Sw , (70.4)
∂ψ ∂t
Or, developing total head,
∂θ ∂ψ
= −∇ · (kw ∇(−ψ + z)) + Sw , (70.5)
∂ψ ∂t
The volumetric water content and the hydraulic conductivity are non-linear functions related to pres-
sure head. Both are commonly expressed by van Genuchten (1980)’s equations. Volumetric water content
function yields (
−θr
θs + (1+αθns vG mvG , if ψ > 0
θ(ψ) = vG ) (70.6)
θs , if ψ < 0.
And the hydraulic conductivity function is
nvG mvG n m 2
(
kw,sat (1−(αvG ψ) (1+αnvG(1+(αvG ψ) vG ) vG )
−mvG /2 , if ψ > 0
kw (ψ) = vG ) (70.7)
kw,sat , if ψ < 0.
where θ is the volumetric water content (L/L), θr is the residual volumetric water content (L/L), θs is the sat-
urated volumetric water content, equal to the porosity (L/L), αvG , nvG , mvG are fitting parameters without
any units.
∂H
θψ + ∇ · (kw ∇H) = Sw . (70.8)
∂t
From the total head the matrix suction will be automatically computed, ψ = z − H. This makes it possible
to have material laws that depend on it.
For transient problems the first term requires special attention. In the current version the sensitivity of θ
to ψ is computed from
(
θ(ψ(ti ))−θ(ψ(ti−1 ))
ψ(ti )−ψ(ti−1 ) if |ψ(ti ) − ψ(ti−1 )| >
θψ = θ(ψ(ti ))−θ(ψ(ti )−)
(70.9)
otherwise.
This way the effective sensitivity is smeared over the whole timestep, dt = ti − ti−1 .
The values of the material parameters in the Richards equation vary a great deal depending on the sat-
uration level and type of medium. Therefore it is important to evaluate the water content and hydraulic
conductivity at the Gaussian integration points using the relevant formulas, rather than computing them at
nodal points and thereafter evaluating the values at the Gaussian integration points using a weighted sum
over the nodal values.
70.4 Keywords
The module includes two different solvers. RichardsSolver solves the primary differential equation
while RichardsFlux solves the resulting flux from the computed solution. The second solver only makes
sense when the pressure field has already been computed with the first one. The second solver uses the same
material parameters as the first one.
Body Force bf id
Richards Source Real
The source term, Sw , of the equation.
Boundary Condition bc id
Solver solver id
Equation String RichardsPostprocess
A describing name for the solver. This can be changes as long as it is used consistently.
Procedure File "RichardsSolver" "RichardsPostprocess"
Name of the solver subroutine.
Target Variable String
The name of the total head field solved by the Richards equation. The default name is Total
head.
71.1 Introduction
Arterial elasticity is a fundamental determinant of blood flow dynamics in arteries, such as the aorta and
its daughter vessel, that face the largest displacements and which takes care of the cushioning of the stroke
volume. Simulation of such a phenomenon requires simultaneous solving of the equations governing both
the fluid flow and wall elasticity. To be able to perform accurate fluid-structure interaction (FSI) simulations,
only a segment of the circulatory system can be studied at a time. For these artificially truncated segments,
which are naturally unbounded domains and in interaction with the rest of the circulation domain, one should
construct in the numerical models boundary conditions which do not exhibit any unphysical behaviour,
which operates transparently, and are also capable to transport a sufficient amount of information over the
boundary.
A natural boundary condition at the outlet of a numerical FSI flow model of an artery is not a proper
choice because it does not exhibit enough correct physiological behavior of the flow, and from the point of
view of numerical approximation, it causes non-physiological reflections of the wave at the boundary. If
measured data of both the pressure (or velocity) and the wall displacement at the outlet boundary are not
available, the only way to get the outlet boundary of a higher order, 2D or 3D model sufficiently specified is
to combine the model with some lower order model, such as a 1D or lumped model.
In order to get the outlet of the arterial FSI model to behave transparently in such cases when only
forward travelling waves are considered, a simple characteristic equation of the of the one dimensional FSI
model can be combined with the higher order model.
71.2 Theory
The conservation equations for a flow in an elastic artery in one dimension may be expressed as
∂A ∂Q
∂t + ∂x = 0
(71.1)
2
∂Q ∂ Q A ∂p
+ ∂x ( A )+ = 0,
∂t ρ ∂x
where Q is the volume flow, A the cross section area of the artery, p is the pressure and x is the axial
coordinate [3]. In order to get the system (71.1) close, an equation relating the area A to the pressure
p = p(A) is derived applying the theory of thin shell structures. Assuming a cylindrical shell, and neglecting
the rotation on the shell cut plane, and the movements of the structure in the axial and circumferential
directions, as well as applying the Kirchhoff-Love assumption, the energy balance equations is reduced to
E h3 Eh 1
dR (4) + dR = p, (71.2)
12(1 − ν 2 ) (1 − ν 2 ) Rm 2
where Rm is the radius to the midplane of the wall, E, ν and dR are the Young modulus, the Poisson
ratio and the radial displacement of wall, respectively. Assuming that the first term on the left side in the
equation (71.2) is much smaller than the second term, we can give the pressure-area relation in the form
√
√ p πhE
p = pext + β( A − A0 ), β= . (71.3)
(1 − ν 2 )A0
The pressure is scaled to be equal to external pressure pext with corresponding reference artery cross
sections area A0 .
The equations (71.1) and (71.3) form a closed system for the simulations of flow in an elastic tubes. The
equations may be written in conservative form which is strictly hyperbolic with two distinctqreal eigenvalues
p √
λ1,2 = ū ± c, where ū = Q/A is the average axial velocity, c = (A/ρf )(∂p/∂A) = β A/(2ρf ) is
the speed of sound, and ρf is the density of blood. The system can be further decomposed into a set of the
equations for the characteristic variables Wi , which are the components of the vector W = T −1 U ( ∂W ∂U =
T −1 ) , U = [A, Q]T [2]. These equations are
∂Wi ∂Wi
+ λi = 0, (71.4)
∂t ∂x
and the characteristic variables are
s
Q 2 √
W1,2 = ±2 + β A.
A ρf
When considering a pulse propagation in a straight, infinitely long homogeneous conduit, without any
bifurcations or other objects which might cause reflections of the pulse, i.e. any backward travelling waves
does not exists, the computations can be done using only the first of equations in (71.4), i.e.
∂W1 (U ) ∂W1 (U )
+ λ1 (U ) = 0.
∂t ∂x
This equation is solved in this Elmer outlet bondary condition for arterial flow simulations solver. The
connection of the one dimensional model to the test models at the their outlets is done applying the following
coupling [1]
dR− = dR+
σ − = p+
W1 = g1 (A− , Q− , p− ),
where dR and σ are radial displacement of the artery wall and fluid traction, respectively. The superscript
’–’ denotes the values in the higher order models, and superscript ’+’ to the values in the 1D model.
71.3 Keywords
Keywords of FlowSolve
Initial Condition ic id
For making the initial guess for the characteristic variable W1
Material mat id
Material properties for the one dimensional section.
Density Real
Density of blood
Artery Wall Youngs Modulus Real
Young’s modulus of the artery
Artery Radius Real
Radius of the artery to the midplane of the artery wall
Artery Wall Thickness Real
Wall thickness of the artery
Artery Poisson Ratio Real
Poisson ratio of the artery
Solver solver id
Keywords for the one dimensional solver. Note that all the keywords related to linear solver (starting
with Linear System) may be used in this solver as well. They are defined elsewhere.
Equation String [Artery Outlet Solver]
Variable [Wnodal]
The variable which is solved
Variable DOFs [1]
The diameter of the artery in the appropriate direction at the outlet of the higher order model is set to
correspond the value given by the outlet boundary condition solver. The subroutines OutletdX and
OutletdY are located in the module ArteryOutlet
Displacement i Variable Time
Real Procedure "./ArteryOutlet" "OutletdX"
This is the inlet boundary of the one dimensional section which is coupled with both, the fluid and the
solid outlet boundary of the higher order model
Fluid Coupling With Boundary Integer
Structure Coupling With Boundary Integer
Figure 71.1: An example of the model results: pressure pulse propagation in a 2D axisymmetric model
combined with an 1D model.
Bibliography
[1] L. Formaggia, J.F. Gerbeau, F. Nobile, and A. Quarteroni. Numerical treatment of defective boundary
conditions for the navier-stokes equations. SIAM J. Numer. Anal, 40:376–401, 2002.
[2] E. Godlewski and P.-A. Raviart. Numerical Approximation of Hyperbolic Systems of Concervation Laws.
Springer, 1996.
[3] T. J. R. Hughes and J. Lubliner. On the one-dimensional theory of blood flow in the large vessels.
Mathematical Biosciences, 19:161–170, 1973.
72.1 Introduction
This module solves the Laplace equation by boundary element method (BEM), where the differential equa-
tion is transformed to integral equation along the boundaries. On the boundaries either potential or normal
flux may be defined. A source term may be included (Poisson equation), but the source term remains a
volume integral.
This is an old module which has limited use since the BEM matrix is assembled in full. This means
that the memory consumption and speed of solution grow rather unfavorably with problem size. Efficient
BEM solvers never create the full matrix but use iterative multilevel methods instead, such as the multi-
pole expansion. Also, the solver only works in serial so parallel computing is not available to resolve the
bottleneck.
72.2 Theory
The Poisson equation is mathematically described as
− ∆Φ − f = 0, in Ω, (72.1)
− ∆w = δr (r0 ), (72.5)
so that Z
− ∆wΦ dΩ = Φ(r), (72.6)
Ω
The weight w chosen this way is the Green’s function for the Laplace operator, i.e.
log(r − r0 ) 1
w(r, r0 ) = in 2d , w(r, r0 ) = in 3d . (72.7)
2π 4π(r − r0 )
Finally we add the source term, and we have the equation
Z Z Z
∂Φ ∂w
Φ(r) − w dΓ + Φ dΓ − f w dΩ = 0. (72.8)
Γ ∂n Γ ∂n Ω
Only the source term is now integrated over the volume. This equation may now be discretized by standard
methods.
Φ = ΦΓ on Γ, (72.9)
or normal flux
∂Φ
− = g on Γ. (72.10)
∂n
72.3 Keywords
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere. Note also that the BEM discretization results to a full
linear system in contrast to FEM discretizations and the ILU preconditioning settings are not available.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
PoissonBEM Logical
if set to True, solve the Poisson equation, the name of this parameter must match the Equation
setting in the Solver section.
If the mesh has any volume elements with a body id that corresponds to a body where to the Poisson
equation is activated, the value of the potential is computed for these elements as a postprocessing
step. Note that the computation of potential is not a trivial task, so large number of volume elements
may result to long execution time.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. The one related to Poisson
(BEM) equation are
Body Id Integer
Give body identification number for this boundary, used to reference body definitions in .sif
file. This parameter must be set so that the ElmerSolver knows at which boundaries to solve the
corresponding equation.
Potential Real
Known potential value at boundary.
Flux Real
Known normal flux at boundary.
Normal Target Body Integer
The direction of boundary normals are important for the success of the computation. They
should point consistently outward from the boundaries. This is accomplished either if the mesh
generator automatically orients the boundary elements consistently, or including in the mesh
the parent (volume) elements of the boundaries and using this keyword. The value -1 of this
parameter points to the side where there are no volume elements. If the parameter gets the value
of the body id of the volume elements, the normal will point to that direction.
Body Force bf id
The source term for the Poisson equation may be given here. The volume integral is computed on a
body with a volume mesh and the PoissonBEM equation set to true.
Source Real
The source term for the Poisson equation.
73.1 Introduction
This module solves the Helmholtz equation by boundary element method (BEM), where the differential
equation is transformed to integral equation along the boundaries. On the boundaries either pressure or
normal flux may be defined.
This is an old module which has limited use since the BEM matrix is assembled in full. This means
that the memory consumption and speed of solution grow rather unfavorably with problem size. Efficient
BEM solvers never create the full matrix but use iterative multilevel methods instead, such as the multi-
pole expansion. Also, the solver only works in serial so parallel computing is not available to resolve the
bottleneck.
73.2 Theory
The Helmholtz equation is mathematically described as
(k 2 + ∆)Φ = 0, in Ω. (73.1)
In BEM we transform this equation to integral equation over boundaries. We start by multiplying the
equation by a weight function and integrating over the volume, and integrating by parts
Z Z Z Z
2 2 ∂Φ
(k + ∆Φ)w dΩ = k wΦdΩ − ∇Φ · ∇w dΩ + w dΓ. (73.2)
Ω Ω Ω Γ ∂n
so that Z
(k 2 + ∆)wΦ dΩ = Φ(r), (73.6)
Ω
The weight w chosen this way is the Green’s function for the Helmholtz operator, i.e.
1 1 0
w(r, r0 ) =
H0 (k(r − r0 )) in 2d , w(r, r0 ) = exp−ik(r−r ) in 3d , (73.7)
i4 4π
where H0 is the Hankel function.
Finally we have the equation
Z Z
∂Φ ∂w
Φ(r) − w dΓ + Φ dΓ = 0. (73.8)
Γ ∂n Γ ∂n
Φ = ΦΓ on Γ, (73.9)
or normal flux
∂Φ
− = g on Γ. (73.10)
∂n
73.3 Keywords
Simulation
Angular Frequency Real
Give the value of the angular frequency for the simulation.
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere. Note also that the BEM discretization results to a full
linear system in contrast to FEM discretizations and the ILU preconditioning settings are not available.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
HelmholtzBEM Logical
if set to True, solve the Helmholtz equation, the name of this parameter must match the
Equation setting in the Solver section.
If the mesh has any volume elements with a body id that corresponds to a body where to the Helmholtz
equation is activated, the value of the pressure is computed for these elements as a postprocessing step.
Note that the computation of potential is not a trivial task, so large number of volume elements may
result to long execution time.
Boundary Condition bc id
The boundary condition section holds the parameter values for various boundary condition types.
Dirichlet boundary conditions may be set for all the primary field variables. The one related to
Helmholtz (BEM) equation are
Body Id Integer
Give body identification number for this boundary, used to reference body definitions in .sif
file. This parameter must be set so that the ElmerSolver knows at which boundaries to solve the
corresponding equation.
Pressure 1 Real
Known real part of pressure at boundary.
Pressure 2 Real
Known imaginary part of pressure at boundary.
Flux 1 Real
Known real part of normal flux at boundary.
Flux 2 Real
Known real part of normal flux at boundary.
Normal Target Body Integer
The direction of boundary normals are important for the success of the computation. They
should point consistently outward from the boundaries. This is accomplished either if the mesh
generator automatically orients the boundary elements consistently, or including in the mesh
the parent (volume) elements of the boundaries and using this keyword. The value -1 of this
parameter points to the side where there are no volume elements. If the parameter gets the value
of the body id of the volume elements, the normal will point to that direction.
74.1 Introduction
Note: This solver is obsolete!
Maxwell’s equations may generally be expressed by employing a scalar potential and a vector potential.
The magnetic flux density is then the curl of the vector potential. In some cases the effect of the scalar
potential vanishes and the system is fully described by the vector potential. These cases include magne-
tostatics problems where time-independent magnetic fields may be created by electromagnets with given
current distributions or permanent ferromagnets. The solver considered here allows the first option, with
non-homogeneous and non-linear magnetic materials.
The scalar potential may also be ignored in two-dimensional magnetoquasistatic cases when the current
density acts in a direction orthogonal to the plane considered. Then eddy current effects relating to a sinu-
soidal evolution of the current density may also be considered at low frequencies. If there are no conductors
in the system, this approximation reduces to the equations of magnetostatics.
This solver was historically developed for the axially symmetric cases and it should only be used in
those. For handling problems in orthogonal Cartesian coordinates, see the modules MagnetoDynamics
and MagnetoDynamics2D for 3-D and 2-D versions, respectively.
74.2 Theory
When there are no hard ferromagnets, a magnetostatics problem may be expressed using the magnetic vector
~ that gives the magnetic flux density as B
potential A ~ = ∇ × A.
~ It is obtained directly using the Ampère’s
law, so that
1 ~
∇× ∇ × A = ~. (74.1)
µ
Here µ is the magnetic permeability of the material. The equation may be non-linear through the magnetic
permeability curve of a ferromagnetic material. The solver discussed is intended for handling the axially
symmetric version of (74.1).
The axially symmetric version of (74.1) may also employed to handle magnetoquasistatic problems
where the effect of the displacement current is ignored. If there are conductors in the system, the current
Aφ = Abφ . (74.3)
In practice, when the Dirichlet condition is used, one usually takes Abφ = 0. If a Dirichlet condition is not
specified, the homogeneous natural boundary condition is used.
74.3 Keywords
Simulation
Frequency Real
Frequency f if harmonic simulation is used.
Angular Frequency Real
Angular frequency ω = 2πf if harmonic simulation is used, alternative to the previous one.
Constants
Permeability of Vacuum Real [4π10−7 ]
Solver solver id
Note that all the keywords related to linear solver (starting with Linear System) may be used in
this solver as well. They are defined elsewhere.
||Akφ − Ak−1 k
φ || < ||Aφ ||,
where λ is the factor given with this keyword. The default value for the relaxation factor is unity.
Equation eq id
The equation section is used to define a set of equations for a body or set of bodies:
Static Magnetic Field Logical
If set to True, solve the magnetostatics equation.
Body Force bf id
The body force section may be used to give additional force terms for the equations.
Current Density Real
Specifies the azimuthal component of the current density. It may be a positive or negative con-
stant, or a function of a given variable.
Current Phase Angle Real
Specifies the phase angle of the current density in degrees. The default phase angle is zero.
Applies only to the time-harmonic case.
Joule Heat Logical
If this flag is active, the heat equation will automatically include the computed Joule heating as
a heat source. Then it is assumed that Joule heating field φ is named Joule field. If there is
no heat equation, this flag has no effect.
Initial Condition ic id
The initial condition section may be used to set initial values for the field variables. The following
variable is active:
Aphi Real
The azimuthal component of the magnetic vector potential.
Material mat id
The material section is used to give the material parameter values. Material parameter available for
the magnetostatics equation are.
Linear Constraints
75.1 Introduction
This subroutine allows user to solve problems with linear constraints. Here constraints are forced with
Lagrange multipliers. This method, however, does not always lead to a well-posed problem. Conditions
that ensure a (unique) solution are excluded here, but the conditions are found in many books (check for
example [1]).
75.2 Theory
The problem at hand is
min xT Ax − xT f (75.1)
x
Let’s assume that we can solve this. Now we also want that the solution solves the system Bx = g. This
gives constraints to our solution. The rank of B should be less or equal to the rank of A. Loosely speaking,
the number of rows in B should be less or equal to the number of rows in A. The method of Lagrange
multipliers fixes these two equations together and gives a new functional to minimize.
A BT
x f
= (75.3)
B 0 λ g
Symmetry of A is not always needed, but then more powerful methods have to be used to get to the above
system.
75.3 Limitations
• General usage of the subroutine
This subroutine can not be used by just adding keywords to solver input file. You must somehow
create the constraint matrix and then call for SolveWithLinearRestriction in your own subroutine or
function. The reader is encouraged to check for details in ElmerTutorials.
• EMatrix-field
The EMatrix-field of the solved system matrix is used passing constraint matrix to SolveWithLinear-
Restriction. This will be a problem if some other function or subroutine tries to use the EMatrix-field.
EMatrix-field of the constraint-matrix is internally used by SolveWithLinearRestriction and should
therefore be left alone.
• Exported Multipliers
The length of the vector that holds the multipliers is limited to be a multiply of the number of nodes
in mesh. This means that the vector usually has extra entries. These entries are set to zero. This leads
to problems in extracting the correct values from the result file. Also post processing with ElmerPost
is at least tricky.
75.4 Keywords
Solver solver-id
Export Lagrange Multiplier Logical
If the multiplier has some physical meaning, you can save it to result file and to post file. This
feature has certain drawbacks, check subsection Limitations. Default is False.
Lagrange Multiplier Name String
The name you want to call the exported multipliers. This keyword has no meaning if the previous
keyword is set to False. Default name is LagrangeMultiplier.
Bibliography
[1] V. Girault and P.A. Raviart. Finite element methods for Navier-Stokes equations. Springer-Verlag, New
York, Berlin, Heidelberg, 1986.
76.1 Introduction
This is an instructional text for using Elmer solvers I created for DFT calculations during the year 2006 while
preparing my Master’s Thesis [7]. These Solvers are rather experimental and I would not recommend their
use for highly complicated problems. Nevertheless they provide nice backbone for creating own DFT-solvers
with finite element method.
76.2 Theory
In DFT, Kohn-Sham equations [1, 2] play central role. They are set of highly nonlinear equations which
define uniquely the exact ground state charge density. From charge density the total energy of the system in
ground state can be calculated, which is unfortunately not implemented in present code.
The Kohn-Sham equations have a form
− 12 ∆ + VEXT (r) + VC [ρ(r)] + VXC [ρ(r)] ψk (r) = εk ψk (r)
PN (76.1)
2
ρ(r) = k=1 |ψk (r)| ,
where KS-orbitals ψk (r) are normalized, ψk (r)2 dr = 1, for eack k = 1, 2, . . . , N . VEXT is the exter-
R
nal potential caused by the nuclei, VC is the non-interacting Coulomb potential and VXC is the exchange
correlation potential that includes all the complicated many body effects, at least approximates. Nice expla-
nation from the widely used Local Density Approximation can be found from [3]. Nonlinearity occurs in
eigenvalue problem, where the operator depends on the solution of the eigen problem.
Self-Consistent iteration
The equations (76.1) are solved with self-consistent iteration (fixed point iteration). In this iteration Coulomb
and external potentials are solved from Poisson equation. The iteration steps are as follows:
1. Begin with previous or initial guess for charge density ρj
2. Solve new electric potential from Poisson equation,
M
X
− ∆V j+1 (r) = 1 j
4π ρ (r) − Zi δ(r − r i ) , (76.2)
i=1
j+1 j+1
where VXC is calculated via some function W from point values of charge density ρj . VXC (r) =
j
W (ρ (r))).
4. Sum new charge density,
N
X
ρj+1 (r) = wk ψk (r)2 , (76.4)
k=1
where the weight coefficients wk depend on the numbers of electrons in orbitals. Extensive overview
of calculation of molecular orbitals can be found from [4, 5].
The point load at the nuclei location requires, that exactly at each nuclei there has to be a node in the
mesh. For the functionality of the solvers no other requirements exists for the mesh or domain.
Unfortunately convergence of this iteration procedure is not guaranteed. For simple atoms (Z = 1,2,3,4)
code converges within any tolerance limits but for more complicated molecules or atoms usually not. Sensi-
ble tolerances were found to between 10−6 or 10−4 .
Boundary Conditions
In theory the zero level of the potential can be set arbitrarily and often in practice one uses condition V (r) →
0, when |r| → ∞. Of course in real calculations the domain Ω is finite and we set, V (r) = 0 if r ∈ ∂Ω. One
also assumes Ω to be large enough, so that charge density vanishes on the boundary, ρ(r) = 0 if r ∈ ∂Ω, so
we set ψk (r) = 0 if r ∈ ∂Ω.
In Kohn-Sham -equations in order to obtain positive definite coefficient matrix on the left hand side of
eigenvalue problem (76.1), one sets V (r) → C, when |r| → ∞. The constant C has to be large enough, so
the eigenvalues are shifted positive. But too large value slows the convergence of the eigenvalue solver.
76.3 Keywords
From the structure of the self-consistent iteration it was natural to divide the solution procedure for three
solvers, Poisson solver, eigensolver and charge density summation. For each solver some keywords to
control the solution procedure were added.
Poisson Solver
Poisson Solver demands knowledge about the locations of the nuclei and their atomic numbers. There has to
be nodes in the mesh at the nuclei locations, or else error will occur. Following example demonstrates how
nuclei of the water molecule with two atoms of atomic numbers Z = 1 (Hydrogen) and single with Z = 8
(Oxygen) are set to the coordinates (0.0, 0.0, 0.0) (Oxygen) and (−1.43, 1.11, 0.0) and (1.43, 1.11, 0.0)
(Hydrogens). The rows beginning with ! are comments.
!
! NOFnuclei is the number of nuclei in the structure.
!
NOFnuclei = Integer 3
!
! NucleiTable is an array of the form
The self-consistent iteration requires heavy (under) relaxation to avoid divergence. Relaxation means
linear mixing of present solution with previous one(s). It is possible to use Guaranteed Reduction Pulay -
method [6, 7] where the mixing constants are calculated every time as a solution of a minimization problem,
it’s sensible to begin GR Pulay after some steps of linear mixing.
In following example the exponential relaxation scheme is changed to GR Pulay after 5 steps or if the
mixing parameter exceeds value 0.5 . Use of constant mixing parameter instead of increasing one can be
easily done by commenting out the first four uncommented lines and removing the comment sign ! from
following two lines.
!
! Select the relaxation method used, possibilities are
! constant mixing parameter a(k) = A or varying parameter
! with scheme a(k) = C + 1- A * Exp( B * k )
!
Eigenproblem Solver
Eigenproblem solver demands knowledge about the type of exchange correlation approximation used. Namely
the expression of W in third self-consistent iteration step. In module xc.f90 there are several different for-
mulae for LDA approximations. Some of them include spin directions and are to be used with different
solver composition where KS-orbitals for up- and down-spins are calculated separately.
!
! Choose the type of the XC Potential, possible choises are:
! "None"
! "Perdew-Zunger"
! "Von Barth-Hedin"
! "Gunnarsson-Lundqvist"
! "Perdew-Wang"
Weights of the Eigen States table has to be size (N, 1). Naturally N has to be equal or less
for the number of eigenstates to be solved in eigenvalue solver.
Bibliography
[1] P. Hohenberg, W Kohn Inhomogeneous Electron Gas Physical Review, Volume 136, Number 3B, 9
November 1964
[2] W. Kohn, L. J. Sham, Self-Consistent Equations Including Exchange and Correlation Effects Physical
Review, Volume 140, Number 4A, 15 November 1965
[3] M. P. Das, Density Functional Theory: Many-Body Effects Without Tears Proceedings of the Miniwork-
shop on "Methods of Electronic Structure Calculations", ICTP, Trieste, Italy 10 August - 4 September
1992
[4] Peter Atkins, Ronald Frieman, Molecular Quantum Mechanics Oxford University Press Inc., Fourth
edition 2005
[5] Andrew R. Leach, Molecular Modelling, Pearson Education Limited, Second edition 2001
[6] D. R. Bowler, M. J. Gillan, An efficient and robust technique for achieving self consistency in electronic
structure calculations Chemical Physics Letters 325 sivut 473-476 (2000)
[7] O. Mali, Kohn-Sham -yhtälöiden ratkaiseminen elementtimenetelmällä,
Diplomityö, 19. syyskuuta 2006
77.1 Introduction
This subroutine is intended for saving parallel results in Xdmf/HDF5 format. The advantages of the Xdmf/HDF5-
format over the native parallel ep-format are the following:
• All results are stored in only two files (results.xmf and results.h5)
• The results are stored in a binary format with reduced storage requirements
• The results can be visualized on the fly during the solution
The result files written by XdmfWriter can be opened and visualized e.g. with Paraview.
At the moment, the module is available for the parallel version of Elmer only. Because of this, it has
been isolated from the main build system. The source code for XdmfWriter can be found from the source
tree in misc/xdmf and it should be compiled by the user as follows:
elmerf90 -I$HDF5/include -L$HDF5/lib -o XdmfWriter XdmfWriter.f90 -lhdf5_fortran -lhdf5
The environment variable $HDF5 defines the installation directory for the HDF5-library.
77.2 Keywords
Solver solver id
Equation String "Xdmf"
The name of the equation.
Procedure File "XdmfWriter" "XdmfWriter"
The name of the file and subroutine.
Base File Name String
Specifies the base file name of the output files. The default is results.
Single Precision Logical
This keyword specifies the output precision (4 byte single precision floating point numbers vs. 8
byte double precision floating point numbers). The default is false.
The following keywords define the scalar and vector fields to be saved:
77.3 Example
The following SIF-block saves results in Xdmf/HDF5-format for the Navier-Stokes equations:
Solver 1
Equation = String "Xdmf"
Procedure = File "XdmfWriter" "XdmfWriter"
Base File Name = String "MyResults"
Single Precision = Logical True
Scalar Field 1 = String "Pressure"
Vector Field 1 = String "Velocity"
End
Wall Law, 28
Wall Particle Bounciness, 204
Wall Particle Collision, 205
Wall Particle Radius, 204
Wall Particle Spring, 204
Water Content, 311
Wave Flux 1,2, 86
Wave Impedance 1,2, 86
WaveFunctionSolver, 329
WaveSolver, 97
Weight Variable, 259
WhitneyAVHarmonicSolver, 111
WhitneyAVSolver, 111
Wnodal, 315
X Epsilon, 297
X Name, 297
XdmfWriter, 333
Y Epsilon, 297
Y Name, 297
Yasuda Exponent, 27
Youngs Modulus, 51, 58, 68, 75, 79, 214, 217