Discretizations¶
Abstract interface¶
Error handling¶
- exception meshmode.discretization.ElementGroupTypeError[source]¶
A
TypeError
specific for handling element groups. This exception may be raised to indicate whenever an improper operation or function is applied to a particular subclass ofElementGroupBase
.
- exception meshmode.discretization.NoninterpolatoryElementGroupError[source]¶
A specialized
ElementGroupTypeError
that may be raised whenever non-interpolatory element groups are being used for interpolation.
Base classes¶
- class meshmode.discretization.ElementGroupBase(mesh_el_group: MeshElementGroup, order: int)[source]¶
Defines a discrete function space on a homogeneous (in terms of element type and order) subset of a
Discretization
. These correspond one-to-one withmeshmode.mesh.MeshElementGroup
. Responsible for all bulk data handling inDiscretization
.- mesh_el_group¶
- order¶
- is_affine¶
A
bool
flag that is True if the local-to-global parametrization of all the elements in the group is affine. Based onmeshmode.mesh.MeshElementGroup.is_affine
.
- nelements¶
The total number of polygonal elements in the
meshmode.mesh.MeshElementGroup
.
- nunit_dofs¶
The number of degrees of freedom (“DOFs”) associated with a single element.
- ndofs¶
The total number of degrees of freedom (“DOFs”) associated with the entire element group.
- shape¶
Returns a subclass of
modepy.Shape
representing the reference element defining the element group.
- space¶
Returns a
modepy.FunctionSpace
representing the underlying polynomial space defined on the element group’s reference element.
- __init__(mesh_el_group: MeshElementGroup, order: int) None [source]¶
- discretization_key() Hashable [source]¶
Return a hashable, equality-comparable object that fully describes the per-element discretization used by this element group. (This should cover all parts of the Ciarlet Triple: reference element, shape functions, and the linear functionals defining the degrees of freedom.) The object should be independent, however, of the (global) elements that make up the group.
The structure of the element is not specified, but it must be globally unique to this element group.
- class meshmode.discretization.ElementGroupFactory(*args, **kwargs)[source]¶
A
typing.Protocol
specifying the interface for group factories.- __call__(mesh_el_group: MeshElementGroup) ElementGroupBase [source]¶
Create a new
ElementGroupBase
for the given mesh_el_group.
- class meshmode.discretization.NodalElementGroupBase(mesh_el_group: MeshElementGroup, order: int)[source]¶
Base class for nodal element groups, defined as finite elements equipped with nodes. Nodes are specific locations defined on the reference element (
shape
) defining a degree of freedom by point evaluation at that location. Such element groups have an associated quadrature rule to perform numerical integration, but are not necessarily usable (unisolvent) for interpolation.Inherits from
ElementGroupBase
.- unit_nodes¶
Returns a
numpy.ndarray
of shape(dim, nunit_dofs)
of reference coordinates of interpolation nodes.Note: this method dispatches to the nodes of the underlying quadrature rule. This means, for interpolatory element groups, interpolation nodes are collocated with quadrature nodes.
- abstract quadrature_rule() Quadrature [source]¶
Returns a
modepy.Quadrature
object for the element group. This quadrature rule shares the nodes returned byunit_nodes()
.
- class meshmode.discretization.ElementGroupWithBasis(mesh_el_group: MeshElementGroup, order: int)[source]¶
Base class for element groups which possess an explicit basis for the underlying function space
space
.Inherits from
ElementGroupBase
.
- class meshmode.discretization.InterpolatoryElementGroupBase(mesh_el_group: MeshElementGroup, order: int)[source]¶
An element group equipped with both an explicit basis for the underlying
space
, and a set of nodal locations on theshape
. These element groups are unisolvent in the Ciarlet sense, meaning the dimension ofspace
matches the number of interpolatory nodal locations. These element groups are therefore suitable for interpolation and differentiation.Inherits from
NodalElementGroupBase
andElementGroupWithBasis
.
- class meshmode.discretization.ModalElementGroupBase(mesh_el_group: MeshElementGroup, order: int)[source]¶
An element group equipped with a function space and a hierarchical basis that is orthonormal with respect to the \(L^2\) inner product.
Inherits from
ElementGroupWithBasis
.
Discretization class¶
- meshmode.discretization.num_reference_derivative(discr: Discretization, ref_axes: Iterable[int], vec: DOFArray) DOFArray [source]¶
- Parameters:
ref_axes – an
Iterable
of indices that define the sequence of derivatives to vec. For example,(0, 1, 1)
would take a third partial derivative, one in the first axis and two in the second axis.
- class meshmode.discretization.Discretization(actx: ArrayContext, mesh: Mesh, group_factory: ElementGroupFactory, real_dtype: dtype | None = None, _force_actx_clone: bool = True)[source]¶
An unstructured composite discretization.
- real_dtype¶
- complex_dtype¶
- mesh¶
- dim¶
- ambient_dim¶
- ndofs¶
- groups¶
- is_nodal¶
A
bool
indicating whether theDiscretization
is defined over element groups subclasses ofNodalElementGroupBase
.
- is_modal¶
A
bool
indicating whether theDiscretization
is defined over element groups subclasses ofModalElementGroupBase
.
- __init__(actx: ArrayContext, mesh: Mesh, group_factory: ElementGroupFactory, real_dtype: dtype | None = None, _force_actx_clone: bool = True) None [source]¶
- Parameters:
actx – an
arraycontext.ArrayContext
used to perform computation needed during initial set-up of the discretization.mesh – a
Mesh
over which the discretization is built.group_factory – an
ElementGroupFactory
.real_dtype – The
numpy
data type used for representing real data, eithernumpy.float32
ornumpy.float64
.
- copy(actx: ArrayContext | None = None, mesh: Mesh | None = None, group_factory: ElementGroupFactory | None = None, real_dtype: dtype | None = None) Discretization [source]¶
Creates a new object of the same type with all arguments that are not None replaced. The copy is not recursive.
- zeros(actx: ArrayContext, dtype: dtype | None = None) DOFArray [source]¶
Return a zero-initialized
DOFArray
.- Parameters:
dtype – type special value ‘c’ will result in a vector of dtype
complex_dtype
. If None (the default), a real vector will be returned.
Element Groups for Composite Polynomial Discretization¶
Group types¶
Simplicial group types¶
- class meshmode.discretization.poly_element.ModalSimplexElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
- class meshmode.discretization.poly_element.InterpolatoryQuadratureSimplexElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
Elemental discretization supplying a high-order quadrature rule with a number of nodes matching the number of polynomials in \(P^k\), hence usable for differentiation and interpolation.
No interpolation nodes are present on the boundary of the simplex.
- class meshmode.discretization.poly_element.QuadratureSimplexElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
Elemental discretization supplying a high-order quadrature rule with a number of nodes which does not necessarily match the number of polynomials in \(P^k\). This discretization therefore excels at quadarature, but is not necessarily usable for interpolation.
No interpolation nodes are present on the boundary of the simplex.
- class meshmode.discretization.poly_element.PolynomialWarpAndBlend2DRestrictingElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
Elemental discretization with a number of nodes matching the number of polynomials in \(P^k\), hence usable for differentiation and interpolation. Interpolation nodes edge-clustered for avoidance of Runge phenomena. Nodes are present on the boundary of the simplex. Provides nodes in two and fewer dimensions, based on the 2D warp-and-blend nodes and their facial restrictions.
- class meshmode.discretization.poly_element.PolynomialWarpAndBlend3DRestrictingElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
Elemental discretization with a number of nodes matching the number of polynomials in \(P^k\), hence usable for differentiation and interpolation. Interpolation nodes edge-clustered for avoidance of Runge phenomena. Nodes are present on the boundary of the simplex. Provides nodes in two and fewer dimensions, based on the 3D warp-and-blend nodes and their facial restrictions.
- class meshmode.discretization.poly_element.PolynomialRecursiveNodesElementGroup(mesh_el_group, order, family)[source]¶
Elemental discretization with a number of nodes matching the number of polynomials in \(P^k\), hence usable for differentiation and interpolation. Interpolation nodes edge-clustered for avoidance of Runge phenomena. Depending on the family argument, nodes may be present on the boundary of the simplex. See [Isaac20] for details.
Supports a choice of the base family of 1D nodes, see the documentation of the family argument to
recursivenodes.recursive_nodes()
.Requires
recursivenodes
to be installed.[Isaac20]Tobin Isaac. Recursive, parameter-free, explicitly defined interpolation nodes for simplices. Arxiv preprint.
Added in version 2020.2.
- class meshmode.discretization.poly_element.PolynomialEquidistantSimplexElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
Elemental discretization with a number of nodes matching the number of polynomials in \(P^k\), hence usable for differentiation and interpolation. Interpolation nodes are present on the boundary of the simplex.
Added in version 2016.1.
Tensor product group types¶
- class meshmode.discretization.poly_element.ModalTensorProductElementGroup(mesh_el_group: MeshElementGroup, order: int)[source]¶
- class meshmode.discretization.poly_element.GaussLegendreTensorProductElementGroup(mesh_el_group, order)[source]¶
Elemental discretization supplying a high-order quadrature rule with a number of nodes matching the number of polynomials in the tensor product basis, hence usable for differentiation and interpolation.
No interpolation nodes are present on the boundary of the hypercube.
- class meshmode.discretization.poly_element.LegendreGaussLobattoTensorProductElementGroup(mesh_el_group, order)[source]¶
Elemental discretization supplying a high-order quadrature rule with a number of nodes matching the number of polynomials in the tensor product basis, hence usable for differentiation and interpolation. Nodes sufficient for unisolvency are present on the boundary of the hypercube.
- class meshmode.discretization.poly_element.EquidistantTensorProductElementGroup(mesh_el_group, order)[source]¶
Elemental discretization supplying a high-order quadrature rule with a number of nodes matching the number of polynomials in the tensor product basis, hence usable for differentiation and interpolation. Nodes sufficient for unisolvency are present on the boundary of the hypercube.
Uses
equidistant_nodes()
.
Group factories¶
- class meshmode.discretization.poly_element.HomogeneousOrderBasedGroupFactory(order: int)[source]¶
Element group factory for a single type of
meshmode.mesh.MeshElementGroup
and fixed order.- mesh_group_class¶
- group_class¶
- order¶
- __init__(order: int) None [source]¶
- Parameters:
order – integer denoting the order of the
ElementGroupBase
. The exact interpretation of the order is left to each individual class, as given bygroup_class
.
- __call__(mesh_el_group)[source]¶
- Returns:
an element group of type
group_class
and orderorder
.
- class meshmode.discretization.poly_element.TypeMappingGroupFactory(order, mesh_group_class_to_factory)[source]¶
Element group factory that supports multiple types of
MeshElementGroup
s, defined through the mappingmesh_group_class_to_factory
.- order¶
- mesh_group_class_to_factory¶
A
dict
fromMeshElementGroup
s to factory callables that return a correspondingElementGroupBase
of orderorder
.
- __init__(order, mesh_group_class_to_factory)[source]¶
- Parameters:
mesh_group_class_to_factory – a
dict
fromMeshElementGroup
subclasses toElementGroupBase
subclasses orElementGroupFactory
instances.
- __call__(mesh_el_group)[source]¶
Create a new
ElementGroupBase
for the given mesh_el_group.
Simplicial group factories¶
- class meshmode.discretization.poly_element.InterpolatoryQuadratureSimplexGroupFactory(order: int)[source]¶
- class meshmode.discretization.poly_element.PolynomialWarpAndBlend2DRestrictingGroupFactory(order: int)[source]¶
- class meshmode.discretization.poly_element.PolynomialWarpAndBlend3DRestrictingGroupFactory(order: int)[source]¶
- class meshmode.discretization.poly_element.PolynomialRecursiveNodesGroupFactory(order, family)[source]¶
Tensor product group factories¶
- class meshmode.discretization.poly_element.GaussLegendreTensorProductGroupFactory(order: int)[source]¶
Type-based group factories¶
- class meshmode.discretization.poly_element.InterpolatoryEdgeClusteredGroupFactory(order)[source]¶
Element group factory for all supported
MeshElementGroup
s that constructs (recommended) element groups with edge-clustered nodes that can be used for interpolation.
- class meshmode.discretization.poly_element.InterpolatoryQuadratureGroupFactory(order)[source]¶
Element group factory for all supported
MeshElementGroup
s that constructs (recommended) element groups with nodes that can be used for interpolation and high-order quadrature.
- class meshmode.discretization.poly_element.InterpolatoryEquidistantGroupFactory(order)[source]¶
Element group factory for all supported
MeshElementGroup
s that constructs (recommended) element groups with equidistant nodes that can be used for interpolation.
- class meshmode.discretization.poly_element.QuadratureGroupFactory(order)[source]¶
Element group factory for all supported
MeshElementGroup
s that constructs (recommended) element groups with nodes that can be used for high-order quadrature, but (not necessarily) for interpolation.
- class meshmode.discretization.poly_element.ModalGroupFactory(order)[source]¶
Element group factory for all supported
MeshElementGroup
s that constructs (recommended) element groups with modal degrees of freedom.
Visualization¶
- meshmode.discretization.visualization.make_visualizer(actx, discr, vis_order=None, element_shrink_factor=None, force_equidistant=False)[source]¶
- Parameters:
vis_order – order of the visualization DOFs.
element_shrink_factor – number in \((0, 1]\).
force_equidistant – if True, the visualization is done on equidistant nodes. If plotting high-order Lagrange VTK elements, this needs to be set to True.
- class meshmode.discretization.visualization.Visualizer(connection, element_shrink_factor=None, is_equidistant=False, _vtk_linear_connectivity=None, _vtk_lagrange_connectivity=None)[source]¶
-
- write_vtk_file(file_name, names_and_fields, compressor=None, real_only=False, overwrite=False, use_high_order=None, par_manifest_filename=None, par_file_names=None)[source]¶
Write a Vtk XML file (typical extension
.vtu
) containing the visualization data in names_and_fields. Can optionally also write manifests for distributed memory simulation (typical extension.pvtu
). See alsowrite_parallel_vtk_file()
for a convenience wrapper.- Parameters:
names_and_fields – A list of tuples
(name, value)
, where name is a string and value is aDOFArray
or a constant, or an object array of those. value may also be a data class (seedataclasses
), whose attributes will be inserted into the visualization with their names prefixed by name. If value is None, then there is no data to write and the corresponding name will not appear in the data file. If value is None, it should be None collectively across all ranks for parallel writes; otherwise the behavior of this routine is undefined.overwrite – If True, silently overwrite existing files.
use_high_order – Writes arbitrary order Lagrange VTK elements. These elements are described in this blog post and are available in VTK 8.1 and newer.
par_manifest_filename – If not None write a distributed-memory manifest with this file name if file_name matches the first entry in par_file_names.
par_file_names – A list of file names of visualization files to include in the distributed-memory manifest.
Changed in version 2020.2:
Added par_manifest_filename and par_file_names.
Added use_high_order.
- write_parallel_vtk_file(mpi_comm, file_name_pattern, names_and_fields, compressor=None, real_only=False, overwrite=False, use_high_order=None, par_manifest_filename=None)[source]¶
A convenience wrapper around
write_vtk_file()
for distributed-memory visualization.- Parameters:
mpi_comm – An object that supports
mpi_comm.Get_rank()
andmpi_comm.Get_size()
method calls, typically (but not necessarily) an instance ofmpi4py.Comm
. This is used to determine the current rank as well as the total number of files being written. May also be None in which case a unit-size communicator is assumed.file_name_pattern – A file name pattern (required to end in
.vtu
) that will be used withstr.format()
with an (integer) argument ofrank
to obtain the per-rank file name. Relative path names are also supported.par_manifest_filename – as in
write_vtk_file()
. If not given, par_manifest_filename is synthesized by substituting rank 0 into file_name_pattern and replacing the file extension with.pvtu
.
See
write_vtk_file()
for the meaning of the remainder of the arguments.Added in version 2020.2.
- write_vtkhdf_file(file_name: str, names_and_fields: list[tuple[str, Any]], *, comm=None, use_high_order: bool = False, real_only: bool = False, overwrite: bool = False, h5_file_options: dict[str, Any] | None = None, dset_options: dict[str, Any] | None = None) None [source]¶
Write a VTK HDF5 file (typical extension
'.hdf'
) containing the visualization fields in names_and_fields.This function requires
h5py
and has support for parallel writes throughmpi4py
.- Parameters:
comm – an
mpi4py.Comm
-like interface that supportsGet_rank
,Get_size
,scan
andreduce
. The last two are required to gather global information about the points and cells in the discretizations.h5_file_options – a
dict
passed directly toh5py.File
that allows controlling chunking, compatibility, etc.dataset_options – a
dict
passed directly toh5py.Group.create_dataset()
.
- write_xdmf_file(file_name, names_and_fields, attrs=None, h5_file_options=None, dataset_options=None, real_only=False, overwrite=False)[source]¶
Write an XDMF file (with an
.xmf
extension) containing the arrays in names_and_fields. The heavy data is written to binary HDF5 files, which requires installing h5py. Distributed memory visualization is not yet supported.- Parameters:
names_and_fields – a list of
(name, array)
, where array is an array-like object (seeVisualizer.write_vtk_file()
).attrs – a
dict
of scalar attributes that will be saved in the root HDF5 group.h5_file_options – a
dict
passed directly toh5py.File
that allows controlling chunking, compatibility, etc.dataset_options – a
dict
passed directly toh5py.Group.create_dataset()
.
- copy_with_same_connectivity(actx, discr, skip_tests=False)[source]¶
Makes a copy of the visualizer for a
Discretization
with the same group structure as the original discretization. This can be useful when the geometry is mapped (e.g. usingaffine_map()
) and the connectivity can be reused.The “same group structure” here means that the two discretizations should have the same group types, number of elements, degrees of freedom, etc.
- Parameters:
skip_tests – If True, no checks in the group structure of the discretizations are performed.