Useful Code Snippets and FAQ¶
Code examples below that use sfepy-* scripts assume the sfepy package to be installed, see also Installation.
Miscellaneous¶
No module named 'sfepy.discrete.common.extmods.mappings'
.When installing SfePy from sources or using the git version, its extension modules have to be compiled before using the package, see Compilation of C Extension Modules.
The extension modules are compiled in place, but
ModuleNotFoundError: No module named 'sfepy'
shows up when running some interactive examples/scripts/modules from the SfePy source directory.On some platforms the current directory is not in the
sys.path
directory list. Add it using:export PYTHONPATH=.
or add the following code prior to
sfepy
imports into the module:import sys sys.path.append('.')
Finite element approximation (field) order and numerical quadrature order.
SfePy supports reading only straight-facet (linear approximation) meshes, nevertheless field orders higher than one can be used, because internally, the mesh elements are enriched with the required additional nodes. The calculation then occurs on such an augmented mesh with appropriate higher order elements.
The quadrature order equal to two-times the field order (used in many examples) works well for bilinear forms with constant (on each element) material parameters. For example, a dot product involves integrating
u * v
, so if the approximation order ofu
andv
is 1, their product’s order is 2. Of course, there are terms that could use a lower quadrature order, or higher, depending on the data. Increased quadrature order is required e.g. in terms with highly oscillating material coefficients.Example:
approx_order = 2 # The finite element approximation order. fields = { 'displacement': ('real', 3, 'Omega', approx_order), } # The numerical quadrature order. integrals = { 'i' : 2 * approx_order, }
Higher order DOF visualization when using an approximation order greater than one.
By default, the additional, higher order DOFs, are not used in the VTK/HDF5 results files (
'strip'
linearization kind). To see the influence of those DOFs,'adaptive'
linearization has to be used, see diffusion/sinbc.py (declarative API) and diffusion/laplace_refine_interactive.py or multi_physics/biot_parallel_interactive.py (imperative API, searchlinearization
).Numbering of DOFs.
Locally (in a connectivity row), the DOFs are stored DOF-by-DOF (
u_0
in all local nodes,u_1
in all local nodes, …).Globally (in a state vector), the DOFs are stored node-by-node (
u_0, u_1, ..., u_X
in node 0,u_0, u_1, ..., u_X
in node 1, …).See also
create_adof_conn()
.Visualization of various FEM-related information.
Quadrature rules:
python3 sfepy/scripts/plot_quadratures.py
Facet orientations - run in the source code directory and make sure the current directory is in the Python’s path list (see Miscellaneous):
python3 sfepy/postprocess/plot_facets.py
Global and local numberings of mesh topological entities (cells, faces, edges, vertices):
python3 sfepy/scripts/plot_mesh.py meshes/elements/2_4_2.mesh
The global numbers serve as indices into connectivities. In the plot, the global numbers are on the entities, the cell-local ones are inside the cells next to each entity towards the cell centroids.
How to work with solvers/preconditioners?
See multi_physics/biot_short_syntax.py (user-defined preconditioners) or navier_stokes/stokes_slip_bc.py (petsc solver setup).
How to get the linear system components: the matrix and the right-hand side?
To get the residual vector
r
(see Implementation of Essential Boundary Conditions) and the tangent matrixK
, the imperative API can be used as follows:# pb is a Problem instance, pb.set_bcs(ebcs=Conditions([...])) # Set Dirichlet boundary conditions. pb.set_ics(Conditions([...])) # Set initial conditions (if any). variables = pb.get_initial_state() pb.time_update() pb.update_materials() variables.apply_ebc() r = pb.equations.eval_residuals(variables()) K = pb.equations.eval_tangent_matrices(variables(), pb.mtx_a)
Where is the code that calculates the element (e.g. stiffness) matrix?
The code that computes the per element residuals and matrices is organized in terms, see Term Overview - click on the term class name and then “source” link to see the code. The original terms are implemented in C, newer terms tend to be implemented directly in Python. The structure and attributes of a term class are described in How to Implement a New Term.
What structural elements (beams, shells, etc.) are available in SfePy?
The code is currently focused on solid elements. The only supported structural element is shell10x, see linear_elasticity/shell10x_cantilever.py.
Regions¶
How to define a region using a function of coordinates in the interactive mode (imperative API)?
Examples:
A facet region defined using a function of mesh vertex coordinates:
from sfepy.discrete import Function, Functions def _get_region(coors, domain=None): ii = np.nonzero(coors[:,0] < 0.5)[0] return ii get_region = Function('get_region', _get_region) region = domain.create_region( 'Region', 'vertices by get_region', 'facet', functions=Functions([get_region]), )
Analogously a cell region defined using the coordinates of cell centroids:
# ... region = domain.create_region( 'Region', 'cells by get_region', 'cell', functions=Functions([get_region]), )
Material Parameters¶
How to set material parameters per region in the interactive mode (imperative API)?
Example: define
rho
,D
to have different values in regionsomega1
,omega2
:m = Material('m', values={'rho': {'omega1': 2700, 'omega2': 6000}, 'D': {'omega1': D1, 'omega2': D2}})
How to implement state dependent materials?
Besides writing a custom solver, one can use pseudo-time-stepping for this purpose, as demonstrated in linear_elasticity/material_nonlinearity.py or diffusion/poisson_field_dependent_material.py. Note that the examples are contrived, and in practice care must be taken to ensure convergence.
Why are results of a 2D elasticity simulation not consistent with a properly constrained 3D elasticity simulation?
Possible reason: when using the Young’s modulus and Poisson’s ratio as input parameters, and then calling
stiffness_from_youngpoisson()
, note that the default value of theplane
argument is'strain'
, corresponding to the plane strain assumption, see alsolame_from_youngpoisson()
. Try settingplane='stress'
.How to set (time-dependent) material parameters by a function in the interactive mode (imperative API)?
Example (also showing the full material function signature):
from sfepy.discrete import Material, Function def get_pars(ts, coors, mode=None, equations=None, term=None, problem=None, **kwargs): value1 = a_function(ts.t, coors) value2 = another_function(ts.step, coors) if mode == 'qp': out = { 'value1' : value1.reshape(coors.shape[0], 1, 1), 'value2' : value2.reshape(coors.shape[0], 1, 1), } return out m = Material('m', function=Function('get_pars', get_pars))
How to get cells corresponding to coordinates in a material function?
The full signature of the material function is:
def get_pars(ts, coors, mode=None, equations=None, term=None, problem=None, **kwargs)
Thus it has access to
term.region.cells
, hence access to the cells that correspond to the coordinates. The length of thecoors
isn_cell * n_qp
, wheren_qp
is the number of quadrature points per cell, andn_cell = len(term.region.cells)
, so thatcoors.reshape((n_cell, n_qp, -1))
can be used.