Script API
This is the API definition of quanscient python module.
Functions
abs
This returns an expression that is the absolute value of the input expression.
Example
absZ
This returns an expression that is the magnitude of the Z = V/I complex impedance.
See Also
acos
This returns an expression that is the or of input. The output expression is in radians
.
Example
See Also
sin()
, cos()
, tan()
, asin()
, atan()
adapt
This function is used to perform a h/p/hp adaptation according to the defined h/p/hp adaptivity settings. To define the
h-adaptivity use function mesh.setadaptivity()
. To define a p-adaptivity for a field use function field.setorder()
.
The function returns True if the mesh or any field order was changed by the adaption and returns False if no changes were made.
Example
See Also
mesh.setadaptivity()
, field.setorder()
, alladapt()
alladapt
This is a collective MPI operation and hence must be called by all ranks. It replaces the adapt()
function in the DDM
framework. This function is used to perform a h/p/hp adaptation according to the defined h/p/hp adaptivity settings. To define the
h-adaptivity use function mesh.setadaptivity()
. To define a p-adaptivity for a field use function field.setorder()
.
Example
See Also
allcomputeradiationpattern
allcomputesparameters
This function extracts the S-parameters corresponding to the physical regions portphysregs
from the solution list sols
.
The parameters sources
and modeprojects
should contain what was used as drivesignal
and lumpfield
with modedrive function.
The function returns two lists that contain the real and imaginary parts of the S-parameters in row-major order (), respectively.
For the definition of S-parameters, we assume that the input signal at port is a complex number times the reference mode of port . If port is driven, is the driving signal used for feeding; otherwise . The output signal at port is a complex number times the reference mode of port . The S-parameter is defined such that the equation holds when port is driven and the others are not.
Example
See Also
alleigenport()
, modedrive()
, formulation.allsolve()
, formulation.lump()
, printsparameters()
alleigenport
This function computes the eigenmodes of a waveguide whose cross section is the given physical region portphysreg
.
The material parameters , , and are required as input arguments; these can be anisotropic, and both real and imaginary parts should be given.
The surface normal portnormal
is assumed to point in the direction of propagation.
The boundary condition (PEC) and the approximation order is extracted from the input field E
.
For each found mode, the function returns the real and imaginary parts of the transverse and longitudal components of the fields and and the propagation constant as a list of expressions. The returned modes are scaled such that the power into the waveguide,
equals one watt; integrationorder
determines the order of the integration rule used to compute this integral.
By default, the function throws an error if material parameters are anisotropic in the direction of propagation.
This is because the computed modes can not be used with modedrive function in that case.
To compute the modes anyway, the error check can be disabled by setting errorifzanisotropic = false
.
Example
See Also
modedrive()
, rectangularport()
allintegrate
This integrates the expression expr
over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
.
Example
See Also
allinterpolate
This interpolates the value of the expression expr
at points whose x,y,z coordinates are provided in the
xyzcoords
argument.
The flattened interpolated field values are returned if the point was found in the elements of the
physical region physreg
.
If a requested interpolation point cannot be found (because it is outside of physreg
or because the interpolation algorithm fails to converge, as can happen on curved 3D elements) then an
error occurs.
Example
See Also
alllineinterpolate()
, allintegrate()
, allprobe(),
alllaplace
alllineinterpolate
This function interpolates the expression expr
at a series of points along a straight line inside a physreg
. The line for
interpolation is defined by a starting and an end point whose [x,y,z] coordinates are provided in the firstcoords
and lastcoords
arguments.
The numsamples
argument determines the number of sample points considered along the straight line.
If a requested interpolation point along the line cannot be found (because it is outside of physreg
or because the interpolation algorithm fails to converge, as can happen on curved 3D elements) then an
error occurs.
This method in combination with setoutputvalue()
is used to make line plots in post-processing.
Example
See Also
allinterpolate()
, allintegrate()
, allprobe()
allmax
This returns the maximum value of the expression expr
obtained over the geometric region physreg
by splitting all
elements refinement
times in each direction. Increasing the refinement will thus lead to a more accurate maximum value,
but at an increased computational cost. The maximum value is exact when the refinement nodes added to the elements correspond
to the position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum
is always exact to machine precision.
Example
See Also
allmeasuredistance
This returns a relative L2 norm according to the below formula:
Example
allmin
This returns the minimum value of the expression expr
obtained over the geometric region physreg
by splitting all
elements refinement
times in each direction. Increasing the refinement will thus lead to a more accurate minimum value,
but at an increased computational cost. The minimum value is exact when the refinement nodes added to the elements correspond
to the position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum
is always exact to machine precision.
Example
See Also
allpartition
This is a collective MPI operation and hence must be called by all ranks. This function partitions the requested mesh into a number of parts equal to the number of ranks. All parts are saved to disk and the part file name for each rank is returned. The GMSH API must be available to partition into more than one part. A physical region containing the global skin can be created with the last argument.
This function will be deprecated. Use mesh.partition()
instead.
Example
allprobe
This functions returns the value of a scalar expression expr
at the point region physreg
.
Example
allsolve
This is a collective MPI operation and hence must be called by all ranks. It solves across all the ranks a nonlinear problem with a fixed-point iteration.
Example
See Also
solve()
, formulation.solve()
, formulation.allsolve()
alltimeinterpolate
allwriteradiationpattern
andpositive
This returns an expression whose value is 1 for all evaluation points where the value of all the input expressions is larger or equal to zero. Otherwise, its value is -1.
Example
See Also
argZ
This returns an expression that is the phase of the Z = V/I complex impedance.
See Also
array1x1
This defines a vector or matrix operation of size . The array is populated in a row-major way.
array1x2
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array1x3
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array2x1
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array2x2
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array2x3
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array3x1
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array3x2
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
array3x3
This defines a vector or matrix operation of size . The array is populated in a row-major way.
Example
asin
This returns an expression that is the or of input. The output expression is in radians
.
Example
See Also
sin()
, cos()
, tan()
, acos()
, atan()
atan
This returns an expression that is the or of input. The output expression is in radians
.
Example
See Also
sin()
, cos()
, tan()
, asin()
, acos()
bode
This function returns the magnitudes (unit: dB) and angles (unit: degrees) of the given complex numbers.
Example
cn
This function takes as an argument the fundamental frequency multiplier. It is a shortform for .
Example
See Also
comp
This returns the selected component of a column vector expression. For a column vector expression, selectedcomp
is 0 for
the first, 1 for the second component and 2 for the third component respectively. For a matrix expression, the whole corresponding
row is returned in the form of an expression. Thus, if selectedcomp
, for example is 5, then an expression containing the entries of the
fifth row of the matrix is returned.
Example
See Also
complexdivision
Complexdivision computes the quotient a / b
of two complex-valued scalar expressions a
and b
, which are presented as lists of length two (containing the real and imaginary parts).
Example
complexinverse
Complexinverse computes the inverse 1 / a
of a complex-valued scalar expression a
, which is presented as a list of length two (containing the real and imaginary parts).
Example
complexproduct
Complexproduct computes the product a * b
of two complex-valued expressions a
and b
, which are presented as lists of length two (containing the real and imaginary parts).
Example
compx
This returns the first or x
component of a column vector expression. For a matrix expression, an expression containing the entries
of the first row of the matrix is returned. This is equivalent to setting selectedcomp=0
in comp()
.
Example
See Also
compy
This returns the second or y
component of a column vector expression. For a matrix expression, an expression containing the entries
of the second row of the matrix is returned. This is equivalent to setting selectedcomp=1
in comp()
.
Example
See Also
compz
This returns the third or z
component of a column vector expression. For a matrix expression, an expression containing the entries
of the third row of the matrix is returned. This is equivalent to setting selectedcomp=2
in comp()
.
Example
See Also
continuitycondition
This returns the formulation terms required to enforce field continuity.
Examples
Example 1: continuitycondition(gamma1:int, gamma2:int. u1:field, u2:field, errorifnotfound:bool=True, lagmultorder:int=0)
This returns the formulation terms required to enforce between boundary region and (with
, meshes can be non-matching). In case is larger than () the boolean flag errorifnotfound
must be set to false.
Example 2: continuitycondition(gamma:int, gamma2:int, u1:field, u2:field, rotcent:List[double], rotangz:double, angzmod:double, factor:double, lagmultorder:int=0)
This returns the formulation terms required to enforce field continuity across an degrees slice of a rotor-stator interface where the rotor geometry is rotated by around the axis with rotation center at . This situation arises for example in electric motor simulations when (anti)periodicity can be considered and thus only a slice of the entire 360 degrees needs to be simulated. Use a factor of - for antiperiodicity. Boundary is the rotor-stator interface on the (non-moving) stator side while the boundary is the interface on the rotor side. In the unrotated position the bottom boundary of the stator and rotor slice must be aligned with the axis.
The condition is based on a Lagrange multiplier of the same type and the same harmonic content as the field and . The mortar finite element method is used to link the unknown field on and so that there is no restriction on the mesh used for both regions.
See Also
periodicitycondition()
, symmetrycondition()
cos
This returns an expression that is the of input. The input expression is in radians
.
Example
See Also
sin()
, tan()
, asin()
, acos()
, atan()
countphysicalram
crossproduct
This computes the cross-product of two vector expressions. The returned expression is a vector.
Example
curl
This computes the curl of a vector expression. The returned expression is a vector.
Example
See Also
d
This functions approximates the derivative of an expression when its variable is moved by a delta.
Example
dbtoneper
This converts the expression toconvert
from a units to .
Example
determinant
This returns the determinant of a square matrix.
Example
See Also
detjac
This returns the determinant of the Jacobian matrix.
Example
See Also
div
This computes the divergence of a vector expression. The returned expression is a scalar.
Example
See Also
dof
This declares an unknown field (dof \ for degree of freedom). The dofs are defined only on the region physreg
which when
not provided is set to the element integration region.
Examples
Example 1: dof(input:expression)
Example 2: dof(input:expression, physreg:int)
See Also
doubledotproduct
This computes the double-dot product of two matrix expressions. The returned expression is a scalar.
Example
dt
This returns the first-order time derivative expression.
Examples
Example 1: dt(input:expression)
Example 2: dt(input:expression, initdt:double, initdtdt)
This gives the transient approximation of the first-order time derivative of a space-independent expression. The
initial values must be provided when using generalized alpha (genalpha
) and are ignored otherwise.
See Also
dtdt
This returns the second-order time derivative expression.
Examples
Example 1: dtdt(input:expression)
Example 2: dtdt(input:expression, initdt:double, initdtdt:double)
This gives the transient approximation of the second-order time derivative of a space-independent expression. The
initial values must be provided when using generalized alpha (genalpha
) and are ignored otherwise.
See Also
dtdtdt
This returns the third-order time derivative expression.
Example
See Also
dtdtdtdt
This returns the fourth-order time derivative expression.
Example
See Also
dx
This returns the space derivative expression.
Example
See Also
dy
This returns the space derivative expression.
Example
See Also
dz
This returns the space derivative expression.
Example
See Also
elasticwavespeed
elementwiseproduct
This computes the element-wise product of two matrix expressions a
and b
. The returned expression has the same size as the two input expressions.
Example
emwavespeed
entry
This gets the (row
, col
) entry in the input
vector or matrix expression.
Example
exp
This returns an exponential function of base :
Example
See Also
eye
This returns a size
x size
identity matrix.
Example
fieldorder
This returns an expression whose value is the interpolation order on each element for the provided input
field. The value is a
constant on each element. When the argument alpha
is set, the value returned is the lowest order required to include
alpha
percentage of the total shape function coefficient weight. An additional optional argument absthres
can be set to provide a
minimum total weight below which the lowest possible field order is returned.
Example
getZ
getc0
getcirculationports
getcirculationsources
getdimension
This returns the x, y and z mesh dimensions.
Example
getepsilon0
This returns the value of vacuum permittivity .
Example
getextrusiondata
This gives the relative depth in the extruded layer, the extrusion normal and tangents and . This is useful when creating Perfectly Matched Layers (PMLs).
Example
We use the disk.msh
for the example here.
See Also
getharmonic
This returns a single harmonic from a multi-harmonic expression. Set a positive last argument to use an FFT to compute the harmonic. The returned expression is on harmonic 1.
Example
getmu0
This returns the value of vacuum permeability .
Example
getpi
This returns value of .
Example
getrandom
This returns a random value uniformly distributed between 0.0 and 1.0.
Example
getrank
This returns the rank of the current process.
Example
See Also
count
getsstkomegamodelconstants
getsubversion
gettime
This gets the value of the time variable t.
Example
See Also
gettotalforce
This returns the components of the total magnetostatic/electrostatic force acting on a given region. In the axisymmetric case zero and components are returned and the component includes a factor to provide the force acting on the corresponding 3D shape. Units are β per unit depthβ in 2D and in 3D and 2D axisymmetry.
Examples
Example 1: gettotalforce(physreg:int, EorH:expression, epsilonormu:expression, extraintegrationorder:int=0)
Example 2: gettotalforce(physreg:int, meshdeform:expression, EorH:expression, epsilonormu:expression, extraintegrationorder:int=0)
This is similar to the above function but the total force is computed on the mesh deformed by the field u
.
See Also
getturbulentpropertiessstkomegamodel
getversion
getversionname
getx
This returns the coordinate.
Example
An expression for distance can be calculated as follows:
See Also
gety
This returns the coordinate.
Example
In CFD applications, a parabolic inlet velocity profile can be prescribed as follows:
See Also
getz
This returns the coordinate.
Example
An expression for distance can be calculated as follows:
See Also
grad
For a scalar input expression, this is mathematically treated as the gradient of a scalar () and the output is a column vector with one entry per space derivative. For a vector input expression, this is mathematically treated as the gradient of a vector () and the output has one row per component of the input and one column per space derivative.
Example
See Also
greenlagrangestrain
This defines the (nonlinear) Green-Lagrange strains in Voigt form . The input can either be the displacement field or its gradient.
Example
See Also
grouptimesteps
This writes a .pvd ParaView file to group a set of .vtu files that are time solutions at the time values provided in
timevals
.
Examples
Example 1: grouptimesteps(filename::str, filestogroup:List[str], timevals:List[double])
Example 2: grouptimesteps(filename::str, fielprefix:str, firstint:int, timevals:List[double])
This is similar to the previous function except that the full list of file names to group does not have to be provided. The file names are constructed from the file prefix with an appended integer starting from βfirstintβ by steps of 1. The filenames are ended with .vtu.
harm
ifpositive
This returns a conditional expression. The argument condexpr
specifies the conditional argument. The expression value is
trueexpr
for all evaluation points where condexpr
is larger or equal to zero. Otherwise, its value is falseexpr
.
Example
See Also
imagZ
This returns an expression that is the imaginary part of the Z = V/I complex impedance.
See Also
insertrank
integral
inverse
This returns the inverse of a square matrix.
Example
See Also
invjac
Example 1: invjac(row:int, col:int)
This returns the inverse of the Jacobian matrix at the entry (row, col).
Example 2: invjac()
This returns the whole Jacobian matrix.
See Also
isdefined
This checks if a physical region physreg
is defined.
Example
See Also
isempty()
, isinside()
, istouching()
isempty
This checks if a physical region physreg
is empty.
Example
See Also
isdefined()
, isinside()
, istouching()
isinside
This checks if a physical region is fully included in another region.
The physreg
is the physical region with which physregtocheck
is checked.
Example
See Also
isdefined()
, isempty()
, istouching()
istouching
This checks if a region is touching another region.
The physreg
is the physical region with which physregtocheck
is checked.
Example
See Also
isdefined()
, isempty()
, isinside()
jac
Example 1: jac(row:int, col:int)
This returns the inverse of the Jacobian matrix at the entry (row, col).
Example 2: jac()
This returns the whole Jacobian matrix.
See Also
linspace
This gives a vector of num
equally spaced values from a
to b
. The space between each values is calculated as:
Example
See Also
loadshape
This function loads a mesh file to shapes. The output holds a shape for every physical region of dimension d (0D, 1D, 2D, 3D) defined in the mesh file. The loaded shapes can be edited (extruded, deformed, β¦) and grouped with other shapes to create a new mesh. Note that the usage of loaded shapes might be more limited than other shapes.
Example
loadvector
This loads a list from the file filename
. The delimiter
specfies the character separating each entry in the file.
The sizeincluded
must be set to True
if the first number in the file is the size of the list.
Example
See Also
log
This returns an expression that is the natural logarithm of the input expression.
Example
log10
logspace
This returns the basis
to the power of each of the num
values in the linspace.
Example
See Also
makeharmonic
This returns a multi-harmonic expression whose harmonic numbers and expressions are provided as arguments. The argument expressions must be on harmonic 1.
Example
max
This returns an expression whose value is the maximum of the two input arguments a
and b
.
Example
See Also
meshsize
This returns an expression whose value is the length/area/volume for each 1D/2D/3D mesh element respectively. The value is
constant on each mesh element. The integrationorder
determines the accuracy of mesh size calculated. Higher the number,
the better the accuracy. Integration order cannot be negative and if the integration order < a RuntimeError is raised.
Example
min
This returns an expression whose value is the minimum of the two input arguments a
and b
.
Example
See Also
mod
This is a modulo function. This returns an expression equal to the remainder resulting from the division
of input
by modval
.
Example
modedrive
Modedrive defines a boundary condition in the physical region portphysreg
by feeding and absorbing the mode found by alleigenport (parameters Etreal
, Etimag
, Htreal
, and Htimag
).
The input field E
is constrained to be a complex multiple of the mode; lumpfield
defines this multiplier and must have been prepared into the formulation beforehand.
If modedrive is applied with different modes in the same region, E
is constrained to be their linear combination.
The mode is fed according to drivesignal
, which should be expressed as or , where is the driving frequency and is an optional phase shift.
The parameter blocktag
is the block number of the feeding term (for the absorbing term this is always 0).
The feeding term only affects the right hand side, so this information can be used to solve the same formulation with multiple right hand sides, e.g. when computing S-parameters.
Example
See Also
alleigenport()
, formulation.allsolve()
, formulation.lump()
, allcomputesparameters()
moveharmonic
This returns an expression equal to the input expression with a selected and moved harmonic content. Set a positive last argument to use an FFT to compute the harmonics of the input expression.
Example
norm
This gives the norm of an expression input.
Example
normal
This defines a normal vector with unit norm. If a physical region is provided as an argument then the normal points out of it. if no physical region is provided then the normal can be flipped depending on the element orientation in the mesh.
Examples
on
This function allows to use fields, unknown dof \ fields or general expressions across physical regions with possibly non- matching meshes by evaluating the expression argument using a (x, y, z) coordinate interpolation. It makes it straightforward to setup the mortar finite element method to enforce general relations, such as field equality , at the interface of non-matching meshes. This can for example be achieved with a Lagrange multiplier such that
holds for any appropriate field , and . The example below illustrates the formulation terms needed to implement the Lagrange multiplier between interfaces and .
Examples
Example 1: on(physreg:int, expr:expression, errorifnotfound:bool=True)
physreg
is the physical region across which the expression expr
is evaluated. The expr
argument can be fields or dof \
fields or any general expressions.
When setting the flag errorifnotfound=False
, any point in without a relative in (and vice versa)
does not contribute to the assembled matrix. The default value is True for which an error is raised if a point in is without
a relative in (and vice versa).
The case where there is no unknown dof \ term in the expression argument is described below:
With the on function, the (x, y, z) coordinates corresponding to each Gauss point of the integral are first calculated then the dz(z) \ expression is evaluated through interpolation at these (x, y, z) coordinates on region vol. With on here dz(z) \ is correctly evaluated as because the z-derivative calculation is performed on the volume region vol. Without the on operator the z-derivative would be wrongly calculated on the top face of the disk (a plane perpendicular to the z-axis).
If a requested interpolation point cannot be found (because it is outside of physreg or because the interpolation algorithm
fails to converge, as can happen on curved 3D elements) then an error occurs unless errorifnotfound
is set to False. In the
latter case, the value returned at any non-found coordinate is zero, without raising an error.
Example 2: on(physreg:int, expr:coordshift, expr:expression, errorifnotfound:bool=True)
This is similar to the previous example but here the (x, y, z) coordinates at which to interpolate the expression are shifted by (x+compx(coordshift), y+compy(coordshift), z+compz(coordshift)).
orpositive
This returns an expression whose value is 1 for all evaluation points where at least one input expression has a value larger or equal to zero. Otherwise, its value is -1.
Example
See Also
periodicitycondition
This returns the formulation terms required to enforce on field a rotation or translation periodic condition between boundary region and (meshes can be non-conforming). A factor different than can be provided to scale the field on (use - for antiperiodicity).
Example
The condition is based on a Lagrange multiplier of the same type and the same harmonic content as the field and . The mortar finite element method is used to link the unknown field on and so that there is no restriction on the mesh used for both regions.
More advanced periodic conditions can be implemented easily using on()
function.
See Also
continuitycondition()
, symmetrycondition()
pow
This is a power function. This returns an expression equal to base
to the power exponent
:
Example
See Also
predefinedacousticradiation
This function defines the equation for the Sommerfeld acoustic radiation condition
which forces the outgoing pressure waves at infinity: a pressure field of the form
propagating in the direction perpendicular to the truncation boundary indeed satisfies the Sommerfeld radiation condition since
Zero artificial wave reflection at the truncation boundary happens only if it is perpendicular to the outgoing waves. In practical applications however the truncation boundary is not at an infinite distance from the acoustic source and the wave amplitude is not constant and thus, some level of artificial reflection cannot be avoided. To minimize this effect the truncation boundary should be placed as far as possible from the acoustic source (at least a few wavelengths away).
An acoustic attenuation value can be provided (in ) in case of harmonic problems. For convenience use the function
dbtoneper()
to convert attenuation values to .
Example
predefinedacousticstructureinteraction
This function defines the bi-directional coupling for acoustic-structure interaction at the medium interface. Field is the acoustic pressure and field is the mechanical displacement. Calling the normal to the interface pointing out of the solid region, the bi-directional coupling is obtained by adding the fluid pressure loading to the structure
as well as linking the structure acceleration to the fluid pressure normal derivative using Newtonβs law:
To have a good matrix conditioning a scaling factor (e.g ) can be provided. In this case, the pressure source is divided by and, to compensate, the pressure force is multiplied by . This leads to the correct membrane deflection but the pressure field is divided by the scaling factor.
An acoustic attenuation value can be provided (in ) in case of harmonic problems. For convenience use the function
dbtoneper()
to convert attenuation values to .
Example
predefinedacousticwave
This function defines the equation for (linear) acoustic wave propagation:
An acoustic attenuation value can be provided (in ) in case of harmonic problems. For convenience use the function
dbtoneper()
to convert attenuation values from to .
The arguments have the following meaning:
dofp
is the dof of the acoustic pressure field.tfp
is the test function of the acoustic pressure field.soundspeed
is the speed of sound in .neperattenuation
is the attenuation in .pmlterms
is the list of pml terms.precondtype
is the type of precondition.
Examples
Example 1: predefinedacousticwave(dofp:expression, tfp:expression, soundspeed:expression, neperattenuation:expression, precondtype:str="")
In the illustrative example below, a highly-attenuated acoustic wave propogation in a rectangular 2D box is simulated.
Example 2: predefinedacousticwave(dofp:expression, tfp:expression, soundspeed:expression, neperattenuation:expression, pmlterms:List[expression], precondtype:str="")
This is the same as the previous example but with PML boundary conditions.
predefinedadmittancebcincompressible
This function returns the weak formulation of admittance boundary condition for incompressible flows:
p(\omega) = \frac{1.0}{Y(\omega)} (\mathbf{V} \cdot {\mathbf{n})where is the pressure, the velocity of the flow, the normal vector to the boundary (pointing outward), and the frequency-dependent admittance in harmonic form. It is assumed that the tabulated values of are provided as function of frequency by the user.
Example
See Also
predefinedimpedancebcincompressible()
predefinedadvectiondiffusion
This defines the weak formulation for the generalized advection-diffusion equation:
where is the scalar quantity of interest and is the velocity that the quantity is moving with. With
and set to unit, the classical advection-diffusion equation with diffusivity
tensor is obtained. Set isdivvzero
to True if is zero (for
incompressible flows).
Example
See Also
predefinedaml
predefinedboxpml
This is a collective MPI operation and hence must be called by all the ranks. This function returns
where is the PML transformation matrix for a square box in a square box. A hyperbolic or shifted hyperbolic PML can be selected with the last argument.
Example
predefineddiffusion
This defines the weak formulation for the generalized diffusion equation:
where is the scalar quantity of interest. With set to unit, the classical diffusion equation with diffusivity tensor is obtained.
Example
See Also
predefinedadvectiondiffusion()
predefinedelasticity
This defines a classical linear elasticity formulation.
Examples
Example 1: predefinedelasticity(dofu:expression, tfu:expression, Eyoung:expression, nupoisson:Expression, myoption:str="")
This defines a classical linear isotropic elasticity formulation whose strong form is:
where,
- is the displacement field vector
- is the Cauchy stress tensor in Voigt notation
- is the strain tensor in Voigt notation
- is the order elasticity/stiffness tensor
- is the volumetric body force vector
- is the mass density
This is used when the material is isotropic. u is the mechanical displacement, Eyoung is the Youngβs modulus [Pa] and nupoisson is the Poissonβs ratio. In 2D the option string must be either set to βplanestrainβ or βplanestressβ for a plane strain or plane stress assumption respectively.
Example 2: predefinedelasticity(dofu:expression, tfu:expression, elasticitymatrix:expression, myoption:str="")
This extends the previous definition (Example 1) to general anisotropic materials. The elasticity matrix [Pa] must be provided such that it relates the stress and strain in Voigt notation.
Example 3: predefinedelasticity(dofu:expression, tfu:expression, u:field, Eyoung:expression, nupoisson:expression, prestress:expression, myoption:str="")
This defines an isotropic linear elasticity formulation with geometric nonlinearity taken into account (full-Lagrangian formulation using the Green-Lagrange strain tensor). Problems with large displacements and rotations can be simulated with this equation but strains must always remain small. Buckling, snap-through and the likes or eigenvalues of prestressed structures can be simulated with the above equation in combination with a nonlinear iteration loop.
The prestress vector [Pa] must be provided in Voigt notation . Set the prestress expression to for no prestress.
Example 4: predefinedelasticity(dofu:expression, tfu:expression, u:field, elasticitymatrix:expression, prestress:expression, myoption:str="")
This extends the previous definition (Example 3) to general anisotropic materials. The elasticity matrix [Pa] must be provided such that it relates the stress and strain in Voigt notation. Similarly, the prestress vector [Pa] must be also provided in Voigt notation .
predefinedelasticradiation
predefinedelectrostaticforce
This function defines the weak formulation term for electrostatic forces. The first argument is the mechanical displacement test function or its gradient, the second is the electric field expression and the third argument is the electric permittivity ( must be a scalar).
Let us call [] the electrostatic Maxwell stress tensor:
where is the electric permittivity, is the electric field and is the identity matrix. The electrostatic force density is N/m^3 so that the loading for a mechanical problem can be obtained by adding the following term:
where is the mechanical displacement. The term can be rewritten in the form that is provided by this function:
where is the infinitesimal strain tensor. This is identical to what is obtained using the virtual work principle. For details refer to βDomain decomposition techniques for the nonlinear, steady state, finite element simulation of MEMS ultrasonic transducer arraysβ, page 40.
In this function, a region should be provided to the test function argument to compute the force only for the degrees of freedom associated to that specific region (in the example below with tf(u, top) the force only acts on the surface region βtopβ. In any case, a correct force calculation requires including in the integration domain all elements in the region where the force acts and in the element layer around it (in the example below βvolβ includes all volume elements touching surface βtopβ).
Example
See Also
predefinedmagnetostaticforce()
predefinedemwave
This defines the equation for (linear) electromagnetic wave propagation:
where is the electric field, is the magnetic permeability, is the electric permiitivity and is the electric conductivity. The real and imaginary parts of each material property can be provided.
The argument have the following meaning:
dofE
is the dof of the electric field.tfE
is the test function of the electric field.mur
andmui
is the real and imaginary part of the magnetic permeability .epsr
andepsi
is the real and imaginary part of the electric permittivity .sigr
andsigi
is the real and imaginary part of the electric conductivity .pmlterms
is the list of pml terms.precondtype
is the type of precondition.
Examples
Example 1: predefinedemwave(dofE:expression, tfE:expression, mur:expression, mui:expression, epsr:expression, epsi:expression, sigr:expression, sigi:expression, precondtype:str="")
Example 2: predefinedemwave(dofE:expression, tfE:expression, mur:expression, mui:expression, epsr:expression, epsi:expression, sigr:expression, sigi:expression, pmlterms:List[expression], precondtype:str="")
This is the same as the previous example but with PML boundary conditions.
predefinedfluidstructureinteraction
This function returns the formulation of fluid-structure interaction for incompressible flows:
The Navier-Stokes equation for incompressible flows in weak form is given by
where is the velocity, the pressure, the displacement of the structure, the fluid domain, and the whole boundary of the fluid domain. The dashed variables are the test functions in the weak formulation.
The no-slip boundary condition at the fluid-structure interface is applied by using a Lagrange multiplier () method as
The Lagrange multiplier naturally contains the viscous forces acting on the fluid, which can be applied directly to the structure with an inverted sign along with the normal pressure force as
where the boundary interface between fluid and structure domains.
Example
See Also
predefinedimpedancebcincompressible
This function returns the weak formulation of impedance boundary condition for incompressible flows:
where is the pressure, the velocity of the flow, the normal vector to the boundary (pointing outward), and the frequency-dependent impedance in harmonic form. It is assumed that the tabulated values of are provided as function of frequency by the user.
Example
See Also
predefinedadmittancebcincompressible()
predefinedlinearpoissonwalldistance
This function calculates and returns distance values from the wall based on the linear Poisson wall distance equation:
where is the approximate wall distance function. The distance is calculated for the physical region physreg from the walls defined in wallreg argument.
More information can be found in Computations of Wall Distances Based on Differential Equations Paul G. Tucker, Chris L. Rumsey, Philippe R. Spalart, Robert E. Bartels, and Robert T. Biedron AIAA Journal 2005 43:3, 539-549, https://doi.org/10.2514/1.8626 .
The system is linear and hence a linear solver is used. After calculating the distance function , a better approximation of distance is obtained as follows:
This wall distance uses an above-zero limiter during calculation. Thus, to ensure that the distance value obtained is smooth, set the project argument to True. This will solve a projection of the distance values at the end and return a smooth solution.
Excerpts from the above paper: βThe derivation of the above formula for assumes extensive (infinite) coordinates in the non-normal wall directions. Hence, the distance is only accurate close to walls. However, turbulence models only need βdβ accurate close to walls.β
Example
See Also
predefinedreciprocalwalldistance()
, predefinednonlinearpoissonwalldistance()
predefinedmagnetostaticforce
This function defines the weak formulation term for magnetostatic forces. The first argument ist the mechanical displacement test function or its gradient, the second is the magnetic field expression and the third argument is the magnetic permeability ( must be a scalar).
Let us call [] the magnetostatic Maxwell stress tensor:
where is the magnetic permeability, is the magnetic field and is the identity matrix. The magnetostatic force density is N/m^3 so that the loading for a mechanical problem can be obtained by adding the following term:
where is the mechanical displacement. The term can be rewritten in the form that is provided by this function:
where is the infinitesimal strain tensor. This is identical to what is obtained using the virtual work principle. For details refer to βDomain decomposition techniques for the nonlinear, steady state, finite element simulation of MEMS ultrasonic transducer arraysβ, page 40.
In this function, a region should be provided to the test function argument to compute the force only for the degrees of freedom associated to that specific region (in the example below with tf(u, top) the force only acts on the surface region βtopβ. In any case, a correct force calculation requires including in the integration domain all elements in the region where the force acts and in the element layer around it (in the example below βvolβ includes all volume elements touching surface βtopβ).
Example
See Also
predefinedelectrostaticforce()
predefinednavierstokes
This defines the weak formulation for the general (nonlinear) flow of Newtonian fluids:
where,
- is the fluid density
- is the dynamic viscosity of the fluid
- is the pressure
- is the flow velocity
The formulation is provided in a form leading to a quadratic (Newton) convergence when solved iteratively in a loop. This formulation is only valid to simulate laminar as well as turbulent flows. Using it to simulate turbulent flows leads to a so- called DNS method (direct numerical simulation). DNS does not require any turbulence model since it takes into account the whole range of spatial and temporal scales of the turbulence. Therefore, it requires a spatial and time refinement that for industrial applications typically exceeds the computing power of the most advanced supercomputers. As an alternative, RANS and LES method can be used for turbulent flow simulation.
The transition from a laminar to a turbulent flow is linked to a threshold value of the Reynolds number. For a flow in pipes typical Reynolds number below which the flow is laminar is about .
Arguments dtrho
and gradrho
are respectively the time derivative and the gradient of the density while includetimederivs
gives the option to include or not the time-derivative terms in the formulation. In case the density constant argument is set
to True, the fluid is supposed incompressible and the Navier-Stokes equations are further simplified since the divergence of
the velocity is zero. If the viscosity is constant in space (it does not have to be constant in time) the constant viscosity argument
can be set to True. By default, the density and viscosity are supposed constant and the time-derivative terms are not included.
Please note that to simulate the Stokes flow the LBB condition has to be satisfied. This is achieved by using nodal (h1)
type shape functions with an interpolation order of at least one higher for the velocity field than for the pressure field.
Alternatively, an additional isotropic diffusive term or other stabilization techniques can be used to overcome the LBB limitation.
Example
See Also
predefinednavierstokescrosswindstabilization
predefinednavierstokesstreamlinestabilization
predefinednonlinearpoissonwalldistance
This function calculates and returns distance values from the wall based on a generic p-Posison wall distance equation:
where is the approximate wall distance function and is the Poisson parameter. The distance is calculated for the
physical region physreg from the walls defined in wallreg argument. The Poisson parameter must be larger than or equal
to 2. Higher the parameter better the distance field approximation. The term represents an apparent
diffusion coefficient. When , the equation reduces to the linear Poisson wall distance. See predefinedlinearpoissonwalldistance()
.
More information can be found in Wall-Distance Calculation for Turbulence Modelling, J. C. Bakker, Delft University of Technology. http://samofar.eu/wp-content/uploads/2018/10/Bakker_Jelle_BSc-thesis_2018.pdf .
The above system is non-linear and hence an iterative Newton solver is used. After calculating the distance function , a better approximation of distance is obtained as follows:
This wall distance uses an above-zero limiter during calculation. Thus, to ensure that the distance value obtained is smooth, set the project argument to True. This will solve a projection of the distance values at the end and return a smooth solution.
Example
See Also
predefinedreciprocalwalldistance()
, predefinedlinearpoissonwalldistance()
predefinedreciprocalwalldistance
This function calculates and returns distance values from the wall based on the reciprocal wall distance (G=1/d) equation:
The distance is calculated for the physical region physreg from the walls defined in wallreg argument.
More information can be found in Fares, E., and W. SchrΓΆder. βA differential equation for approximate wall distance.β International journal for numerical methods in fluids 39.8 (2002): 743-762.
Excerpts from the above paper: βThe desired smoothing is controlled by the value of the smoothing parameter . The larger the value means a stronger smoothing at sharp edges (but also a large deviation from exact distances). The value of the wall boundary condition influences the smoothing too.
Reference length is relevant in the definition of the initial and boundary conditions. For geometries with just one-sided wall, does not play a role- since the solution is the exact distance for all and . This formulation promises an enhancement of turbulence models at strongly curved surfaces.β
Smaller and larger allow for better approximations of distances although at times it can be difficult to obtain convergence. In such cases, lowering the improves.
Example
See Also
predefinedlinearpoissonwalldistance()
, predefinednonlinearpoissonwalldistance()
predefinedslipwall
predefinedstabilization
This function defines the isotropic, streamline anisotropic, crosswind, crosswind shockwave, streamline Petrov_Galerkin and streamline upwind Petrov-Galerkin stabilization methods for the advection-diffusion problem:
where is the scalar quantity of interest, is the velocity that the quantity is moving with and is the diffusivity tensor.
A characteristic number of advection-diffusion problems is the Peclet number:
where is the length of each mesh element. It quantifies the relative importance of advective and diffusive transport rates. When the Peclet number is large () the problem is dominated by faster advection (higher advection transport) and prone to spurious oscillations in the solution. Although lowering the Peclet number can be achieved by refining the mesh, a classical alternative is to add stabilization terms to the original equation. A proper choice of stabilization should remove oscillations while changing the original problem as little as possible. In the most simple method proposed (isotropic diffusion), the diffusivity is artificially increased to lower the Peclet number. The more advanced method proposed attempts to add artificial diffusion only where it is needed. In the crosswind shockwave, SPG and SUPG methods the residual of the advection-diffusion equation is used to quantify the local amount of diffusion to add. The terms provided by the proposed stabilization methods have the following form:
- isotropic diffusion:
- streamline anisotropic diffusion
- crosswind diffusion:
- crosswind shockwave:
- streamline Petrov-Galerkin (SPG):
- streamline upwind Petrov-Galerkin (SUPG):
where is the test function associated with field and .
To understand the effect of the crosswind diffusion one can notice that for a 2D flow in the direction only, tensor becomes
and the artificial diffusion is only added at places where has a component in the direction perpendicular to the flow.
How to use the predefined stabilization methods: Due to the large amount of artificial diffusion added by the isotropic diffusion method it should only be considered as a fallback option. In practice, a pair of one streamline and one crosswind method should be used with the smallest possible tuning factor . If the problem allows, SUPG should be preferred over SPG and crosswind shockwave should be preferred over the crosswind because the amount of diffusion added tends to be lower.
Examples
The different stabilization methods are defined for the following simulation setup:
The following residual-based stabilizations require the strong-form residual. Neglecting the second-order space-derivative still leads to a good residual approximation.
predefinedstabilizednavierstokes
predefinedstokes
This defines the weak formulation for the Stokes (creeping) flow, a linear form of Navier-Stokes where the advective term is ignored as the inertial forces are smaller compared to the viscous forces:
where,
- is the fluid density
- is the dynamic viscosity of the fluid
- is the pressure
- is the flow velocity
This formulation is only valid to simulate the flow of Newtonian fluids (air, water, β¦) with a very small Reynolds number ():
where is the characteristic length of the flow. Low flow velocities, high viscosities or small dimensions can lead to a valid Stokes flow approximation. Flows in microscale devices such as microvalves are also good candidates for Stokes flow simulations.
Arguments dtrho
and gradrho
are respectively the time derivative and the gradient of the density while includetimederivs
gives the option to include or not the time-derivative terms in the formulation. In case the density constant argument is set
to True, the fluid is supposed incompressible and the Navier-Stokes equations are further simplified since the divergence of
the velocity is zero. If the viscosity in space (it does not have to be constant in time) the constant viscosity argument
can be set to True. By default, the density and viscosity are supposed constant and the time-derivative terms are not included.
Please note that to simulate the Stokes flow the LBB condition has to be satisfied. This is achieved by using nodal (h1)
type shape functions with an interpolation order of at least one higher for the velocity field than for the pressure field.
Alternatively, an additional isotropic diffusive term or other stabilization techniques can be used to over the LBB limitation.
Example
See Also
predefinedstreamlinestabilizationparameter
predefinedturbulencecrosswindstabilization
predefinedturbulencemodelsstkomega
predefinedturbulencestreamlinestabilization
predefinedviscoelasticity
predefinedviscoelasticwave
printonrank
This function allows the string argument toprint
to be printed only by the given rank
number. This is useful
during DDM simulations and the user wants to print a custom output to monitor the simulation. If the python built-in print
function is used while running DDM simulations, then the input string will be printed by all the ranks resulting in
the same text written multiple times.
Example
printphysicalram
printsparameters
Prints the magnitudes (unit: dB) and angles (unit: degrees) of the S-parameters returned by allcomputesparameters.
See Also
printtotalforce
This prints the total force and its unit. The total force value is returned.
Examples
Example 1: printtotalforce(physreg:int, EorH:expression, epsilonormu:expression, extraintegrationorder:int=0)
Example 2: printtotalforce(physreg:int, meshdeform:expression, EorH:expression, epsilonormu:expression, extraintegrationorder:int=0)
This is similar to the above function but the total force is computed and returned on the mesh deformed by the field u
.
See Also
printvector
This prints the input
list as well as its values. The input
can be a list of double/int/bool elements.
Example
See Also
printversion
ramp
This creates a ramp function. It is a signal that starts initially at value 0. Then at 0 + delay
seconds it transitions
from value 0 to 1 in a linear increase. That transition happens in rampuptime
seconds. This is followed by a flat value 1
that is held for holdtime
seconds. This is followed by a linear decrease from value 1 to 0 that happens in rampdowntime
seconds.
The value is then forever 0 after that.
The rampuptime
is the time to transition linearly from value 0 to 1. The holdtime
is the time
the value stays at 1. The rampdowntime
is the time to transition linearly from value 1 to 0. The delay
is the time at which
the rampup starts.
Examples
The operation current is ramped from 0 to 200 in 3 seconds and is held at 200 for another 5 seconds after which it is ramped down to 0 in the next 3 seconds.
If the holdtime
is set to zero, then the ramp defines a triangular function.
If the rampuptime
and rampdowntime
is set zero with a positive holdtime
, then a rectangular function is defined.
realZ
This returns an expression that is the real part of the Z = V/I complex impedance.
See Also
rectangularport
This function returns the TE or TM mode of index (according to the parameters mmode
and nmode
) for the rectangular waveguide whose cross section is the physical region portphysreg
.
The parameter modetype
should be βteβ or βtmβ. The material parameters and are required as input arguments; these must be real and scalar-valued.
The list cxynodecoords
should contain three corner points of the rectangular cross section; cxynodecoords[1] - cxynodecoords[0]
gives the -direction and cxynodecoords[2] - cxynodecoords[0]
the -direction.
The mode is returned as a list of expressions containing the fields and (both real-valued) and the phase constant .
The mode is scaled such that the power into the waveguide equals one watt; integrationorder
determines the order of the integration rule used to compute the power.
Example
See Also
scatterwrite
This writes to the output file a scalar or vector values at given coordinates. If atleast one of the compyevals
or
compzevals
is not empty then the values saved are vectors and not scalars. For scalars, only compxevals
must be provided.
If the length of all the list arguments are not identical, a RuntimeError is raised.
Example
selectall
This returns a new or an existing physical region that covers the entire domain.
Example
See Also
selectunion()
, selectintersection()
, selectnooverlap()
, shape
, mesh
selectintersection
This returns a new or an existing physical region that is the intersection of physical regions passed via the argument
physregs
. The intersectdim
argument determines the dimensional data from the intersection that would be utilized
in subsequent operations such as setting constraints on a physical region or writing a field or expression to the
physical region. For,
intersectdim=3
: from the intersection, only volumes are used in subsequent operations.intersectdim=2
: from the intersection, only surfaces are used in subsequent operations.intersectdim=1
: from the intersection, only lines are is used in subsequent operations.intersectdim=0
: from the intersection, only points are is used in subsequent operations.
This is useful in isolating only those dimensional data that might be necessary and ignoring the others arising
from the intersection. Note that, the intersected region itself is not affected by intersectdim
. This argument
only determines which dimensional data is utilized when the intersected physical region is used in calculations or
operations.
Examples
See Also
selectunion()
, selectall()
, selectnooverlap()
selectnooverlap
This returns a new or an existing physical region that covers no-overlap domain in case of overlap DDM and the entire domain otherwise.
See Also
selectunion()
, selectintersection()
, selectall()
selectunion
This returns a new or an existing physical region that is the union of physical regions passed via the argument physregs
.
Example
See Also
selectintersection()
, selectall()
, selectnooverlap()
setaxisymmetry
This call should be placed at the very beginning of the code. After the call everything will be solved assuming axisymmetry (works for 2D meshes in the xy plane only). All equations should be written in their 3D form.
In order to correctly take into account the cylindrical coordinate change, the appropriate space derivative
operators should be used. For example, the gradient of a vector operator required in the mechanical strain calculation to
compute the gradient of mechanical displacement should not be defined manually using dx()
, dy()
and dz()
space derivatives.
The grad()
operator should instead be called on the mechanical displacement vector. Note that If the function is called after
loading a mesh, a RuntimeError is raised.
Example
setdata
This function transfers the vector data to all fields and ports defined in the formulation associated to the vector.
If the formulation uses ports, then this method must be used to update port values from the solution vector.
Using field.setdata()
only updates the fields.
Example
See Also
setfundamentalfrequency
This defines the fundamental frequency (in ) required for multi-harmonic problems.
Example
setoutputfield
Add a field to output for visualization. The function must be called by all ranks, so that all ranks write their own output files.
Example
Example transient
setoutputfieldiodata
Add a field to output for visualization using precalculated iodata object. The function must be called by all ranks, so that all ranks write their own output files.
Example radiation pattern
setoutputfieldstate
Add raw field state to output. The function must be called by all ranks, so that all ranks write their own files.
Outputs written using this function can be used as inputs of other simulations using the field initializations feature.
Example
setoutputmesh
Add mesh output that will be available for users.
Arguments
name
:βName for the mesh, used in the filename
: Β
regions
:βPhysical regions that should be included in the mesh files
: Β
option
:βThe option parameter given to mesh.write()(β¦) simcore function
: Β
mesh
:βSimcore mesh object
: Β
step: Current timestamp or the eigenvalue index. If not applicable, leave unset.
setoutputtransientstate
Add the current state of the transient timestepper to output.
Outputs written using this function can be used as inputs of other simulations using the field initializations feature.
Example
setoutputvalue
Add a value output. Only the main rank (0) will actually write the value.
Example
Example transient
setphysicalregionshift
This shifts the physical region numbers by shiftamount
x (1 + physical region dimension) when loading a mesh.
Example
In the example the point/line/face/volume (0D/1D/2D/3D) physical region numbers will be shifted by 1000/2000/3000/4000 when a mesh is loaded.
settime
This sets the time variable t.
Example
See Also
settimederivative
This allows us to set the time derivative vectors to the corresponnding fields used in the formulation.
Examples
Example 1: settimederivative(dtx:vec)
This sets the first-order time derivate vector and removes the second-order time derivative vector.
Example 2: settimederivative(dtx:vec, dtdtx:vec)
This sets the first and second-order time derivative vectors.
sin
This returns an expression that is the of input. The input expression is in radians
.
Example
See Also
cos()
, tan()
, asin()
, acos()
, atan()
sn
This function takes as an argument the fundamental frequency multiplier. It is a shortform for .
Example
See Also
solve
This function solves an algebraic problem. This function can solve both nonlinear and linear systems. Nonlinear problems are solved with a fixed-point iteration. Linear problems can be solved with both direct and iterative solvers. Depending on the algebraic problem and the solver needed, the overloaded solve function can be called with different numbers and types of arguments as shown in the examples below.
Examples
Example 1: solve(A:mat, b:vec, soltype:str="lu", diagscaling:bool=False) -> quanscient.vec
This solves a linear algebraic problem with a (possibly reused) LU or Cholesky factorization by calling the mumps parallel direct solver via PETSC. The matrix can be diagonally scaled for improved conditioning (especially in multiphysics problems). In the case of diagonal scaling the matrix is modified after the call.
Example 2: solve(A:mat, b:List[vec], soltype:str="lu") -> List[vec]
This is same as the previous example but allows us to efficiently solve for multiple right-hand side vectors .
Example 3: solve(A:mat, b:vec, sol:vec, relrestol:double, maxnumit:int, soltype:str="bicgstab", precondtype:str="sor", verbosity:int=1, diagscaling:bool=False)
This solves a linear algebraic problem with a preconditioned (ilu, sor, gamg) iterative solver (gmres or bicgstab). Vector sol is used as an initial guess and holds the solution at the end of the call. Values relrestol and maxnumit give the relative residual tolerance and the maximum number of iterations to be performed by the iterative solver. The matrix can be diagonally scaled for improved conditioning (especially in multiphysics problems). In the case of diagonal scaling the matrix is modified after the call.
Example 4: solve(nltol:double, maxnumnlit:int, realxvalue:double, formuls:List[formulation], verbosity:int=1) -> int
This solves a nonlinear problem with a fixed point iteration. A relaxation value can be provided with relaxvalue
argument.
Usually, a relaxation value less than (under-relaxation) is used to avoid divergence of a solution.
See Also
allsolve()
, formulation.allsolve()
sqrt
This returns an expression that is the square root of the input expression.
Example
startoutputfileupload
NOTE: Only use this if you need to access custom files written during simulation that might timeout or be aborted.
Start uploading output files. It is not necessary to call this for outputs that have their own
function such as setoutputfield()
, setoutputmesh()
and setoutputfieldstate()
.
strain
This defines the (linear) engineering strains in Voigt form . The input can either be the displacement field or its gradient.
Example
See Also
symmetrycondition
This defines a weak formulation of symmetry condition on the boundary region bndphysreg
. Depending on, if the u
field
passed is a vector or scalar, the appropriate symmetry condition is formulated. For a vector and scalar field, the symmetry
condition is respectively,
This function uses a scalar Lagrange multiplier to enforce the symmetry boundary condition. The lagmultorder
argument sets
the interpolation order of the Lagrange multiplier.
where is the unit normal vector. In fluid dynamics, the symmetry condition is equivalent to the slip-condition which states
that there is no outflow through the boundary. This is equivalent to velocity vector normal to the boundary being zero. Here, the u
field
passed as the argument is the velocity vector.
Examples
Example 1: symmetrycondition_doc(bndphysreg:int, u:field, lagmultorder:int=0)
Note that the symmetry condition also works on fields with harmonics.
The lagrangemultorder
also determines the type of shape function used by the Lagrange multiplier. If the order is set to zero,
shape function of type βone1β (in 2D) or βone2β (in 3D) is used. For order greater than 0, shape function of type βh1β is used.
Example 2: symmetrycondition_doc(bndphysreg:int, meshdeform:expression, u:field, lagmultorder:int=0)
Here, the symmetry boundary condition of u
is formulated on the mesh deformed by the field v
.
See Also
periodicitycondition()
, continuitycondition()
t
This gives the time variable in the form of an expression. The evaluation gives a value equal to gettime()
.
Example
See Also
tan
This returns an expression that is the of input. The input expression is in radians
.
Example
See Also
sin()
, cos()
, asin()
, acos()
, atan()
tangent
This defines a tangent vector with unit norm.
Example
tf
This declares a test function field. The test functions are defined only on the region physreg
which when not provided is set
to the element integration region.
Examples
Example 1: tf(input:expression)
Example 2: tf(input:expression, physreg:int)
See Also
toggle
trace
This computes the trace of a square matrix expression a
. The returned expression is a scalar.
Example
trackpetscinfo
transpose
This returns an expression that is the transpose of a vector or matrix expression.
Example
vonmises
This returns the von Mises stress expression corresponding to the 3D stress tensor provided as argument. The stress tensor should be provided in Voigt form .
For 2D plane stress problems all related components of the stress tensor are . For plane strain problems do not forget the term .
Example
wallfunction
wavelet
write
writecsvfile
writeshapefunctions
This writes to file all shape functions up to a requested order. It is a convenient tool to visualize the shape functions.
Example
writevector
This writes all the entries of a list given in towrite
to the file filename
with the requested delimiter
.
The size of the list can also be written at the beginning of a file if writesize
is set to True.
Example
See Also
zienkiewiczzhu
This defines a Zienkiewicz-Zhu type error indicator for the argument expression. The value of the returned expression is constant over each element. It equals the maximum of the argument expression value jump between that element and any neighbour. In the below example, the zienkiewiczzhu(grad(v)) expression quantifies the discontinuity of the field derivative. For a non-scalar arguments the function is applied to each entry and the norm is returned.
Example
Classes
Class: densemat
The densemat
object stores a row-major array of doubles that corresponds to a dense matrix.
For storing an array of integers, see indexmat
object.
Examples
There are several ways of instantiating a densemat
object. They are listed below:
Example 1: densemat(numberofrows:int, numberofcolumns:int)
The following creates a matrix with 2 rows and 3 columns. The entries may be undefined.
Example 2: densemat(numberofrows:int, numberofcolumns:int, initvalue:double)
This creates a matrix with 2 rows and 3 columns. All entries are assigned the value initvalue
.
Example 3: densemat(numberofrows:int, numberofcolumns:int, valvec:List[double])
This creates a matrix with 2 rows and 3 columns. The entries are assigned the values of valvec
.
The length of valvec
is expected to be equal to the total count of entries in the matrix. So for creating
a matrix of size , length of valvec
must be 6.
Example 4: densemat(numberofrows:int, numberofcolumns:int, init:double, step:double)
This creates a matrix with 2 rows and 3 columns. The first entry is assigned the value init
and the consecutive entries
are assigned values that increase by steps of step
.
Example 5: densemat(input:List[densemat])
This creates a matrix that is the vertical concatenation of input
matrices. Since, the concatenation occurs vertically,
the number of columns in all the input matrices must match.
Methods
count
This counts and returns the total number of entries in the dense matrix.
Example
countcolumns
This counts and returns the number of columns in the dense matrix.
Example
countrows
This counts and returns the number of rows in the dense matrix.
Example
print
This prints the entries of the dense matrix.
Example
printsize
This prints the size of the dense matrix.
Example
Class: eigenvalue
The eigenvalue object allows us to solve classical, generalized and polynomial eigenvalue problems. The computation is done by SLEPc, a scalable library for eigenvalue problem computation.
Examples
Example 1: eigenvalue(A: mat)
This defines a classical eigenvalue problem:
Example2.1: eigenvalue(A:mat, B:mat)
This defines a generalized eigenvalue problem . Undamped mechanical resonance modes and resonance frequencies can be calculated with this since an undamped mechanical problem can be written in the form
which for a harmonic excitation at angular frequency can be rewritten as
so that the generalized eigen value is equal to .
To visualize the resonance frequencies of all calculated undamped modes the method eigenvalue.printeigenfrequencies()
can be called.
Example2.2: eigenvalue(form: formulation)
This is same as the example 2.1 but the eigen solution is obtained iteratively. This can be used for both non-DDM and DDM simulation case setup.
Example 3: eigenvalue(K: mat, C:mat, M:mat)
This defined a second-order polynomial eigenvalue problem which allows getting the resonance modes and resonance frequencies for damped mechanical problems. The input arguments are respectively the mechanical stiffness, damping matrix and mass matrix. A second-order polynomial eigenvalue problem attempts to find a solution of the form
which corresponds to a damped oscillation at frequency with a damping ratio
In the case of proportional damping (if and only if is symmetric) the oscillation of the undamped system is at . The undamped oscillation frequency can then be calculated as
To visualize all relevant resonance information for the computed eigenvalues the method eigenvalue.printeigenfrequencies()
can be called.
Example 4: eigenvalue(inmats: List[mat])
This defines an arbitraray order polynomial eigenvalue problem.
Methods
allcompute
This is an iterative eigen solver that attempts to compute the first numeigenvaluestocompute
eigenvalues
closest to the given target. Note that the targeted values here are eigenvalues and not eigenfrequencies.
There is no guarantee that SLEPc will return the exact number of eigenvalues requested.
This can be used on both non-DDM and DDM simulation setup.
Example
See Also
eigenvalue.compute()
, eigenvalue.allcomputeeigenfrequencies()
allcomputeeigenfrequencies
This is an iterative eigen solver that attempts to compute the first numeigenfrequenciestocompute
eigenfrequencies
whose magnitude is closest to a targeteigenfrequency
( by default). Note that the targeted values are
eigenfrequencies and not eigenvalues unlike in the eigenvalue.allcompute()
method. There is no guarantee that SLEPc will
return the exact number of eigenfrequencies requested. This can be used on both non-DDM and DDM simulation setup.
Example
See Also
eigenvalue.compute()
, eigenvalue.allcompute()
compute
count
This gets the number of eigenvalues found by SLEPc.
geteigenfrequencies
geteigenvalueimaginarypart
This gets the imaginary part of all eigenvalues found.
Example
geteigenvaluerealpart
This gets the real part of all eigenvalues found.
Example
geteigenvectorimaginarypart
This gets the imaginary part of all eigenvectors found.
Example
geteigenvectorrealpart
This gets the real part of all eigenvectors found.
Example
printeigenfrequencies
This method provides a convenient way to print the eigenfrequencies associated with all eigenvalues calculated for a mechanical resonance problem. In case a generalized eigenvalue problem is used to calculate the resonance modes of an undamped mechanical problem, this method displays the resonance frequency of each calculated resonance mode. In case a second-order polynomial eigenvalue problem is used to calculate the resonance modes of a damped mechanical problem this function displays not only the damped resonance frequency of each resonance mode but also the undamped resonance frequency (only valid in case of proportional damping), the bandwidth, the damping ratio and the quality factor.
Example
printeigenvalues
This prints the eigenvalues found.
Example
settolerance
This sets the tolerance and maximum number of iterations for the iterative eigen solver. The settolerance
should be called
only if eigenvalue.allcompute()
is used to solve the eigen problem.
Example
Class: expression
The expression object holds a mathematical expression made of operators (such as +, -, *, /), fields, parameters, square operators, abs operators and so on.
Examples
An empty expression object can be created as:
An expression object can be a scalar:
An expression object can also be a vector or a 2D array. For this three arguments are required. The first and second arguments
specify the number of rows and the number of columns respectively. The expression object is filled with input expressions provided
as a list in the third argument. The general syntax is expression(numrows:int, numcols:int, input:List[expression]
In a 2D array expression, the inputs are set in row-major order. In the example below, the entry at the index pair (1,0) in the created expression is set to and the entry (1,2) to .
A symmetric expression array can also be created by only providing the input list corresponding to the lower triangular part:
A diagonal expression array can also be created by only providing the input list corresponding to the diagonal elements:
Note that to create a symmetric or diagonal expression array, the size must correspond to a square array (number of rows = number of columns).
The expression input can also be made of fields. For example:
An expression array object can be obtained from the row-wise and column-wise concatenation of input expressions using the syntax
expression(input:[List[List[expression]]
. Every element in the argument input
(i.e. input[0]
, input[1]
, ..) is concatenated column-wise with
others. Every expression in `input[i]
(i.e input[i][0]
, input[i][1]
, ..) is concatenated row-wise with the other expressions in that List.
It is also useful in many cases to create a conditional expression. It takes the form expression(condexpr:expression, exprtrue:expression, exprfalse:expression)
.
If the first argument is greater than equal to zero then the expression is equal to the expression provided in the second argument. If smaller than zero, then it
is equal to the expression in the third argument.
An expression can be used to define an algebraic relation between two variables as in the example below:
In the above example, an algebraic relation between two variables was already known allowing us to create an expression that is continuous.
However, if the data is from an experiment, they are usually not continuous. As an application example, if measurements of a material stiffness (Youngβs modulus )
have been performed for a set of temperatures , then only a discrete data set exists between variable and . A discrete data set can be converted to a
continuous function ( as a function of ) using cubic splines which allows us to interpolate at any value in the measured discrete temperature range.
Using this spline object an expression can be defined that provides cubic spline interpolation of Youngβs modulus in the measured discrete temperature range.
Refer to the spline
object for more details.
The expression object is much more versatile. Say, we have to define an electric supply voltage profile in time that is:
- 0V for time before 1 sec.
- increases linearly from 0V to 1V for time range [1,3] sec.
- 1V for time after 3 sec. This can be created as shown below in the example. The following creates a conditional expression for the intervals defined in the first argument for the time variable t(). In the below example, the defined interval is [1.0,3.0]. This provides information in three intervals:
- interval 1: from - to 1.0
- interval 2: between 1.0 to 3.0
- interval 3: from 3.0 to + The second argument holds three expressions, each valid in the sequence of the respective interval defined above. The third argument specifies the variable input (time in this case). Printing the expression object provides insight into the conditional expression created with these inputs.
Methods
allgridwrite
This methods evaluates an expression on a 3D rectilinear grid and writes the evaluated data to the filename
in an x-major order.
The points of the rectilinear grid are found in the physreg
.
The X,Y,Z limits of the rectilinear grid is defined by the argument bounds
.
The number of grid points in X,Y,Z direction is provided in the numsamples
argument.
If a grid point cannot be found (because it is outside of physreg
or because the interpolation algorithm fails
to converge, as can happen on curved 3D elements) then an error occurs if errorifnotfound
argument is set to True.
If it is set to False, the evaluation of the expression at any non-found grid point is zero, without raising an error.
Example
See Also
allintegrate
This is a collective MPI operation and hence must be called by all ranks. This integrates an
expression over a physical region across all the DDM ranks. Integrate expression(1)
to calculate volume/area/length.
For axisymmetric problems, the value returned is the integral of the requested expression times the
coordinate change Jacobian. In the case of axisymmetry, the volume/area/length of the 3D shape corresponding to the
physical region on which to integrate can be obtained by integrating expression(1)
and multiplying the output
by .
Example 1: allintegrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: allintegrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
allinterpolate
This is a collective MPI operation and hence must be called by all ranks. Its functionality is as described in
expression.interpolate()
but considers the physical region partitioned across the DDM ranks. The argument must
xyzcoord
be the same for all ranks.
Example 1: allinterpolate(physreg:int, xyzcoord:List[double])
This interpolates the expression at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated expression values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 2: allinterpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
An expression can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
expression.interpolate()
, expression.alllineinterpolate()
alllineinterpolate
This is a collective MPI operation and hence must be called by all ranks. This method interpolates the
expression at a series of points along a line inside a physreg
. The line for interpolation is defined
by a starting and an end point whose [x,y,z] coordinates are provided in the firstcoords
and lastcoords
arguments.
The numsamples
argument determines the number of sample points considered along the line.
If a requested interpolation point along the line cannot be found (because it is outside of physreg
or because the interpolation algorithm fails to converge, as can happen on curved 3D elements) then an
error occurs if errorifnotfound
argument is set to True. If it is set to False, the value returned at
any non-found coordinate is zero, without raising an error.
This method in combination with setoutputvalue()
is used to make line plots in post-processing.
Example
See Also
expression.interpolate()
, expression.allinterpolate()
, setoutputvalue()
allmax
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the maximum value of an expression computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: allmax(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate maximum value, but
at an increased computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to
the position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax, ycoordmax, zcoordmax] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the maximum value.
Example 2: allmax(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
expression.allmin()
, expression.min()
, expression.max()
allmin
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the minimum value of an expression computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: allmin(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate minimum value, but
at an increased computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to
the position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin, ycoordmin, zcoordmin] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the minimum value.
Example 2: allmin(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The minimum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The minimum location and the delimiting box are on the undeformed mesh.
See Also
expression.allmax()
, expression.max()
, expression.min()
alltimeinterpolate
at
This returns the entry at the requested row and column.
Example
atbarycenter
This outputs a vec
object whose structure is based on the field argument onefield
and which contains the expression
evaluated at the barycenter of each reference element of physical region physreg
. The barycenter of the reference element
might not be identical to the barycenter of the actual element in the mesh (for curved elements, for general quadrangles,
hexahedra and prisms). The evaluation at barycenter is constant on each mesh element.
Example
countcolumns
This counts the number of columns in an expression.
Example
countrows
This counts the number of rows in an expression.
Example
evaluate
This evaluates a scalar, space-independent expression.
Example
evaluateharmonics
getcolumn
This returns for a matrix expression the column corresponding to the specified input index colnum
.
Example
getrow
This returns for a matrix expression the row corresponding to the specified input index rownum
.
Example
integrate
This integrates an expression over a physical region. Integrate expression(1)
to calculate volume/area/length.
For axisymmetric problems, the value returned is the integral of the requested expression times the
coordinate change Jacobian. In the case of axisymmetry, the volume/area/length of the 3D shape corresponding to the
physical region on which to integrate can be obtained by integrating expression(1)
and multiplying the output
by .
Example 1: allintegrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: allintegrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
interpolate
This interpolates the expression at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated expression values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 1: interpolate(physreg:int, xyzcoord:List[double])
Example 2: interpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
An expression can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
expression.allinterpolate()
, expression.alllineinterpolate()
isscalar
This returns True if the expression is a scalar (i.e. has a single row and column).
Examples
iszero
This returns True if all the entries in the expression is zero, otherwise False.
Examples
max
This returns a list with its first element containing the maximum value of an expression computed over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: max(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate maximum value, but
at an increased computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to
the position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax, ycoordmax, zcoordmax] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the maximum value.
Example 2: max(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
expression.min()
, expression.allmax()
, expression.allmin()
min
This returns a list with its first element containing the minimum value of an expression computed over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: min(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate minimum value, but
at an increased computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to
the position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin, ycoordmin, zcoordmin] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the minimum value.
Example 2: min(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The minimum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
expression.max()
, expression.allmax()
, expression.allmin()
print
This prints the expression to the console.
Example
reordercolumns
This reorders the columns of a matrix expression in the specified order neworder
.
Example
reorderrows
This reorders the rows of a matrix expression in the specified order neworder
.
Example
resize
This resizes an expression. Any newly created expression entry is set to zero.
Example
reuseit
In case an expression appears multiple times, say in a formulation, and requires much time to compute, then the
expression can be reused by calling this method and setting istobereused=True
. With this, the expression is computed
only once to assemble a formulation block and reused as long as its value remains changed.
Example
rotate
This rotates a given expression by ax
, ay
and az
angles about x, y, z axis respectively.
Let us call (3x3) the classical 3D rotation matrix used in the transformation of expression written in tensorial form and (6x6) the rotation matrix used in the transformation of expression written in Voigt form. For example, the mechanical stress tensor in Voigt form = () is rotated as . Matrix is orthogonal ( = ) but matrix is not orthogonal ().
This function left-multiplies the calling expression by lefttop
and right-multiplies it by righttop
(if any) -
these arguments depend on the definition of the physics.
Options for lefttop
/righttop
are , , , -, -, , , -, -
respectively for a left/right multiplication by nothing , , , , , , , . The function can
be called without providing the string argument (default) to rotate 3x3 tensors and 3x1 vectors (both with the x,y,z component
ordering).
The stress tensor in Voigt form is rotated as while the strain tensor in Voigt form is rotated as . The rotation of strain Voigt form is different from the stress because of the factor added to the off-diagonal strain terms. In any case = . Denoting the rotated quantities with a prime symbol `, one can deduce as an illustration the rotation formulas below.
In Voigt notation, the rotation of stress tensor and strain tensor is:
The elasticity matrix is such that and thus,
Similarly, the compliance matrix C is such that and thus,
The 6x3 piezoelectric coupling matrix [] relating the electric field to induced stress is such that and with rotated electric field relation , we have:
Example
streamline
This follows and writes to disk all paths tangent to the expression vector that are starting at a set of points whose
, and coordinates are provided in startcoords
. These coordinates can for example be obtained via .getcoords()
on a shape object. A fourth-order Runge-Kutta algorithm is used. The stepsize
argument is related to the distance between
two vector direction updates; decrease it to more accurately follow the paths. The paths will be followed as long as they
remain in the physical region physreg
. In case the vector norm is zero somewhere on the paths or a path is a closed loop then
the function might enter an infinite loop and never return.
To use this function on closed loops (for example to get magnetic field lines of a permanent magnet) a solution is to
break the loops by excluding the permanent magnet domain from the physical region (selectexclusion
) function can be called
for that) and set the starting coordinates on the boundary of the magnet.
Example
write
This evaluates an expression in the physical region physreg
and writes it to the file filename
. The
lagrangeorder
is the order of interpolation for evaluation of the expression.
Examples
In the example below, an additional integer input is passed in the second argument. The here means that the expression is treated as multi-harmonic, nonlinear in time variable and an FFT is performed to get the first harmonics. All harmonics whose magnitude is above a threshold are saved with β_harm iβ extension (except for time-constant harmonic).
In the example below, an additional integer input is instead passed as the last argument posterior to the
interpolation order argument. This represents that numtimesteps
(default=-1). For a positive value of , the
multi-harmonic expression is saved at equidistant timesteps in the fundamental period and can then be
visualized in time.
The expressions can also be evaluated and written on a mesh deformed by a field. If field βvβ is the deformed mesh, then:
Class: field
The field object holds the information of the finite element fields. The field object itself only holds a pointer to a βrawfieldβ object.
Examples
Example 1: field(fieldtypename:str)
This creates a field object with the specified shape functions. The full list of shape functions available are:
- Nodal shape functions βh1β e.g. for electrostatic potential and acoustic or fluid pressure.
- Two-components nodal shape functions βh1xyβ e.g. for 2D mechanical displacements and 2D fluid velocity.
- Three-components nodal shape functions βh1xyzβ e.g. for 3D mechanical displacements and 3D fluid velocity.
- Nedelecβs edge shape functions βhcurlβ e.g. for the electric field in the E-formulation of electromagnetic wave propagation (here order 0 is allowed).
- βoneβ, one0β, one1β, one2β, one3β (trailing βxyβ or βxyzβ allowed) shape functions have a single shape function equal to a constant one on respectively an n, 0, 1, 2, 3-dimensional element (n is the geometry dimension).
- βh1dβ, βh1d0β, βh1d1β, βh1d2β, βh1d3β (trailing βxyβ or βxyzβ allowed) shape functions are elementwise-βh1β shape functions that allow storing fields that are fully discontinuous between elements.
Additionally, types βxβ, βyβ and βzβ can be used to define the x, y and z coordinate fields.
Example 2: field(fieldtypename:str, harmonicnumbers:List[int])
Consider the infinite Fourier series of a field that is periodic in time:
where is the time variable, is the space variable and is the fundamental frequency of the periodic field. The coefficients only depend on the space variable, not on the time variables which have now moved to the sines and cosines. In the example above, field is a multi-harmonic βh1β type field that includes harmonic fields: the , , and fields in the truncated Fourier series above. All other harmonics in the infinite Fourier series are supposed to equal zero so that the field can be rewritten as:
This is the truncated multi-harmonic representation of field (which must be periodic in time). The following can be used to get the harmonic from field . It can then be used like any other field.
Example 3: field(fieldtypename:str, spantree:spanningtree)
This adds the spanning tree input argument needed when the field has to be gauged. (e.g. for the magnetic vector potential formulation of the magnetostatic problem in 3D).
Example 3: field(fieldtypename:str, harmonicnumbers:List[int], spantree:spanningtree)
This adds the spanning tree input argument needed when a field has to be gauged.
Methods
allintegrate
This is a collective MPI operation and hence must be called by all ranks. This integrates a field over a physical region across all the DDM ranks.
Example 1: allintegrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: allintegrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
allinterpolate
This is a collective MPI operation and hence must be called by all ranks. Its functionality is as described in
field.interpolate()
but considers the physical region partitioned across the DDM ranks. The argument xyzcoord
must be the same for all ranks.
Example 1: allinterpolate(physreg:int, xyzcoord:List[double])
This interpolates the field at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated field values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 2: allinterpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
A field can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
allmax
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the maximum value of a field computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: allmax(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in
each direction. Increasing the refinement will thus lead to a more accurate maximum value, but at an increased
computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to the
position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum
is always exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is
[xboxmin,xboxmax, yboxmin, yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax,
ycoordmax, zcoordmax] or an empty list if the physical region argument is empty or is not in the box provided. If the
argument defining the box is not provided, then the whole geometric region is considered for evaluating the maximum
value.
Example 2: allmax(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
field.max()
, field.min()
, field.allmin()
allmin
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the minimum value of a field computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: allmin(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in
each direction. Increasing the refinement will thus lead to a more accurate minimum value, but at an increased
computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to the
position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum
is always exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is
[xboxmin,xboxmax, yboxmin, yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin,
ycoordmin, zcoordmin] or an empty list if the physical region argument is empty or is not in the box provided. If the
argument defining the box is not provided, then the whole geometric region is considered for evaluating the minimum
value.
Example 2: allmin(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The min value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The min location and the delimiting box are on the undeformed mesh.
See Also
field.min()
, field.max()
, field.allmax()
alltimeinterpolate
atbarycenter
This outputs a vec
object whose structure is based on the field argument onefield
and which contains the field
evaluated at the barycenter of each reference element of physical region physreg
. The barycenter of the reference element
might not be identical to the barycenter of the actual element in the mesh (for curved elements, for general quadrangles,
hexahedra and prisms). The evaluation at barycenter is constant on each mesh element.
Example
automaticupdate
After this call, the field and all its subfields will have their value automatically updated after hp-adaptivity.
Example
See Also
comp
This gets the , or component of a field with subfields.
Example
compx
This gets the component of a field with multiple subfields.
Example
compy
This gets the component of a field with multiple subfields.
Example
compz
This gets the component of a field with multiple subfields.
Example
copy
cos
This gets the βh1xyzβ type field that is the harmonic at freqindex
times the fundamental frequency in field .
Example
See Also
countcomponents
This returns the number of components in the field.
Example
getharmonics
This returns the list of harmonics of the field object.
Example
getnodalvalues
This gets the values of a βh1β type field at a set of nodenumbers
.
Example
harmonic
This gets a βh1xyzβ type field that includes the harmonicnumber(s)
.
Examples
This gets a βh1xyzβ type field that includes the harmonicnumber(s)
.
Examples
integrate
This integrates a field over the physical region physreg
. For axisymmetric problems, the value returned is the
integral of the requested field times the coordinate change Jacobian.
Example 1: integrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: integrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
interpolate
This interpolates the field value at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated field values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 1: interpolate(physreg:int, xyzcoord:List[double])
Example 2: interpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
A field can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
loadraw
This loads the .slz file created with the writeraw
method. If the .slz file was written in the binary format then isbinary
argument
must be set to True else to False. The same mesh must be used when loading with loadraw
as the one that was used during
the corresponding writeraw
call.
Example
See Also
max
This returns a list with its first element containing the maximum value of a field computed over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: max(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in
each direction. Increasing the refinement will thus lead to a more accurate maximum value, but at an increased
computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to the
position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum
is always exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is
[xboxmin,xboxmax, yboxmin, yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax,
ycoordmax, zcoordmax] or an empty list if the physical region argument is empty or is not in the box provided. If the
argument defining the box is not provided, then the whole geometric region is considered for evaluating the maximum
value.
Example 2: max(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
field.min()
, field.allmax()
, field.allmin()
min
This returns a list with its first element containing the minimum value of a field computed over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: min(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in
each direction. Increasing the refinement will thus lead to a more accurate minimum value, but at an increased
computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to the
position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum
is always exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is
[xboxmin,xboxmax, yboxmin, yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin,
ycoordmin, zcoordmin] or an empty list if the physical region argument is empty or is not in the box provided. If the
argument defining the box is not provided, then the whole geometric region is considered for evaluating the minimum
value.
Example 2: min(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The min value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The min location and the delimiting box are on the undeformed mesh.
See Also
field.max()
, field.allmax()
, field.allmin()
noautomaticupdate
After this call, the field and all its subfields will not have their value automatically updated after hp-adaptivity. If the automatic update is not needed then this call is recommended to avoid a possible costly field value update.
Example
See Also
print
This prints the field name.
Example
printharmonics
This prints a string showing the harmonics in the field.
Example
setcohomologysources
This method assigns cohomology coefficients to the field. The field value is reset to zero on the cohomology regions before the coefficients are added on their respective regions.
Example
setconditionalconstraint
This forces the field value (i.e. Dirichlet constraint) on the region physreg
to a value valexpr
for all node-associated degrees of
freedom for which the condition condexpr
evaluates to greater than or equal to zero at the nodes. This should only be used for fields
with βh1β type functions.
Example 1: setconditionalconstraint(physreg: int, condexpr: expression, valexpr: expression)
The conditional expression is computed on the undeformed mesh.
Example 2: setconditionalconstraint(physreg: int, meshdeform: expression, condexpr: expression, valexpr: expression)
The conditional expression is computed on a mesh deformed by meshdeform
.
See Also
setconstraint
This forces the field value (i.e. Dirichlet condition) on the region physreg
to input
expression. An extra int argument extraintegrationdegree
can be used to increase or decrease the default integration order when computing the projection of the expression on the field.
Increasing it can give a more accurate computation of the expression but might take longer. The default integration order is equal
to βfield order β. Dirichlet constraints have priority over conditional constraints and gauge conditions.
Defining any of these on a Dirichlet constrained region has no effect.
Examples
Example 1: field.setconstraint(physreg:int, input:expression, extraintegrationdegree:int=0)
This forces the field value (i.e Dirichlet constraint) on region vol to input
expression (here ).
Example 2: field.setconstraint(physreg:int, meshdeform:expression, input:expression, extraintegrationdegree:int=0)
This forces the field value on region vol to input
expression (here ) but on a mesh deformed by meshdeform
.
Example 3: field.setconstraint(physreg:int, input:List[expression], input:expression, extraintegrationdegree:int=0)
This sets a Dirichlet constraint with the given value for each corresponding field harmonic.
Example 4: field.setconstraint(physreg:int, meshdeform:expression, input:List[expression], extraintegrationdegree:int=0)
This sets a Dirichlet constraint for each corresponding field harmonic with the given expression computed on a mesh deformed by meshdeform
.
Example 5: field.setconstraint(physreg:int, numfftharms:int, input:expression, extraintegrationdegree:int=0)
This calls an FFT for the calculation required for nonlinear multi-harmonic expressions. The FFT is computed at numfftharms
timesteps.
Example 6: field.setconstraint(physreg:int, numfftharms:int, meshdeform:expression, input:expression, extraintegrationdegree:int=0)
This calls an FFT for the calculation and the expression is evaluated on a mesh deformed by meshdeform
.
Example 7: field.setconstraint(physreg:int)
This forces the field value (i.e. Dirichlet condition) on region vol to .
See Also
field.setconditionalconstraint()
setdata
This either sets or adds the data in the vector to the field. If the argument op
is βsetβ, then the vector data is set and if it is
βaddβ then the vector data is added to the existing field values. This method only updates the corresponding field values.
If the formulation uses ports, then setdata()
method must be used to update port values from the solution vector.
Example
See Also
setgauge
This sets a gauge condition on regionphysreg
. It must be used e.g. for the magnetic vector potential formulation of the magnetostatic
problem in 3D since otherwise, the algebraic system to solve is singular. It is only defined for edge shape functions (βhcurlβ). Its
effect is to constrain to zero all degrees of freedom corresponding to:
- gradient type shape functions.
- lowest order edge-shape functions for all edges on the spanning tree provided.
Example
setname
This gives a name to the field. Useful when printing expressions including fields.
setnodalvalues
This sets the values of a βh1β type field at a set of nodenumbers
to values
.
Example
setorder
This sets the specified interpolation order of the field object.
Examples
Example 1: field.setorder(physreg:int, interpolorder:int)
This sets the interpolation order to on the physical region βvolβ. When using different interpolation orders on different physical regions for a given field it is only allowed to set the interpolation orders in a decreasing way. i.e starting with the physical region with the highest order and ending with the physical region with the lowest order. This is required to enforce field continuity and is due to the fact the interpolation order on the interface between multiple physical regions must be the one of lowest touching region.
Example 2: field.setorder(criterion:expression, loworder:int, highorder:int)
In the above example, the field interpolation order will be adapted on each mesh element (of the entire geometry) based on the value of a positive criterion (p-adaptivity). The max range of the criterion is split into a number of intervals equal to the number of orders in range βloworderβ to βhighorderβ. All intervals have the same size. The barycenter value of the criterion on each mesh element is considered to select the interval, and therefore the corresponding interpolation order to assign to the field on each element. As an example, for a criterion with the highest value of 900 over the entire domain and a low/high order requested of 1/3 the field on elements with criterion values in range 0 to 300, 300 to 600, 600 to 900 will be assigned order 1, 2, 3 respectively.
Example 3: field.setorder(targeterror:double, loworder:int, highorder:int, absthres:double)
The field interpolation order will be adapted on each mesh element (of the entire geometry) based on a criterion measuring the Legendre expansion decay. The target error gives the fraction of the total shape function weight that does not need to be captured. The low order is used on all elements where the total weight is lower than the absolute threshold provided.
setpatternedport
setport
This function associates a primal-dual pair of ports to the field on the requested physical region. As a side effect, it lowers the field order on that region to the minimum possible. Ports have priority over Dirichlet constraints, conditional constraints and gauge conditions}. Defining any of these on a port region has no effect.
Ports that have been associated to a field with a setport call and unassociated ports are visible to a formulation only if they appear in a port relation (in the example below: electrokinetic += I - 1.0 ). The primal and dual of associated ports are always made visible together even if only of them appears in a port relation. Unassociated ports are not connected to the weak form terms: the primal can be used as the lumped field value on the associated region while the dual can be used as the total contribution over that region of the Neumann term in the formulation. The field value is considered constant by the formulation over the region of each associated port visible to it.
To illustrate the meaning of the dual port let us consider the below DC current flow simulation example code. The strong form to solve is
where is the electric conductivity and is the electric potential field. The corresponding weak form is
which after integration by parts can be rewritten as
where,
- is the boundary of ,
- is the unit normal pointing outward from and
- .
The Neumann term is the second term of the weak formulation. The dual port in the below example, therefore equals the total current flowing through the electrode and thus can be used to impose a total current source condition on the electrode. More details about the associated mathematics can be found in the paper βCoupling of local and global quantities in various finite element formulations and their application to electrostatics, magnetostatics and magnetodynamicsβ, Dular et al.
Example
setupdateaccuracy
This method allows tuning the integration order in the projection used to update the field value after hp-adaptivity. A positive/negative argument increases/decreases the accuracy but slowsdown/speeds up the update.
Example
setvalue
This sets the field value on the region physreg
to input
expression. An extra int argument extraintegrationdegree
can be used to increase or decrease the default integration order when computing the projection of the expression on the field.
Increasing it can give a more accurate computation of the expression but might take longer. The default integration order is equal
to βfield order β.
Examples
Example 1: field.setvalue(physreg:int, input:expression, extraintegrationdegree:int=0)
This sets the field value on region vol to .
Example 2: field.setvalue(physreg:int, meshdeform:expression, input:expression, extraintegrationdegree:int=0)
This sets the field value on region vol to expression but on a mesh deformed by meshdeform
.
Example 3: field.setvalue(physreg:int, numfftharms:int, input:expression, extraintegrationdegree:int=0)
This calls an FFT for the calculation required for nonlinear multi-harmonic expressions. The FFT is computed at numfftharms
timesteps.
Example 4: field.setvalue(physreg:int, numfftharms:int, meshdeform:expression, input:expression, extraintegrationdegree:int=0)
This calls an FFT for the calculation and the expression is evaluated on a mesh deformed by meshdeform
.
Example 5: field.setvalue(physreg:int)
This sets the field value on region vol to .
sin
This gets the βh1xyzβ type field that is the harmonic at freqindex
times the fundamental frequency in field .
Example
See Also
write
This evaluates a field in the physical region physreg
and writes it to the file filename
. The
lagrangeorder
is the order of interpolation for the evaluation of the field values.
Examples
In the example below, an additional integer input is passed in the second argument. The here means that the field is treated as multi-harmonic, nonlinear in time variable and an FFT is performed to get the first harmonics. All harmonics whose magnitude is above a threshold are saved with β_harm iβ extension (except for time-constant harmonic).
In the example below, an additional integer input is instead passed as the last argument posterior to the
interpolation order argument. This represents that numtimesteps
(default=-1). For a postive value of , the
multi-harmonic field is saved at equidistant timestpes in the fundamental period and can then be
visualized in time.
The field can also be evaluated and written on a mesh deformed by a field. If field βvβ is the deformed mesh, then:
writeraw
This writes a (possibly multi-harmonic) field on a given region to disk in the compact .slz sparselizard format. If
isbinary=False
the output format is in ASCII and with isbinary=True
the output is in binary format. In the latter case,
the .slz.gz extension can also be used to write to gz compressed -slz format (the most compact version). While the binary file
is more compact on disk it might be less portable across different platforms than the ASCII version.
The last input argument allows storing extra data (timestep, parameter values, ..) that can be loaded back from the
loadraw
output.
Example
See Also
Class: formulation
The formulation object holds the port relations and the weak form terms of the problem to solve.
The following creates an empty formulation object:
Using the +=
operator, a port relation can be added to the formulation or can be coupled to weak-form terms.
Examples
Adding a port relation to the formulation: formulation.operator+=(integrationobject: expression)
Adding a weak form term to the formulation: formulation.operator+=(integration integrationobject)
. All terms are
added together and their sum equals zero. There are twelve += calls that are listed below.
Basic version
In the following, the term is assembled for unknowns (dofs) and test functions (tf). The first argument vol is the element
integration region. Hence, the assembly is for integration on all elements in the region vol. When no region is specified
for the dof()
or tf()
then the element integration region (vol in this case) is used by default.
In the following, the unknowns (dofs) are defined on region vol while the test functions are defined only on region sur. In the third argument, an extra integer is added. This specifies the extra number that should be added to the default integration order to perform the numerical integration in the assembly process. The default integration order is equal to (the order of the unknown + order of the test function + 2). In case there is no unknown then it is equal to (order of the test function x 2 + 2). By increasing the order a more accurate assembly can be obtained, at the expense of an increased assembling time.
Each weak form term can be assigned a contribution number or block number. The default value is . In the below example, it is set to . This can be of interest when the formulation is generated since one can choose exactly which block numbers to generate and which ones to not generate.
Assemble on the mesh deformed by field Assembly of weak form terms can also be performed on the deformed mesh by providing an additional field input as the second argument. The following shows the previous 3 examples but with the assembly performed on the mesh deformed by field .
Assemble with a call to FFT to compute the first 20 harmonics If the additional input in the second argument is a positive integer a Fast Fourier Transform (FFT) is called during the assembly and the first 20 harmonics will be computed. The harmonics whose magnitude is below a threshold are disregarded. This must be called when assembling a multi-harmonic formulation term that is nonlinear in the time variable.
Assemble with a call to FFT to compute the first 20 harmonics on the mesh deformed by field Assembly of a multi-harmonic formulation can be performed on the deformed mesh by providing the field input in the third argument.
Methods
A
This gives the matrix (of ) that was assembled during the formulation.generate()
call. By default the keepfragments
argument is False which means that the generated matrix is no longer kept in the formulation after returning it to a mat
object.
However, if you select True for keepfragments
it means the generated matrix is kept in the formulation and will be added to the
matrix assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.rhs()
, formulation.b()
C
This gives the damping matrix that was assembled during the formulation.generate()
call. The damping matrix is a
matrix that is assembled with only those terms in the formulation which have a dof and that dof has a first-order time
derivative applied to it (i.e ). For multi-harmonic simulations damping matrix is empty.
By default, the keepfragments
argument is False which means that the generated matrix is no longer kept in the formulation after
returning it to a mat
object. However, if you select True for keepfragments
it means the generated matrix is kept in the
formulation and will be added to the matrix assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.K()
, formulation.M()
K
This gives the stiffness matrix that was assembled during the formulation.generate()
call. The stiffness matrix is a
matrix that is assembled with only those terms in the formulation which have a dof and that dof has no time derivative applied
to it. For multi-harmonic formulations, the stiffness matrix holds the assembly of all the terms.
By default, the keepfragments
argument is False which means that the generated matrix is no longer kept in the formulation after
returning it to a mat
object. However, if you select True for keepfragments
it means the generated matrix is kept in the
formulation and will be added to the matrix assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.C()
, formulation.M()
M
This gives the mass matrix that was assembled during the formulation.generate()
call. The mass matrix is a
matrix that is assembled with only those terms in the formulation which have a dof and that dof has a second-order
time derivative applied to it (i.e ). For multi-harmonic simulations mass matrix is empty.
By default, the keepfragments
argument is False which means that the generated matrix is no longer kept in the formulation after
returning it to a mat
object. However, if you select True for keepfragments
it means the generated matrix is kept in the
formulation and will be added to the matrix assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.K()
, formulation.C()
allcountdofs
This is a collective MPI operation and hence must be called by all the ranks. It returns on every rank the global number of degrees of freedom defined in the scattered formulation. The count is exact if for each field the number of unknowns associated to each element matches across touching ranks. It is an estimation otherwise.
Example
See Also
allneumann
allsolve
This is a collective MPI operation and hence must be called by all the ranks. This solves the formulation on all the ranks using DDM. The initial solution is taken from the fieldsβ state. The relative residual history is returned. This method can be used for both linear and nonlinear problems.
Examples
Example 1: formulation.allsolve(relrestol:double, maxnumit:int, soltype:str="lu", verbosity:int=1)
This is used for linear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iterations stop if either relative residual tolerance is less than relrestol
or if the number of DDM iteration
reaches maxnumit
.
Example 2: formulation.allsolve(relrestol:double, maxnumit:int, nltol:double, maxnumnlit:int, relaxvalue:double=1, soltype:str="lu", verbosity:int=1)
This is used for nonlinear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iteration stops if either relative residual tolerance is less than relrestol
or if the number of DDM iterations reaches
maxnumit
. A nonlinear fixed-point iteration is performed for at most maxnumnlit
or until the relative error (norm of relative
solution vector change) is smaller than the tolerance prescribed in nltol
. A relaxation value can be provided with relaxvalue
argument. Usually, a relaxation value less than (under-relaxation) is used to avoid divergence of a solution.
b
This returns the rhs vector that was assembled during the formulation.generate()
call. By default the keepvector
argument
is False which means that the generated rhs vector is no longer kept in the formulation after returning it to a vec
object.
However, if you select True for keepvector
it means the generated rhs vector is kept in the formulation and will be added to
the rhs vector assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.rhs()
, formulation.A()
countdofs
This returns the number of degrees of freedom defined in the formulation.
Example
See Also
generate
This assembles all the terms in the formulation.
Examples
A block number can be passed as an argument to generate only the necessary terms in the formulation. For example, the following generates only the block number 2. (i.e the first integral term)
A list of block numbers can also be passed as an argument. For example, the following generates all terms with block numbers 0 and 2. For this formulation, it means all terms are generated since these are the only block numbers existing. and 0 (default) block numbers.
See Also
formulation.generatestiffnessmatrix()
, formulation.generatedampingmatrix()
, formulation.generatemassmatrix()
, formulation.rhs()
generatedampingmatrix
This assembles only those terms in the formulation which have a dof and that dof has a first-order time derivative applied to it (i.e ). For multi-harmonic simulations, it generates nothing.
Example
See Also
formulation.generate()
, formulation.generatestiffnessmatrix()
, formulation.generatemassmatrix()
, formulation.rhs()
generatemassmatrix
This assembles only those terms in the formulation which have a dof and that dof has a second-order time derivative applied to it (i.e ). For multi-harmonic formulations, it generates nothing.
Example
See Also
formulation.generate()
, formulation.generatestiffnessmatrix()
, formulation.generatedampingmatrix()
, formulation.rhs()
generaterhs
This assembles only the terms in the formulation which have no dof.
Example
See Also
formulation.generate()
, formulation.generatestiffnessmatrix()
, formulation.generatedampingmatrix()
, formulation.generatemassmatrix()
generatestiffnessmatrix
This assembles only those terms in the formulation which have a dof and that **dof has no time derivative applied to it. For multi-harmonic formulations it generates all the terms.
Example
See Also
formulation.generate()
, formulation.generatedampingmatrix()
, formulation.generatemassmatrix()
, formulation.rhs()
getmatrix
Depending on KCM
argument value, it returns the corresponding matrix as follows:
- , returns the stiffness matrix
- , returns the damping matrix
- , returns the mass matrix
By default, the keepfragments
argument is False which means that the generated matrix is no longer kept in the formulation after
returning it to a mat
object. However, if you select True for keepfragments
it means the generated matrix is kept in the
formulation and will be added to the matrix assembled in any subsequent formulation.generate()
call.
Example
See Also
formulation.K()
, formulation.C()
, formulation.M()
lump
This defines one lumped field for each requested physical region in physreg
.
If harmonicnumbers
is nonempty, the fields are all defined with these harmonics.
Example
See Also
rhs
This returns the rhs vector that was assembled during the formulation.generate()
call. By default the keepvector
argument
is False which means that the generated rhs vector is no longer kept in the formulation after returning it to a vec
object.
However, if you select True for keepvector
it means the generated rhs vector is kept in the formulation and will be added to
the rhs vector assembled in any subsequent formulation.generate()
call. This is the same as formulation.b()
.
Example
See Also
formulation.b()
, formulation.A()
solve
This generates the formulation, solves the algebraic problem with a direct solver then saves all the data in vector to the fields defined in the formulation.
The direct solver type can be set to βluβ or βcholeskyβ through the soltype
argument. If the diagscaling
is set to True, then the diagonal
scaling preconditioning is applied. The blockstoconsider
is a list of integral blocks considered for solving. Default is - meaning all the
blocks are considered.
Example
Class: genalpha
This defines the genalpha timestepper object to solve in time the formulation formul
with the fieldsβ state as an initial solution
for , dtxinit
for , dtdtxinit
for . The isrhskcmconstant
list can be used to specify whether
the RHS vector, K matrix, C matrix and M matrix are constant in time or not. However, this argument is optional and
need not be provided by the user: in which case the timestepper algorithm automatically determines
at each timestep whether the correponding vector/matrix is constant in time or not. If constant, the generated vector/matrix
are reused, otherwise, they are regenerated again at each timestep. If the K, C and M matrices are constant in time, the
factorization of the algebraic problem is also reused.
The user has the flexibility to specify the verbosity
and isrhskcmconstant
argument. For example:
The boolean argument in rhskcconstant[i]
:
- corresponds to the rhs vector
- corresponds to the K matrix
- corresponds to the C matrix
- corresponds to the M matrix
The genalpha object allows performing a generalized alpha time resolution for a problem of the form , be it linear or nonlinear. The solutions for as well as and are made available. For nonlinear problems, a fixed-point iteration is performed at every timestep until the relative error (norm of relative solution vector change) is less than the prescribed tolerance.
The generalized alpha method comes with four parameters (, , and ) that can be tuned to adjust the properties of the time resolution method (convergence order, stability, high frequency, damping and so on). When both parameters are set to zero, a classical Newmark iteration is obtained. By default, the parameters are set to (, , and ) which corresponds to an unconditionally stable Newmark iteration.
A convenient way proposed to set the four parameters is to specify a high-frequency dissipation level and let the four parameters be deduced accordingly. This gives a set of parameters leading to an unconditionally stable, second-order accurate algorithm possessing an optimal combination of high-frequency and low-frequency dissipation. More information on the generalized alpha method can be found in the paper A time integration algorithm for structural dynamics with improved numerical dissipation: the generalized-alpha method.
Note that even if the rhs vector can be reused the Dirichlet constraints will nevertheless be recomputed at each timestep.
Methods
allnext
This is a collective MPI operation and hence must be called by all ranks. It is similar to the genalpha.next()
function
but the resolution is performed on all ranks using DDM. This method runs the generalized alpha algorithm for one timestep. After
the call, the time and field values are updated on all the DDM ranks. This method can be used for both linear and nonlinear
problems.
Examples
Example 1: genalpha.allnext(relrestol: double, maxnumit: int, timestep: double)
This is used for linear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iterations stop if either relative residual tolerance is less than relrestol
or if the number of DDM iterations
reaches maxnumit
. Use timestep=-1
for automatic time adaptivity.
Example 2: genalpha.next(relrestol: double, maxnumit: int, timestep: double, maxnumnlit:int)
This is used for nonlinear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iteration stops if either relative residual tolerance is less than relrestol
or if the number of DDM iterations reaches
maxnumit
. A nonlinear fixed-point iteration is performed for at most maxnumnlit
or until the relative error (norm of relative
solution vector change) is smaller than the tolerance prescribed in genalpha.settolerance()
. Set timestep=-1
for automatic
time-adaptivity and maxnumnlit=-1
for unlimited nonlinear iterations. This method returns the number of nonlinear iterations
performed.
See Also
count
This counts the total number of steps computed.
gettimederivative
This returns a list containing current time derivative solutions. The first element in the list contains the solution of the first time derivative and the second element contains the solution of the second time derivative .
See Also
gettimes
This returns all the time values stepped through.
gettimestep
This returns the current timestep.
isrhskcmreusable
This returns a list of booleans that provides information about the reusability of the rhs vector, K matrix, C matrix and M matrix. They are usually resuable if constant in time otherwise must be regenerated.
Example
next
This runs the generalized alpha algorithm for one timestep. After the call, the time and field values are updated. This method can be used for both linear and nonlinear problems.
Examples
Example 1: genalpha.next(timestep: double)
This is used for linear problems. Use - for automatic time-adaptivity.
Example 2: genalpha.next(timestep: double, maxnumnlit:int)
This is used for nonlinear problems. A nonlinear fixed-point iteration is performed for at most maxnumnlit
or until the
relative error (norm of relative solution vector change) is smaller than the tolerance prescribed in genalpha.settolerance()
.
Set timestep=-1
for automatic time-adaptivity and maxnumnlit=-1
for unlimited nonlinear iterations. This method
returns the number of nonlinear iterations performed.
postsolve
This defines the set of formulations that must be solved every resolution of the formulation provided to the genalpha constructor. The formulations provided here must lead to a system of the form (no damping or mass matrix allowed).
See Also
presolve
This defines the set of formulations that must be solved every resolution of the formulation provided to the genalpha constructor. The formulations provided here must lead to a system of the form (no damping or mass matrix allowed).
See Also
setadaptivity
This sets the configuration for automatic time adaptivity. The timestep will be adjusted between the minimum
timestep mints
and maximum timesteps maxts
to reach the requested relative error tolerance tol
. To measure the relative
deviation from a constant time derivative, the relative error is defined as
Arguments reffact
and coarfact
give the factor to use when the time step is refined or coarsened respectively.
The timestep is refined when the relative error is above tol
or when the maximum number of nonlinear iterations is reached.
The timestep is coarsened when the relative error is below the product coarthes
tol
and the nonlinear loop has
converged in less than the maximum number of iterations.
setparameter
This is used to set the parameters of the generalized alpha method.
To set the four parameters (, , and ), four arguments are passed, one for each parameter:
To set the high-frequency dissipation (), only one argument is passed:
The range of high-frequency dissipation is in the range . The four generalized alpha parameters are optimally deduced from (). The deduced parameters lead to an unconditionally stable, second-order accurate algorithm possessing an optimal combination of high-frequency and low-frequency dissipation. Lower () values lead to more dissipation.
setrelaxationfactor
This sets the relaxation factor for the fixed-point nonlinear iteration performed at every timestep for nonlinear problems. If the relaxation factor is not set, the default value of is set. If is the solution obtained at a current iteration, is solution at previous iteration, then the new solution at the current iteration is updated as
where is the relaxation factor.
Example
See Also
genalpha.settolerance()
, genalpha.setverbosity()
settimederivative
This sets the current solution for the time derivatives and to sol[0]
and sol[1]
respectively.
See Also
settimestep
This sets the current timestep.
settolerance
This sets the tolerance for the fixed-point nonlinear iteration performed at every timestep for nonlinear problems. If the tolerance is not set, the default value of is considered.
Example
See Also
genalpha.setrelaxationfactor()
, genalpha.setverbosity()
setverbosity
This sets the verbosity level. For debugging, higher verbosity is recommended. If the verbosity is not set, the default value of is considered.
Example
See Also
genalpha.setrelaxationfactor()
, genalpha.settolerance()
Class: grid
A grid object allows multivariate interpolation in a rectilinear grid data using bilinear interpolation (for two variates)
and trilinear interpolation (for three variates). For single variate interpolation refer spline
class.
Example
The above example corresponds to a rectilinear grid data where the function βfβ value depends on two variates
βaβ and βbβ. The grid object expects that gridticks
are sorted in ascending order and thegridvalues
are
provided in a-major order as depicted in the image below. Therefore, the first entry corresponds to the variate
pair (0,0), the second entry corresponds to the variate pair (0,0.75) and so on.
A grid data can be read from a text file. The text file containing the data must be in the following format:
Methods
countvariables
This returns the number of variates in the rectilinear grid data.
Example
evalat
For a rectilinear grid object, this method returns interpolated values at given input point(s).
Examples
To interpolate at a single evaluation point:
To interpolate at multiple evaluation points, the evaluation points are passed as a densemat object.
- number of rows of densemat = number of evaluation points.
- number of cols of densemat = number of variates in the rectilinear grid.
Check densemat
for reference.
getgridmaxs
This returns a list of maximum value of each variate in the rectilinear grid data. The length of the list is equal to the number of variates.
Example
See Also
getgridmins
This returns a list of minimum value of each variate in the rectilinear grid data. The length of the list is equal to the number of variates.
Example
See Also
set
This method defines a grid object based on the gridticks
and gridvalues
provided.
Example
See Also
write
This writes to the file the original rectilinear grid data.
Example
The grid data are written to the file in a certain format. For the above example, the written file is as shown in the image below (but without the comments).
See Also
Class: impliciteuler
This defines the impliciteuler timestepper object to solve in time the formulation formul
with the fieldsβ state as an initial
solution for and dtxinit
for . The isrhskcconstant
list can be used to specify whether the RHS vector,
K matrix and C matrix are constant in time or not. However, this argument is optional and need not be provided
by the user: in which case the timestepper algorithm automatically determines at each timestep
whether the correponding vector/matrix is constant in time or not. If constant, the generated vector/matrix are reused,
otherwise, they are regenerated again at each timestep. If the K and C matrices are constant in time, the factorization
of the algebraic problem is also reused.
The user has the flexibility to specify the verbosity
and isrhskcconstant
argument. For example:
The boolean argument in rhskcconstant[i]
:
- corresponds to the rhs vector
- corresponds to the K matrix
- corresponds to the C matrix
The impliciteuler object allows performing an implicit (backward) Euler time resolution for a problem of the form , be it linear or nonlinear. The solutions for , as well as , are made available. For nonlinear problems, a fixed-point iteration is performed at every timestep until the relative error (norm of relative solution vector change) is less than the prescribed tolerance. Note that even if the rhs vector can be reused the Dirichlet constraints will nevertheless be recomputed at each timestep.
Methods
allloadstate
allnext
This is a collective MPI operation and hence must be called by all ranks. It is similar to the impliciteuler.next()
function
but the resolution is performed on all ranks using DDM. This method runs the implicit Euler algorithm for one timestep. After
the call, the time and field values are updated on all the DDM ranks. This method can be used for both linear and nonlinear
problems.
Examples
Example 1: impliciteuler.allnext(relrestol: double, maxnumit: int, timestep: double)
This is used for linear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iterations stop if either relative residual tolerance is less than relrestol
or if the number of DDM iterations
reaches maxnumit
. Use timestep=-1
for automatic time adaptivity.
Example 2: impliciteuler.next(relrestol: double, maxnumit: int, timestep: double, maxnumnlit:int)
This is used for nonlinear problems. The relrestol
and maxnumit
arguments correspond to the stopping criteria for DDM solver.
The DDM iteration stops if either relative residual tolerance is less than relrestol
or if the number of DDM iterations reaches
maxnumit
. A nonlinear fixed-point iteration is performed for at most maxnumnlit
or until the relative error (norm of relative
solution vector change) is smaller than the tolerance prescribed in impliciteuler.settolerance()
. Set timestep=-1
for automatic
time-adaptivity and maxnumnlit=-1
for unlimited nonlinear iterations. This method returns the number of nonlinear iterations
performed.
See Also
allsavestate
count
This counts the total number of steps computed.
gettimederivative
This returns the current solution for the first time derivative .
See Also
impliciteuler.settimederivative()
gettimes
This returns all the time values stepped through.
gettimestep
This returns the current timestep.
isrhskcreusable
This returns a list of booleans that provides information about the reusability of the rhs vector, K matrix and C matrix. They are usually resuable if constant in time otherwise must be regenerated.
Example
next
This runs the implicit Euler algorithm for one timestep. After the call, the time and field values are updated. This method can be used for both linear and nonlinear problems depending on the number of arguments passed.
Examples
Example 1: implicit.next(timestep: double)
This is used for linear problems. Use - for automatic time-adaptivity.
Example 2: implicit.next(timestep: double, maxnumnlit:int)
This is used for nonlinear problems. A nonlinear fixed-point iteration is performed for at most maxnumnlit
or until the
relative error (norm of relative solution vector change) is smaller than the tolerance prescribed in impliciteuler.settolerance()
.
Set timestep=-1
for automatic time-adaptivity and maxnumnlit=-1
for unlimited nonlinear iterations. This method
returns the number of nonlinear iterations performed.
postsolve
This defines the set of formulations that must be solved every resolution of the formulation provided to the impliciteuler constructor. The formulations provided here must lead to a system of the form (no damping or mass matrix allowed).
See Also
presolve
This defines the set of formulations that must be solved every resolution of the formulation provided to the impliciteuler constructor. The formulations provided here must lead to a system of the form (no damping or mass matrix allowed).
See Also
setadaptivity
This sets the configuration for automatic time adaptivity. The timestep will be adjusted between the minimum
timestep mints
and maximum timesteps maxts
to reach the requested relative error tolerance tol
. To measure the relative
deviation from a constant time derivative, the relative error is defined as
Arguments reffact
and coarfact
give the factor to use when the time step is refined or coarsened respectively.
The timestep is refined when the relative error is above tol
or when the maximum number of nonlinear iterations is reached.
The timestep is coarsened when the relative error is below the product coarthes
tol
and the nonlinear loop has
converged in less than the maximum number of iterations.
setrelaxationfactor
This sets the relaxation factor for the fixed-point nonlinear iteration performed at every timestep for nonlinear problems. If the relaxation factor is not set, the default value of is set. If is the solution obtained at a current iteration, is solution at previous iteration, then the new solution at the current iteration is updated as
where is the relaxation factor.
Example
See Also
impliciteuler.settolerance()
, impliciteuler.setverbosity()
settimederivative
This sets the current solution for the first time derivatives to sol[0]
.
See Also
impliciteuler.gettimederivative()
settimestep
This sets the current timestep.
settolerance
This sets the tolerance for the fixed-point nonlinear iteration performed at every timestep for nonlinear problems. If the tolerance is not set, the default value of is considered.
Example
See Also
impliciteuler.setrelaxationfactor()
, impliciteuler.setverbosity()
setverbosity
This sets the verbosity level. For debugging, higher verbosity is recommended. If the verbosity is not set, the default value of is considered.
Example
See Also
impliciteuler.setrelaxationfactor()
, impliciteuler.settolerance()
Class: indexmat
The indexmat
object stores a row-major array of integers that corresponds to a dense matrix.
For storing an array of doubles, see densemat
object.
Examples
There are many ways of instantiating an indexmat
object. There are listed below:
Example 1: indexmat(numberofrows:int, numberofcolumns:int)
The following creates a matrix with 2 rows and 3 columns. The entries may be undefined.
Example 2: indexmat(numberofrows:int, numberofcolumns:int, initvalue:int)
This creates a matrix with 2 rows and 3 columns. All entries are assigned the value initvalue
.
Example 3: indexmat(numberofrows:int, numberofcolumns:int, valvec:List[int])
This creates a matrix with 2 rows and 3 columns. The entries are assigned the values of valvec
.
The length of valvec
is expected to be equal to the total count of entries in the matrix. So for creating
a matrix of size , length of valvec
must be 6.
Example 4: indexmat(numberofrows:int, numberofcolumns:int, init:int, step:int)
This creates a matrix with 2 rows and 3 columns. The first entry is assigned the value init
and the consecutive entries
are assigned values that increase by steps of step
.
Example 5: indexmat(input:List[indexmat])
This creates a matrix that is the vertical concatenation of input
matrices. Since the concatenation occurs vertically,
the number of columns in all the input matrices must match.
Methods
count
This counts and returns the total number of entries in the dense matrix.
Example
countcolumns
This counts and returns the number of columns in the dense matrix.
Example
countrows
This counts and returns the number of rows in the dense matrix.
Example
print
This prints the entries of the dense matrix.
Example
printsize
This prints the size of the dense matrix.
Example
Class: integration
This is an internal container class for integration.
Class: iodata
This is an internal container class. iodata
can be generated by some methods like computeradiationpattern
and
written as field outputs with setoutputfieldiodata()
or directly to a file with write()
.
Class: mat
The mat
object holds a sparse algebriac square matrix. Before creating a mat
object, ensure that a mesh object is
available. If a mesh object is not already available, create an empty mesh object. If a mesh object is not available
before creating a mat
object, a RuntimeError is raised.
Examples
There are many ways of instantiating an indexmat
object. There are listed below:
Example 1: mat(matsize:int, rowaddresses:indexmat, coladdresess:indexmat, vals:densemat)
This creates a sparse matrix object of size matsize
matsize
. The rowaddresses
and coladdresess
provide the
location (row, col) of non-zero values in the sparse matrix. The non-zero values are provided in the dense matrix vals
.
Note that a mesh object must already be available before instantiating mat
object.
Example 2: mat(myformulation:formulation, rowaddresses:indexmat, coladdresses:indexmat, vals:densemat)
This creates a sparse matrix object whose dof()
structure is the one in the formulation projection
. The rowaddresses
and
coladdresess
provide the location (row, col) of non-zero values in the sparse matrix. The non-zero values are provided in the
dense matrix vals
.
Methods
copy
This creates a full copy of the matrix. Only the values are copied. (E.g: the mat.reusefactorization()
is set back to the default
no reuse.)
Example
countcolumns
This counts and returns the number of columns in the matrix.
Example
countnnz
This counts and returns the number of non-zero entries in the matrix which is the sub-matrix of
with eliminated Dirichlet constraints. Refer mat.getainds()
.
If the requested information is not available, then - is returned.
Example
countrows
This counts and returns the number of rows in the matrix.
Example
getainds
Let us call dinds the set of unknowns that have a Dirichlet constraint and ainds the remaining unknowns.
The mat
object holds sub-matrices and such that
where is a square matrix equal to with eliminated Dirichlet constraints.
is an all zero matrix and is the square identity matrix of all Dirichlet constraints.
Matrices and are stored with their local indexing. The methods mat.getainds()
and
mat.getdinds()
gives the global indexing (i.e index in ) of each local index in and
.
Example
See Also
getdinds
This outputs dinds.
Example
See Also
print
This prints the matrix size and values.
Example
reusefactorization
The matrix factorization will be reused in allsolve()
.
Class: mesh
The mesh object holds the finite element mesh of the geometry.
Examples
A mesh object based on a mesh file can be created through the native reader or via the GMSH API.
To get more information on the physical regions of the mesh, the verbosity
argument can be
set to .
In the domain decomposition framework, creating a mesh object requires two additional arguments:
globalgeometryskin
and numoverlaplayers
. Furthermore, the mesh is treated as a part of a global
mesh. Each MPI rank owns only a part of the global mesh and all ranks must perform the call
collectively. The argument globalgeometryskin
is the part of the global mesh skin that belongs to
the current rank. It can only hold elements of dimension one lower than the geometry dimension.
The global mesh skin cannot intersect itself. The mesh parts are overlapped by the number of
overlap layers requested. More than one overlap layer cannot be guaranteed everywhere as the overlapping
is limited to the direct neighbouring domains.
mesh(filename:str, globalgeometryskin:int, numoverlaplayers:int, verbosity:int=1)
In the above examples, the mesh objects were created based on a mesh file. Similarly, mesh objects can
be created based on shape
objects.
Creating a mesh object from the shape object can be carried out also in the domain decomposition
framework using the following syntax:
mesh(inputshapes:List[shape], globalgeometryskin:int, numoverlaplayers:int, verbosity:int=1)
It is also possible to combine multiple meshes. Elements shared by the input meshes can either be
merged or not by setting the bool value for argument mergeduplicates
. For every input mesh, a new
physical region containing all elements is created. Set verbosity equal to 2 to get information on
physical regions in the mesh.
Methods
createboundarylayer
extrude
This extrudes the boundary region bnd
. After the extrusion process, newphysreg
will contain the extruded region and
newbndphysreg
will contain the extrusion end boundary. the extrudelens
is a list specifying the size of each layer in the extrusion.
The length of list determines the number of mesh layers in the extrusion. If - is given as the extrusion length for each layer, an optimal
value is automatically calculated.
Example
See Also
getdimension
This returns the dimension of the highest dimension element in the mesh 0D, 1D, 2D or 3D.
Example
getdimensions
This returns the x, y and z mesh dimensions in meters.
Example
getphysicalregionnumbers
This returns all physical region numbers of a given dimension. Use - or no argument to get the regions of all dimensions.
Example
load
This method allows an empty mesh object to be populated with mesh data. It takes in the same corresponding arguments as required in instantiating a mesh object directly. The only difference with direct instantiation is that this method requires that an empty mesh object is already created. If this method is called by a non-empty mesh object any existing mesh data are lost.
Examples
Loading a mesh from the shape objects:
Combing multiple meshes with load
method
move
This moves the whole or part of the mesh object by the x, y and z components of expression u in the x, y and z direction.
Examples
partition
This requests a DDM partition of the mesh. This is an overloaded function and can be instantiated in several ways.
Example 1: partition()
This automatically partitions a mesh into parts equal to the number of nodes selected in allsolve.
Example 2: partition(groupsphysregs: List[List[int]], groupsnumranks: List[int])
Here the user has the flexibility to group physical regions and also specify the number of ranks into which the grouped physical region is partitioned. In the below example, the βtop+middleβ is grouped into one region and is stored in rank. The βbottomβ region is partitioned into ranks. If a simulation is run on ranks, any remaining ungrouped regions will be paritioned into -- ranks.
In the below example, the βtopβ region will be partitioned into ranks. The βmiddle+bottomβ region is grouped into one region and will be partitioned into ranks. If a simulation is run on 15 ranks, any remaining ungrouped regions will be paritioned into --= ranks.
printdimensions
This prints and returns the x, y and z mesh dimensions.
Example
removeduplicatednodes
rotate
This rotates the whole or part of the mesh object first by ax
degrees around x axis followed by ay
degrees around
the y-axis and then by az
degrees around the z-axis.
Examples
scale
This scales the whole or part of the mesh object first by a factor x
, y
and z
respectively in the
x, y and z direction.
Examples
selectanynode
This tells the mesh object to create a new physical region newphysreg
that contains a single node arbitrarily chosen in the
region physregtoselectfrom
. If no region is selected (i.e. if physregtoexcludefrom
is empty) or if the argument
physregtoexcludefrom
is not provided, then the arbitrary node is chosen considering the whole domain. The new region newphysreg
is
created when the mesh.load()
method is called on the mesh object.
Examples
Example 1: mesh.selectanynode(newphysreg:int, physregtoselectfrom:int)
Example 2: mesh.selectanynode(newphysreg:int)
selectbox
This tells the mesh object to create a new physical region newphysreg
that contains elements of the region physregtoselectfrom
that
are in the box delimited by [,, ,, ,] given in boxlimit
. If no region is selected (i.e. if
physregtoselectfrom
is empty) or if the argument physregtoselectfrom
is not provided, then the box region is created
considering the whole domain.
The new region newphysreg
is created when the mesh.load()
method is called on the mesh object. The elements populated in
the new region newphysreg
are of dimension selecteddim
.
Examples
Example 1: mesh.selectbox(newphysreg:int, physregtobox:int, selecteddim:int, boxlimit:List[double])
Example 2: mesh.selectbox(newphysreg:int, selecteddim:int, boxlimit:List[double])
selectexclusion
This tells the mesh object to create a new physical region newphysreg
that contains the elements of the region physregtoexcludefrom
that are not in physregtoexclude
. If no region is selected (i.e. if physregtoexcludefrom
is empty) or if the argument
physregtoexcludefrom
is not provided, then the new region is created considering the whole domain. The new region newphysreg
is
created when the mesh.load()
method is called on the mesh object.
Examples
Example 1: mesh.selectexclusion(newphysreg:int, physregtoexlcudefrom:int, physregtoexclude:int)
Example 2: mesh.selectexclusion(newphysreg:int, physregtoexclude:int)
selectlayer
This tells the mesh object to create a new physical region newphysreg
that contains the layer of elements of the region physregtoselectfrom
that touches the region physregtostartgrowth
. If no region is selected (i.e. if physregtoselectfrom
is empty) or if the argument
physregtoselectfrom
is not provided, then the layer region is created considering the whole domain. When multiple layers are requested
through the argument numlayers
, they are grown on top of each other. The new region newphysreg
is created when the mesh.load()
method
is called on the mesh object.
Examples
Example 1: mesh.selectlayer(newphysreg:int, physregtoselectfrom:int, physregtostartgrowth:int, numlayers:int)
Example 2: mesh.selectlayer(newphysreg:int, physregtostartgrowth:int, numlayers:int)
selectperpendicular
selectskin
This tells the mesh object to create a new physical region newphysreg
that contains elements that form the skin of the
selected physical regions. If no region is selected (i.e. if physregtoselectfrom
is empty) or if the argument
physregtoselectfrom
is not provided, then the skin region is created considering the whole domain.
The skin region newphysreg
is created when the mesh.load()
method is called on the mesh object. The dimension of the skin region
is always one dimension less than that of the physical regions selected. Note that space derivatives or βhcurlβ field
evaluations on a surface do not usually lead to the same values as a volume evaluation.
Examples
Example 1: mesh.selectskin(newphysreg:int, physregtoskin)
Example 2: mesh.selectskin(newphysreg:int)
selectsphere
This tells the mesh object to create a new physical region newphysreg
that contains elements of the region physregtoselectfrom
that
are in the sphere of prescribed radius and of center [, ,] as given in centercoords
. If no region is selected (i.e. if
physregtoselectfrom
is empty) or if the argument physregtoselectfrom
is not provided, then the sphere region is created
considering the whole domain.
The new region newphysreg
is created when the mesh.load()
method is called on the mesh object. The elements populated in
the new region newphysreg
are of dimension selecteddim
.
Examples
Example 1: mesh.selectsphere(newphysreg:int, physregtosphere:int, selecteddim:int, centercoords:List[double], radius:double)
Example 2: mesh.selectsphere(newphysreg:int, selecteddim:int, centercoords:List[double], radius:double)
setadaptivity
Each element in the mesh will be adapted (refined/coarsened) based on the value of a positive criterion (h-adaptivity).
The max range of the criterion is split into a number of intervals equal to the number of refinement levels in the range
lownumsplits
and highnumsplits
. All intervals have the same size. The barycenter value of the criterion on each element
is considered to select the interval, and therefore the corresponding refinement of each mesh element. As an example, for a
criterion with the highest value of 900 over the entire domain and a low/high refinement level requested of 1/3 the refinement on
mesh elements with criterion value in the range 0 to 300, 300 to 600, 600 to 900 will be 1, 2, 3 levels respectively.
Example
setcohomologycuts
This makes the mesh object aware of the cohomology cut regions.
Example
setphysicalregions
shift
This translates the whole or part of the mesh object by x, y and z amount in the x, y and z direction.
Examples
split
This splits each element in the mesh n
times. Element quality is maximized and element curvature is taken into
account. Each element is split recursively n
times as follows:
- point 1 point
- line 2 lines
- triangle 4 triangles
- quadrangle 4 quadrangles
- tetrahedron 8 tetrahedra
- hexahedron 8 hexahedra
- prism 8 prisms
- pyramid 6 pyramids + 4 tetrahedra
Example
use
This allows one to select which mesh to use in case multiple meshes are available. This call invalidates all objects that are based on the previously selected mesh for as long as the latter is not selected again.
Example
write
This writes the mesh object to a given input filename.
Examples
If a physical region is passed in the first argument, then only part of the mesh object included in that physical region is written:
If only the file name
is provided as an argument, then all the physical regions of the mesh are written.
The argument physregs
is the list of physical regions that will be written if the argument option=1
.
If option=-1
then all the physical regions except the ones in the list physregs
will be written. The
default value for physregs=-1
which is equivalent to considering all the physical regions (the option argument
is ignored when physregs=-1
).
Class: parameter
The parameter object can hold different expression objects on different geometric regions.
Examples
A parameter object can be a scalar. The following creates an empty object.
A parameter object can also be a 2D array. The following creates an empty object.
Methods
addvalue
This adds the Γ¬nput
expression to the parameterβs existing value on the physical region physreg
.
Example
See Also
allintegrate
This is a collective MPI operation and hence must be called by all ranks. This integrates a parameter over a physical region across all the DDM ranks.
Example 1: allintegrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: allintegrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
allinterpolate
This is a collective MPI operation and hence must be called by all ranks. Its functionality is as described in
parameter.interpolate()
but considers the physical region partitioned across the DDM ranks. The argument xyzcoord
must be the same for all ranks.
Example 1: allinterpolate(physreg:int, xyzcoord:List[double])
This interpolates the parameter at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated parameter values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 2: allinterpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
A parameter can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
allmax
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the maximum value of a parameter computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: allmax(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate maximum value, but
at an increased computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to
the position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax, ycoordmax, zcoordmax] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the maximum value.
Example 2: allmax(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
parameter.allmin()
, parameter.min()
, parameter.max()
allmin
This is a collective MPI operation and hence must be called by all ranks. This returns a list with its first element containing the minimum value of a parameter computed across all the DDM ranks over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: allmin(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate minimum value, but
at an increased computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to
the position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin, ycoordmin, zcoordmin] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the minimum value.
Example 2: allmin(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The minimum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The minimum location and the delimiting box are on the undeformed mesh.
See Also
parameter.allmax()
, parameter.max()
, parameter.min()
alltimeinterpolate
atbarycenter
This outputs a vec
object whose structure is based on the field argument onefield
and which contains the parameter
evaluated at the barycenter of each reference element of physical region physreg
. The barycenter of the reference element
might not be identical to the barycenter of the actual element in the mesh (for curved elements, for general quadrangles,
hexahedra and prisms). The evaluation at barycenter is constant on each mesh element.
Example
countcolumns
This returns the number of columns in the parameter.
Example
countrows
This returns the number of rows in the parameter.
Example
integrate
This integrates a parameter over a physical region.
Example 1: allintegrate(physreg:int, integrationorder:int)
The integration is performed over the physical region physreg
. The integration is exact up to the order of
polynomials specified in the argument integrationorder
Example 2: allintegrate(physreg:int, meshdeform:expression, integrationorder:int)
Here, the integration is performed on the deformed mesh configuration meshdeform
.
See Also
interpolate
This interpolates the parameter at a single point whose [x,y,z] coordinate is provided as an argument.
The flattened interpolated parameter values are returned if the point was found in the elements of the
physical region physreg
. If not found an empty list is returned.
Example 1: interpolate(physreg:int, xyzcoord:List[double])
Example 2: interpolate(physreg:int, meshdeform:expression, xyzcoord:List[double])
A parameter can also be interpolated on a deformed mesh by passing its corresponding field.
See Also
max
This returns a list with its first element containing the maximum value of a parameter computed over a geometric region. The remaining elements of the list provide the coordinates at which the maximum value was found. This is an overloaded method.
Example 1: max(physreg:int, refinement:int, xyzrange:List[double]=[])
The maximum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate maximum value, but
at an increased computational cost. The maximum value is exact when the refinement nodes added to the elements correspond to
the position of maximum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the maximum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the maximum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [maxvalue, xcoordmax, ycoordmax, zcoordmax] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the maximum value.
Example 2: max(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The maximum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
parameter.min()
, parameter.allmax()
, parameter.allmin()
min
This returns a list with its first element containing the minimum value of a parameter computed over a geometric region. The remaining elements of the list provide the coordinates at which the minimum value was found. This is an overloaded method.
Example 1: min(physreg:int, refinement:int, xyzrange:List[double]=[])
The minimum value is obtained over the geometric region physreg
by splitting all elements refinement
times in each direction.
Increasing the refinement will thus lead to a more accurate minimum value, but
at an increased computational cost. The minimum value is exact when the refinement nodes added to the elements correspond to
the position of minimum. For a first-order nodal shape function interpolation, on a mesh that is not curved, the minimum is always
exact to machine precision. The default value of xyzrange
is an empty list.
The search of the minimum value can be restricted to a box delimited by the last argument xyzrange
whose form is [xboxmin,xboxmax, yboxmin,
yboxmin, zboxmax, zboxmin]. The output returned is a list of the form [minvalue, xcoordmin, ycoordmin, zcoordmin] or an empty list
if the physical region argument is empty or is not in the box provided. If the argument defining the box is not provided, then
the whole geometric region is considered for evaluating the minimum value.
Example 2: min(physreg:int, meshdeform:expression, refinement:int, xyzrange:List[double]=[])
The minimum value can also be evaluated on the geometry deformed by a field (possibly a curved mesh). The location and the delimiting box are on the undeformed mesh.
See Also
parameter.max()
, parameter.allmax()
, parameter.allmin()
print
This prints the information on the parameter to the console.
Example
setvalue
This sets the Γ¬nput
expression to the parameter on the physical region physreg
.
Example
See Also
write
This evaluates a parameter in the physical region physreg
and writes it to the file filename
. The
lagrangeorder
is the order of interpolation for the evaluation of the parameter.
Examples
Class: port
The port object represents a scalar lumped quantity.
Examples
A port object with an initial zero value is created as:
A multi-harmonic port object with an initial zero value can be created by passing a list of harmonic numbers. Refer to the multi-harmonic field constructor for the meaning of the harmonic numbers.
Methods
cos
This gets a port that is the harmonic at freqindex
times the fundamental frequency in port V.
Example
See Also
getharmonics
This returns the list of harmonics of the port object.
Example
getname
This gets the name of the port object.
Example
See Also
getvalue
This returns the value of the port object.
Example
See Also
harmonic
This returns a port that is the harmonic/list of harmonics of the port object.
Example
print
This prints the information of the port object.
Example
setname
This sets the name for the port object.
Example
See Also
setvalue
This sets the value of the port object.
Examples
To set the value of a multi-harmonic port:
See Also
port.harmonic()
, port.getvalue()
sin
This gets a port that is the harmonic at freqindex
times the fundamental frequency in port V.
Example
See Also
Class: shape
The shape objects are meshed geometric entities. The mesh created based on shapes can be written in .msh
format
at any time for visualization in GMSH. It might be needed to change the color
and visibility
options in the menu
Tools > Options > Mesh
of GMSH.
Examples
Depending on the number and type of arguments, different shape objects can be created for different purposes.
- Creates a shape with the coordinates of all nodes provided as input:
- Example 2: for points and lines:
myshape = shape(shapename:str, physreg:int, coords:List[double])
- Example 2: for points and lines:
- Creates a shape based on the coordinates of the corner nodes in the shape
- Example 3: for lines and arcs:
myshape = shape(shapename:str, physreg:int, coords:List[double], nummeshpts:int)
- Example 4: for triangles and quadrangles:
myshape = shape(shapename:str, physreg:int, coords:List[double], nummeshpts:List[int])
- Example 3: for lines and arcs:
- Creates a shape based on sub-shapes provided.
- Example 5: for lines and arcs:
myshape = shape(shapename:str, physreg:int, subshapes:List[shape], nummeshpts:int)
- Example 6: for straight-edged triangles and quadrangles:
myshape = shape(shapename:str, physreg:int, subshapes:List[shape], nummeshpts:List[int])
- Example 7: for curved triangles and quadrangles. Also, union of several shapes:
myshape = shape(shapename:str, physreg:int, subshapes:List[shape])
- Example 5: for lines and arcs:
- Creates a disk shape.
- Example 8:
myshape = shape(shapename:str, physreg:int, centercoords:List[double], radius:double, nummeshpts:int)
- Example 9:
myshape = shape(shapename:str, physreg:int, centerpoint:shape, radius:double, nummeshpts:int)
- Example 8:
Example 1: Creating an empty shape object
Example 2: myshape = shape(shapename:str, physreg:int, coords:List[double])
.
This can be used to create a line going through a list of nodes whose x,y,z coordinates are provided.
A physical region number is also provided to have access to the geometric regions of interest in the finite element simulation.
If the nodes in the mesh need to be accessed, a point shape object can be created with corresponding nodal coordinates. The nodes can then be accessed through the physical region provided.
Example 3: myshape = shape(shapename:str, physreg:int, coords:List[double], nummeshpts:int)
This can be used to create:
a straight line between the first (x1,y1,z1) and last point (x2,y2,z2) provided.
a circular arc between the first (x1,y1,z1) and second point (x2,y2,z2) whose center is the third point (x3,y3,z3).
The nummeshpts
argument corresponds to the number of nodes in the meshed shape. At least two nodes are expected.
Example 4: myshape = shape(shapename:str, physreg:int, coords:List[double], nummeshpts:List[int])
This can be used to create:
a straight-edge quadrangle with a full quadrangle structured mesh.
a straight-edge triangle with s structured mesh made of triangles along the edge linking the second and third node and quadrangles everywhere else.
Example 5: myshape = shape(shapename:str, physreg:int, subshapes:List[shape], nummeshpts:int)
This can be used to create the following shapes from the list of subshapes provided:
a straight line between the first (x1,y1,z1) and last point (x2,y2,z2) provided.
a circle arc between the first (x1,y1,z1) and second point (x2,y2,z2) whose center is the third point.
The nummeshpts
argument corresponds to the number of nodes in the meshed shape.
Example 6: myshape = shape(shapename:str, physreg:int, subshapes:List[shape], nummeshpts:List[int])
This can be used to create the following shapes from the list of subshpaes provided:
a straight-edge quadrangle with a full quadrangle structured mesh
a straight-edge triangle with a structured mesh made of triangles along the edge linking the second and third nodes and quadrangles everywhere.
The subshapes
argument provides the list of corner point shapes. The nummeshpts
argument gives the number of nodes to mesh each of the contour lines.
At least two nodes are expected for each contour line. All contour lines must have the same number of nodes for the triangle shape while for the quadrangle
shape the contour lines facing each other must have the same number of nodes.
Example 7: myshape = shape(shapename:str, physreg:int, subshapes:List[shape])
This can be used to create:
a curved quadrangle with full quadrangle structured mesh.
a curved triangle with structured mesh made of triangles along the edge linking the second and third nodes and quadrangles everywhere.
a shape that is the union of several shapes of the same dimension.
The subshapes
argument provides the contour shapes (clockwise or anti-clockwise). All contour lines must have the same number of nodes for the triangle shape
while for quadrangle shape the contour lines facing each other must have the same number of nodes.
Example 8: myshape = shape(shapename:str, physreg:int, centercoords:List[double], radius:double, nummeshpts:int)
This is used to create a 2D disk with structured mesh centered around centercoords
. The nummeshpts
argument
corresponds to the number of nodes in the contour circle of the disk. Since the disk has a structured mesh, the number of
mesh nodes must be a multiple of 4. The radius
argument provides the radius of the disk.
Example 9: myshape = shape(shapename:str, physreg:int, centerpoint:shape, radius:double, nummeshpts:int)
This is used to create a 2D disk with structured mesh centered around point shape centerpoint
. The nummeshpts
argument corresponds to the number of nodes in the contour circle of the disk. Since the disk has a structured mesh,
the number of mesh nodes must be a multiple of 4. The radius
argument provides the radius of the disk.
Methods
duplicate
This outputs a shape that is a duplicate of the initial shape. All the subshapes are duplicated recursively as well but the object equality relations between subshapes are identical between a shape and its duplicate.
Example
See Also
shape.move()
, shape.shift()
, shape.scale()
, shape.rotate()
extrude
A given shape is extruded in the direction specified by the unit vector argument extrudedirection
(-axis by default) to form a higher dimensional
shape. The extrude function works for 0D, 1D and 2D shapes. The physreg
is the physical region to which the extruded shape is set. The argument
height
is the height of extrusion in the direction of extrusion. The number of node layers the extruded mesh should contain is specified by
numlayers
.
Examples
Example 1: myshape = shape.extrude(physreg:int, height:double, numlayers:int, extrudedirection:List[double])
Example 2: myshape = shape.extrude(physreg:List[int], height:List[double], numlayers:[int], extrudedirection:List[double])
.
This extends the extrude
function to multiblock extrusion.
getcoords
This returns the coordinates of all nodes in the shape mesh.
Examples
getcurvatureorder
This returns the curvature order of a given shape.
Example
getdimension
This gives the shape dimension (0D, 1D, 2D or 3D).
Examples
getname
This returns the name of the shape.
Examples
getphysicalregion
This gives the physical region number for a given shape. The physical region is used in the finite element simulation to identify a region. The method returns -1 if the physical region was not set, else a corresponding positive integer.
Examples
See Also
shape.setphysicalregion()
, shape.getsons()
getsons
This returns a list containing the direct subshapes of the shape object. For a quadrangle, its 4 contour lines are returned. For a triangle, its 3 contour lines are returned.
Example
move
This moves the shape (and all its subshapes recursively) in the x,y and z direction by a value provided in the 3x1 expression array. When moving multiple shapes that share common subshapes, ensure that subshapes are not moved multiple times.
Parameter
u: expression
3x1 array expression that specifies the values by which shape is moved in x,y,z direction
Example
See Also
shape.shift()
, shape.scale()
, shape.rotate()
, shape.duplicate()
rotate
This rotates the shape (and all its subshapes recursively) first by alphax
degrees around the x-axis, then
alphay
degrees around the y-axis and finally alphaz
degrees around the z-axis. When rotating multiple shapes
that share common subshapes make sure that subshapes are not rotated multiple times.
Example
See Also
shape.move()
, shape.shift()
, shape.scale()
, shape.duplicate()
scale
This scales the shape (and all its subspaces recursively) in the x, y and z directions by a given factor provided
respectively by scalex
, scaley
, and scalez
. A factor of 1 keeps the shape unchanged. When scaling multiple
shapes that share common subshapes make sure the subshapes are not scaled multiple times.
Example
See Also
shape.move()
, shape.shift()
, shape.rotate()
, shape.duplicate()
setphysicalregion
This sets, for a given shape, a physical region number provided by physreg
. Subshapes are not affected.
The physical region is used in the finite element simulation to identify a region.
Example
See Also
shape.getphysicalregion()
, shape.getsons()
shift
This shifts the shape (and all its subshapes recursively) in the x, y, and z directions by a value provided
respectively by shiftx
, shifty
, and shiftz
. When shifting multiple shapes that share common subshapes
make sure the subspaces are not shifted multiple times.
Example
See Also
shape.move()
, shape.scale()
, shape.rotate()
, shape.duplicate()
Class: spanningtree
The spanningtree object holds a spanning tree whose edges go through all nodes in the mesh without forming a loop.
The physregs
is the list of physical regions where the spanning tree is first fully grown before being extended everywhere.
Example
A spanning tree object is created by passing the physical regions βsurβ and βtopβ. Hence, here the tree is first fully grown on face regions βsurβ and βtopβ before extending everywhere.
Methods
countedgesintree
This returns the number of edges in the spanning tree.
Example
write
This writes the tree into a file for visualization. The filename
is the name of the file to which the data samples are written.
Example
Class: spline
The spline object allows single variate interpolation in a discrete data set using cubic (natural) splines. Before creating
a spline object, ensure that a mesh object is available. If a mesh object is not already available, create an empty mesh object.
For multivariate data interpolation refer grid
class.
Examples
Say the data samples are in a text file, with each data separated by β,β as shown below:
A spline object can then be created by reading the x-y data contained in the text file.
The x-y data samples can also be provided in two separate lists or tuples. In that case, a spline object is created as follows:
Note that the ordering of the samples provided does not matter. Internally they are always sorted in the ascending order of data.
Methods
evalat
This method interpolates at given input
point(s) that falls within the original data range provided. For
interpolation of inputs outside the range of the original data a linear extrapolation is
performed.
Examples
getderivative
This returns the derivative of the spline.
The spline polynomial and its derivative :
Example
getxmax
This returns the maximum value that input takes in the original data provided.
Example
See Also
getxmin
This returns the minimum value that input takes in the original data provided.
Example
See Also
set
This method defines a spline object based on the x-y data samples provided in two separate lists or tuples.
Example
write
This writes to file a refined version of the original data samples with data sorted in ascending order.
It can be used to visualize the interpolation obtained with cubic splines. The argument filename
is the name of the
file to which the data samples are written. The numsplits
is the number of additional points between two successive
input considered for evaluation and subsequent writing. Minimum value of numsplits
required is . The
delimiter
is a string specifying the separation between the output columns in the written file.
Examples
Create a spline object:
Example 1:
If numsplits = 0
, no additional points are considered and the original data samples are written.
Example 2:
If numsplits = 1
, between two successive inputs, one additional point is considered for evaluation and subsequent writing.
Similarly, if numsplits = 2
, between two successive inputs, two additional points are considered for evaluation and subsequent writing.
Class: vec
The vec
object holds a vector, be it the solution vector of an algebraic problem or its right-hand side.
Examples
Example 1: vec(formul:formulation)
This creates an all-zero vector whose structure and size is the one of formulation projection.
Example 2: vec(vecsize:int, addresses:indexmat, vals:densemat)
This creates a vector with given values at given addresses.
Methods
abs
Returns a new vector with each element replaced by its absolute value.
Examples
copy
This creates a full copy of the vector object.
Examples
getallvalues
This gets the values of all the entries of the vector in sequential order. It returns a column matrix with number of rows equal to the the vector object size.
Example
See Also
vec.setvalue()
, vec.setvalues()
, vec.setallvalues()
, vec.getvalue()
, vec.getvalues()
getvalue
This gets the value of the vector object at the given address
. The address
provides the index at which the entry
of a vector is requested. It returns a matrix of size .
Example
See Also
vec.setvalue()
, vec.setvalues()
, vec.setallvalues()
, vec.getvalues()
, vec.getallvalues()
getvalues
This gets the values in the vector that are at the indices given in addresses
. The addresses
is the column
matrix storing the indices at which the entries of a vector are requested. It returns a column matrix with number
of rows equal to the length of the addresses
.
Example
See Also
vec.setvalue()
, vec.setvalues()
, vec.setallvalues()
, vec.getvalue()
, vec.getallvalues()
load
This loads the data of a vector object from a file (either .bin
or .txt
ASCII format). This only works correctly if the dof
structure of the calling vector object is the same as that of the vector object from which the file was written to the disk.
In other words, the same set of formulation contributions must be defined in the same order.
Examples
See Also
noautomaticupdate
After this call, the vector object will not have its value automatically updated after hp-adaptivity. If the automatic update is not needed then this call is recommended to avoid a possibly costly update to the vector values.
Examples
norm
This returns the , or - norm of the vector. The type
argument determines the type of the norm returned:
- For
type='1'
, norm is computed. - For
type='2'
, norm is computed, which is the default. - For
type='infinity'
, - norm is computed.
If is the element in a vector of length , the different norms are defined as follows:
- L1 norm:
- L2 norm:
- L-infinity norm:
Examples
See Also
vec.sum
permute
This rearranges the vector in the order of indices prescribed in rowpermute
.
The inverse permutation is performed if the boolean flag invertit
is set to True.
The rowpermute
describes the mapping or inverse mapping function.
Example
print
This prints the values of the vector object.
Examples
setallvalues
This replaces all the entries in the vector object by the values in valsmat
. The addresses of valsmat
are
assumed to be in sequential order. If op='set'
, the values are replaced and if op='add'
the values are instead
added to existing ones. This method works on all the entries. The valsmat
is a column matrix storing the values
that are replaced in or added to the vector object.
Example
See Also
vec.setvalue()
, vec.setvalues()
, vec.getvalue()
, vec.getvalues()
, vec.getallvalues()
setdata
This sets to the vector the data from the fields and ports defined in the formulation.
Examples
Example 2: vec.setdata()
Replace the vector data with the data from all the fields and ports defined in the associated formulation.
setvalue
This replaces the value in the vector object at the given address
with the values in value
. The βaddressβ provides the index at which
the entry is replaced by value
. If op='set'
, the value is replaced and if op='add'
the value is added to the existing one.
This method works only on a given single entry. The address
is the index at which the entry of a vector is replaced/added.
The value
is the value that is set/added in the vector object.
Example
See Also
vec.setvalues()
, vec.setallvalues()
, vec.getvalue()
, vec.getvalues()
, vec.getallvalues()
setvalues
This replaces the values in the vector object at the given addresses
with the values in valsmat
.
If op='set'
, the values are replaced and if op='add'
the values are instead added to existing ones.
This method works only on entries given in the addresses
. The addresses
is a column matrix storing
the indices at which the entries of a vector are replaced/added. The valsmat
is a column matrix storing
the values that are replaced in or added to the vector object.
Example
See Also
vec.setvalue()
, vec.setallvalues()
, vec.getvalue()
, vec.getvalues()
, vec.getallvalues()
size
This returns the size of the vector object. If the vector was instantiated from a formulation, then the vector size is equal to the number of dofs in that formulation.
Example
updateconstraints
This updates the values of all Dirichlet constraint entries in the vector.
Example
write
This writes all the data in the vector object to disk in a lossless and compact form. The file can be written in binary .bin
format (extremely compact but less portable) or in ASCII .txt
format (portable). The filename
is the name of the file to
which the data from the vector object is written.
Examples
See Also
Class: wallclock
This initializes the wall clock object.
Methods
pause
This pauses the clock. The wallclock.pause()
and wallclock.resume()
functions allow to time selected operations in loop.
Example
See Also
print
This prints the time elapsed in the most appropriate format (, , or ).
It also prints the message passed in the argument toprint
(if any).
Example
resume
This resumes the clock. The wallclock.pause()
and wallclock.resume()
functions allow to time selected operations in loop.
Example
See Also
tic
This resets the clock.
Example
See Also
toc
This returns the time elapsed (in ).
Example
See Also
Generated by pdoc 0.10.0 (https://pdoc3.github.io).