dolfinx.cpp.fem
FEM module
Classes
|
Value constant with respect to integration domain |
|
Value constant with respect to integration domain |
|
Value constant with respect to integration domain |
|
Value constant with respect to integration domain |
Coordinate map element |
|
Coordinate map element |
|
|
Object for representing Dirichlet (essential) boundary conditions |
|
Object for representing Dirichlet (essential) boundary conditions |
|
Object for representing Dirichlet (essential) boundary conditions |
|
Object for representing Dirichlet (essential) boundary conditions |
|
DofMap object |
|
Object describing the layout of dofs on a cell |
|
An Expression |
|
An Expression |
|
An Expression |
|
An Expression |
|
Finite element object |
|
Finite element object |
|
Variational form object |
|
Variational form object |
|
Variational form object |
|
Variational form object |
|
Finite element function space |
|
Finite element function space |
A finite element function |
|
A finite element function |
|
A finite element function |
|
A finite element function |
|
|
- class dolfinx.cpp.fem.Constant_complex128(self, c: ndarray[dtype=complex128, order='C', writable=False])
Bases:
object
Value constant with respect to integration domain
Create a constant from a value array
- property dtype
(self) -> str
- property value
(self) -> numpy.ndarray[dtype=complex128]
- class dolfinx.cpp.fem.Constant_complex64(self, c: ndarray[dtype=complex64, order='C', writable=False])
Bases:
object
Value constant with respect to integration domain
Create a constant from a value array
- property dtype
(self) -> str
- property value
(self) -> numpy.ndarray[dtype=complex64]
- class dolfinx.cpp.fem.Constant_float32(self, c: ndarray[dtype=float32, order='C', writable=False])
Bases:
object
Value constant with respect to integration domain
Create a constant from a value array
- property dtype
(self) -> str
- property value
(self) -> numpy.ndarray[dtype=float32]
- class dolfinx.cpp.fem.Constant_float64(self, c: ndarray[dtype=float64, order='C', writable=False])
Bases:
object
Value constant with respect to integration domain
Create a constant from a value array
- property dtype
(self) -> str
- property value
(self) -> numpy.ndarray[dtype=float64]
- class dolfinx.cpp.fem.CoordinateElement_float32(self, celltype: dolfinx.cpp.mesh.CellType, degree: int)
- class dolfinx.cpp.fem.CoordinateElement_float32(self, element: basix._basixcpp.FiniteElement_float32)
- class dolfinx.cpp.fem.CoordinateElement_float32(self, celltype: dolfinx.cpp.mesh.CellType, degree: int, variant: int)
Bases:
object
Coordinate map element
- create_dof_layout
- property degree
(self) -> int
- property dim
(self) -> int
- property dtype
(self) -> str
- pull_back
- push_forward
- property variant
(self) -> int
- class dolfinx.cpp.fem.CoordinateElement_float64(self, celltype: dolfinx.cpp.mesh.CellType, degree: int)
- class dolfinx.cpp.fem.CoordinateElement_float64(self, element: basix._basixcpp.FiniteElement_float64)
- class dolfinx.cpp.fem.CoordinateElement_float64(self, celltype: dolfinx.cpp.mesh.CellType, degree: int, variant: int)
Bases:
object
Coordinate map element
- create_dof_layout
- property degree
(self) -> int
- property dim
(self) -> int
- property dtype
(self) -> str
- pull_back
- push_forward
- property variant
(self) -> int
- class dolfinx.cpp.fem.DirichletBC_complex128(self, g: ndarray[dtype=complex128, order='C', writable=False], dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float64)
- class dolfinx.cpp.fem.DirichletBC_complex128(self, g: dolfinx.cpp.fem.Constant_complex128, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float64)
- class dolfinx.cpp.fem.DirichletBC_complex128(self, g: dolfinx.cpp.fem.Function_complex128, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False])
- class dolfinx.cpp.fem.DirichletBC_complex128(self, g: dolfinx.cpp.fem.Function_complex128, dofs: collections.abc.Sequence[ndarray[dtype=int32, shape=(*), order='C', writable=False]], V: dolfinx.cpp.fem.FunctionSpace_float64)
Bases:
object
Object for representing Dirichlet (essential) boundary conditions
- dof_indices
- property dtype
(self) -> str
- property function_space
(self) -> dolfinx::fem::FunctionSpace<double>
- set
- property value
(self) -> dolfinx::fem::Function<std::complex<double>, double> | dolfinx::fem::Constant<std::complex<double> >
- class dolfinx.cpp.fem.DirichletBC_complex64(self, g: ndarray[dtype=complex64, order='C', writable=False], dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float32)
- class dolfinx.cpp.fem.DirichletBC_complex64(self, g: dolfinx.cpp.fem.Constant_complex64, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float32)
- class dolfinx.cpp.fem.DirichletBC_complex64(self, g: dolfinx.cpp.fem.Function_complex64, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False])
- class dolfinx.cpp.fem.DirichletBC_complex64(self, g: dolfinx.cpp.fem.Function_complex64, dofs: collections.abc.Sequence[ndarray[dtype=int32, shape=(*), order='C', writable=False]], V: dolfinx.cpp.fem.FunctionSpace_float32)
Bases:
object
Object for representing Dirichlet (essential) boundary conditions
- dof_indices
- property dtype
(self) -> str
- property function_space
(self) -> dolfinx::fem::FunctionSpace<float>
- set
- property value
(self) -> dolfinx::fem::Function<std::complex<float>, float> | dolfinx::fem::Constant<std::complex<float> >
- class dolfinx.cpp.fem.DirichletBC_float32(self, g: ndarray[dtype=float32, order='C', writable=False], dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float32)
- class dolfinx.cpp.fem.DirichletBC_float32(self, g: dolfinx.cpp.fem.Constant_float32, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float32)
- class dolfinx.cpp.fem.DirichletBC_float32(self, g: dolfinx.cpp.fem.Function_float32, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False])
- class dolfinx.cpp.fem.DirichletBC_float32(self, g: dolfinx.cpp.fem.Function_float32, dofs: collections.abc.Sequence[ndarray[dtype=int32, shape=(*), order='C', writable=False]], V: dolfinx.cpp.fem.FunctionSpace_float32)
Bases:
object
Object for representing Dirichlet (essential) boundary conditions
- dof_indices
- property dtype
(self) -> str
- property function_space
(self) -> dolfinx::fem::FunctionSpace<float>
- set
- property value
(self) -> dolfinx::fem::Function<float, float> | dolfinx::fem::Constant<float>
- class dolfinx.cpp.fem.DirichletBC_float64(self, g: ndarray[dtype=float64, order='C', writable=False], dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float64)
- class dolfinx.cpp.fem.DirichletBC_float64(self, g: dolfinx.cpp.fem.Constant_float64, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False], V: dolfinx.cpp.fem.FunctionSpace_float64)
- class dolfinx.cpp.fem.DirichletBC_float64(self, g: dolfinx.cpp.fem.Function_float64, dofs: ndarray[dtype=int32, shape=(*), order='C', writable=False])
- class dolfinx.cpp.fem.DirichletBC_float64(self, g: dolfinx.cpp.fem.Function_float64, dofs: collections.abc.Sequence[ndarray[dtype=int32, shape=(*), order='C', writable=False]], V: dolfinx.cpp.fem.FunctionSpace_float64)
Bases:
object
Object for representing Dirichlet (essential) boundary conditions
- dof_indices
- property dtype
(self) -> str
- property function_space
(self) -> dolfinx::fem::FunctionSpace<double>
- set
- property value
(self) -> dolfinx::fem::Function<double, double> | dolfinx::fem::Constant<double>
- class dolfinx.cpp.fem.DofMap(self, element_dof_layout: dolfinx.cpp.fem.ElementDofLayout, index_map: dolfinx.cpp.common.IndexMap, index_map_bs: int, dofmap: dolfinx.cpp.graph.AdjacencyList_int32, bs: int)
Bases:
object
DofMap object
- property bs
(self) -> int
- cell_dofs
- property dof_layout
(self) -> dolfinx.cpp.fem.ElementDofLayout
- property index_map
(self) -> dolfinx.cpp.common.IndexMap
- property index_map_bs
(self) -> int
- map
- class dolfinx.cpp.fem.ElementDofLayout(self, block_size: int, endity_dofs: collections.abc.Sequence[collections.abc.Sequence[collections.abc.Sequence[int]]], entity_closure_dofs: collections.abc.Sequence[collections.abc.Sequence[collections.abc.Sequence[int]]], parent_map: collections.abc.Sequence[int], sub_layouts: collections.abc.Sequence[dolfinx.cpp.fem.ElementDofLayout])
Bases:
object
Object describing the layout of dofs on a cell
- property block_size
(self) -> int
- entity_closure_dofs
- entity_dofs
- property num_dofs
(self) -> int
- num_entity_closure_dofs
- num_entity_dofs
- class dolfinx.cpp.fem.Expression_complex128(self, coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex128], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex128], X: ndarray[dtype=float64, shape=(*, *), order='C', writable=False], fn: int, value_shape: collections.abc.Sequence[int], argument_function_space: dolfinx.cpp.fem.FunctionSpace_float64)
Bases:
object
An Expression
- X
- property dtype
(self) -> str
- eval
- property value_shape
(self) -> list[int]
- property value_size
(self) -> int
- class dolfinx.cpp.fem.Expression_complex64(self, coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex64], X: ndarray[dtype=float32, shape=(*, *), order='C', writable=False], fn: int, value_shape: collections.abc.Sequence[int], argument_function_space: dolfinx.cpp.fem.FunctionSpace_float32)
Bases:
object
An Expression
- X
- property dtype
(self) -> str
- eval
- property value_shape
(self) -> list[int]
- property value_size
(self) -> int
- class dolfinx.cpp.fem.Expression_float32(self, coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float32], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float32], X: ndarray[dtype=float32, shape=(*, *), order='C', writable=False], fn: int, value_shape: collections.abc.Sequence[int], argument_function_space: dolfinx.cpp.fem.FunctionSpace_float32)
Bases:
object
An Expression
- X
- property dtype
(self) -> str
- eval
- property value_shape
(self) -> list[int]
- property value_size
(self) -> int
- class dolfinx.cpp.fem.Expression_float64(self, coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float64], X: ndarray[dtype=float64, shape=(*, *), order='C', writable=False], fn: int, value_shape: collections.abc.Sequence[int], argument_function_space: dolfinx.cpp.fem.FunctionSpace_float64)
Bases:
object
An Expression
- X
- property dtype
(self) -> str
- eval
- property value_shape
(self) -> list[int]
- property value_size
(self) -> int
- class dolfinx.cpp.fem.FiniteElement_float32(self, element: basix._basixcpp.FiniteElement_float32, block_size: int, symmetric: bool)
- class dolfinx.cpp.fem.FiniteElement_float32(self, elements: collections.abc.Sequence[dolfinx.cpp.fem.FiniteElement_float32])
- class dolfinx.cpp.fem.FiniteElement_float32(self, cell_type: dolfinx.cpp.mesh.CellType, points: numpy.ndarray[dtype=float32, shape=(*, *)], block_size: int, symmetry: bool)
Bases:
object
Finite element object
- T_apply
- Tt_apply
- Tt_inv_apply
- property basix_element
(self) -> basix::FiniteElement<float>
- property dtype
(self) -> str
- property interpolation_ident
(self) -> bool
- interpolation_points
- property needs_dof_transformations
(self) -> bool
- property num_sub_elements
(self) -> int
- signature
- property space_dimension
(self) -> int
- class dolfinx.cpp.fem.FiniteElement_float64(self, element: basix._basixcpp.FiniteElement_float64, block_size: int, symmetric: bool)
- class dolfinx.cpp.fem.FiniteElement_float64(self, elements: collections.abc.Sequence[dolfinx.cpp.fem.FiniteElement_float64])
- class dolfinx.cpp.fem.FiniteElement_float64(self, cell_type: dolfinx.cpp.mesh.CellType, points: numpy.ndarray[dtype=float64, shape=(*, *)], block_size: int, symmetry: bool)
Bases:
object
Finite element object
- T_apply
- Tt_apply
- Tt_inv_apply
- property basix_element
(self) -> basix::FiniteElement<double>
- property dtype
(self) -> str
- property interpolation_ident
(self) -> bool
- interpolation_points
- property needs_dof_transformations
(self) -> bool
- property num_sub_elements
(self) -> int
- signature
- property space_dimension
(self) -> int
- class dolfinx.cpp.fem.Form_complex128(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex128], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex128], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None)
- class dolfinx.cpp.fem.Form_complex128(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex128], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex128], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None)
Bases:
object
Variational form object
Overloaded function.
__init__(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex128], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex128], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None) -> None
__init__(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex128], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex128], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None) -> None
Create a Form from a pointer to a ufcx_form
- property coefficients
(self) -> list[dolfinx.cpp.fem.Function_complex128]
- domains
- property dtype
(self) -> str
- property function_spaces
(self) -> list[dolfinx::fem::FunctionSpace<double>]
- integral_ids
- property integral_types
(self) -> set[dolfinx::fem::IntegralType]
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float64
- property needs_facet_permutations
(self) -> bool
- property rank
(self) -> int
- class dolfinx.cpp.fem.Form_complex64(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex64], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None)
- class dolfinx.cpp.fem.Form_complex64(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex64], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None)
Bases:
object
Variational form object
Overloaded function.
__init__(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex64], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None) -> None
__init__(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_complex64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_complex64], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None) -> None
Create a Form from a pointer to a ufcx_form
- property coefficients
(self) -> list[dolfinx.cpp.fem.Function_complex64]
- domains
- property dtype
(self) -> str
- property function_spaces
(self) -> list[dolfinx::fem::FunctionSpace<float>]
- integral_ids
- property integral_types
(self) -> set[dolfinx::fem::IntegralType]
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float32
- property needs_facet_permutations
(self) -> bool
- property rank
(self) -> int
- class dolfinx.cpp.fem.Form_float32(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float32], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float32], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None)
- class dolfinx.cpp.fem.Form_float32(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float32], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float32], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None)
Bases:
object
Variational form object
Overloaded function.
__init__(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float32], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float32], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None) -> None
__init__(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float32], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float32], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float32], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float32, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float32 | None) -> None
Create a Form from a pointer to a ufcx_form
- property coefficients
(self) -> list[dolfinx.cpp.fem.Function_float32]
- domains
- property dtype
(self) -> str
- property function_spaces
(self) -> list[dolfinx::fem::FunctionSpace<float>]
- integral_ids
- property integral_types
(self) -> set[dolfinx::fem::IntegralType]
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float32
- property needs_facet_permutations
(self) -> bool
- property rank
(self) -> int
- class dolfinx.cpp.fem.Form_float64(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float64], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None)
- class dolfinx.cpp.fem.Form_float64(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float64], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None)
Bases:
object
Variational form object
Overloaded function.
__init__(self, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], integrals: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, int, ndarray[dtype=int32, shape=(*), order='C', writable=False], ndarray[dtype=int8, shape=(*), order='C', writable=False]]]], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float64], need_permutation_data: bool, entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None) -> None
__init__(self, form: int, spaces: collections.abc.Sequence[dolfinx.cpp.fem.FunctionSpace_float64], coefficients: collections.abc.Sequence[dolfinx.cpp.fem.Function_float64], constants: collections.abc.Sequence[dolfinx.cpp.fem.Constant_float64], subdomains: collections.abc.Mapping[dolfinx.cpp.fem.IntegralType, collections.abc.Sequence[tuple[int, ndarray[dtype=int32, shape=(*), order='C', writable=False]]]], entity_maps: collections.abc.Mapping[dolfinx.cpp.mesh.Mesh_float64, ndarray[dtype=int32, shape=(*), order='C', writable=False]], mesh: dolfinx.cpp.mesh.Mesh_float64 | None) -> None
Create a Form from a pointer to a ufcx_form
- property coefficients
(self) -> list[dolfinx.cpp.fem.Function_float64]
- domains
- property dtype
(self) -> str
- property function_spaces
(self) -> list[dolfinx::fem::FunctionSpace<double>]
- integral_ids
- property integral_types
(self) -> set[dolfinx::fem::IntegralType]
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float64
- property needs_facet_permutations
(self) -> bool
- property rank
(self) -> int
- class dolfinx.cpp.fem.FunctionSpace_float32(self, mesh: dolfinx.cpp.mesh.Mesh_float32, element: dolfinx.cpp.fem.FiniteElement_float32, dofmap: dolfinx.cpp.fem.DofMap, value_shape: collections.abc.Sequence[int])
Bases:
object
Finite element function space
- collapse
- component
- contains
- property dofmap
(self) -> dolfinx.cpp.fem.DofMap
- property element
(self) -> dolfinx::fem::FiniteElement<float>
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float32
- sub
- tabulate_dof_coordinates
- property value_shape
(self) -> numpy.ndarray[dtype=uint64, writable=False]
- class dolfinx.cpp.fem.FunctionSpace_float64(self, mesh: dolfinx.cpp.mesh.Mesh_float64, element: dolfinx.cpp.fem.FiniteElement_float64, dofmap: dolfinx.cpp.fem.DofMap, value_shape: collections.abc.Sequence[int])
Bases:
object
Finite element function space
- collapse
- component
- contains
- property dofmap
(self) -> dolfinx.cpp.fem.DofMap
- property element
(self) -> dolfinx::fem::FiniteElement<double>
- property mesh
(self) -> dolfinx.cpp.mesh.Mesh_float64
- sub
- tabulate_dof_coordinates
- property value_shape
(self) -> numpy.ndarray[dtype=uint64, writable=False]
- class dolfinx.cpp.fem.Function_complex128(self, arg: dolfinx.cpp.fem.FunctionSpace_float64, /)
- class dolfinx.cpp.fem.Function_complex128(self, arg0: dolfinx.cpp.fem.FunctionSpace_float64, arg1: dolfinx.cpp.la.Vector_complex128, /)
Bases:
object
A finite element function
Overloaded function.
__init__(self, arg: dolfinx.cpp.fem.FunctionSpace_float64, /) -> None
Create a function on the given function space
__init__(self, arg0: dolfinx.cpp.fem.FunctionSpace_float64, arg1: dolfinx.cpp.la.Vector_complex128, /) -> None
- collapse
Collapse sub-function view
- eval
Evaluate Function
- property function_space
(self) -> dolfinx::fem::FunctionSpace<double>
- interpolate
Overloaded function.
interpolate(self, f: ndarray[dtype=complex128, shape=(*), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, f: ndarray[dtype=complex128, shape=(*, *), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, u: dolfinx.cpp.fem.Function_complex128, cells0: ndarray[dtype=int32, shape=(*), order='C', writable=False], cells1: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate a finite element function
interpolate(self, u: dolfinx.cpp.fem.Function_complex128, cells: ndarray[dtype=int32, shape=(*), order='C', writable=False], interpolation_data: dolfinx.cpp.geometry.PointOwnershipData_float64) -> None
Interpolate a finite element function on non-matching meshes
interpolate(self, e0: dolfinx.cpp.fem.Expression_complex128, cells0: ndarray[dtype=int32, order='C', writable=False], cells1: ndarray[dtype=int32, order='C', writable=False]) -> None
Interpolate an Expression on a set of cells
- interpolate_ptr
Interpolate using a pointer to an expression with a C signature
- property name
(self) -> str
- sub
Return sub-function (view into parent Function
- property x
Return the vector associated with the finite element Function
- class dolfinx.cpp.fem.Function_complex64(self, arg: dolfinx.cpp.fem.FunctionSpace_float32, /)
- class dolfinx.cpp.fem.Function_complex64(self, arg0: dolfinx.cpp.fem.FunctionSpace_float32, arg1: dolfinx.cpp.la.Vector_complex64, /)
Bases:
object
A finite element function
Overloaded function.
__init__(self, arg: dolfinx.cpp.fem.FunctionSpace_float32, /) -> None
Create a function on the given function space
__init__(self, arg0: dolfinx.cpp.fem.FunctionSpace_float32, arg1: dolfinx.cpp.la.Vector_complex64, /) -> None
- collapse
Collapse sub-function view
- eval
Evaluate Function
- property function_space
(self) -> dolfinx::fem::FunctionSpace<float>
- interpolate
Overloaded function.
interpolate(self, f: ndarray[dtype=complex64, shape=(*), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, f: ndarray[dtype=complex64, shape=(*, *), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, u: dolfinx.cpp.fem.Function_complex64, cells0: ndarray[dtype=int32, shape=(*), order='C', writable=False], cells1: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate a finite element function
interpolate(self, u: dolfinx.cpp.fem.Function_complex64, cells: ndarray[dtype=int32, shape=(*), order='C', writable=False], interpolation_data: dolfinx.cpp.geometry.PointOwnershipData_float32) -> None
Interpolate a finite element function on non-matching meshes
interpolate(self, e0: dolfinx.cpp.fem.Expression_complex64, cells0: ndarray[dtype=int32, order='C', writable=False], cells1: ndarray[dtype=int32, order='C', writable=False]) -> None
Interpolate an Expression on a set of cells
- interpolate_ptr
Interpolate using a pointer to an expression with a C signature
- property name
(self) -> str
- sub
Return sub-function (view into parent Function
- property x
Return the vector associated with the finite element Function
- class dolfinx.cpp.fem.Function_float32(self, arg: dolfinx.cpp.fem.FunctionSpace_float32, /)
- class dolfinx.cpp.fem.Function_float32(self, arg0: dolfinx.cpp.fem.FunctionSpace_float32, arg1: dolfinx.cpp.la.Vector_float32, /)
Bases:
object
A finite element function
Overloaded function.
__init__(self, arg: dolfinx.cpp.fem.FunctionSpace_float32, /) -> None
Create a function on the given function space
__init__(self, arg0: dolfinx.cpp.fem.FunctionSpace_float32, arg1: dolfinx.cpp.la.Vector_float32, /) -> None
- collapse
Collapse sub-function view
- eval
Evaluate Function
- property function_space
(self) -> dolfinx::fem::FunctionSpace<float>
- interpolate
Overloaded function.
interpolate(self, f: ndarray[dtype=float32, shape=(*), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, f: ndarray[dtype=float32, shape=(*, *), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, u: dolfinx.cpp.fem.Function_float32, cells0: ndarray[dtype=int32, shape=(*), order='C', writable=False], cells1: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate a finite element function
interpolate(self, u: dolfinx.cpp.fem.Function_float32, cells: ndarray[dtype=int32, shape=(*), order='C', writable=False], interpolation_data: dolfinx.cpp.geometry.PointOwnershipData_float32) -> None
Interpolate a finite element function on non-matching meshes
interpolate(self, e0: dolfinx.cpp.fem.Expression_float32, cells0: ndarray[dtype=int32, order='C', writable=False], cells1: ndarray[dtype=int32, order='C', writable=False]) -> None
Interpolate an Expression on a set of cells
- interpolate_ptr
Interpolate using a pointer to an expression with a C signature
- property name
(self) -> str
- sub
Return sub-function (view into parent Function
- property x
Return the vector associated with the finite element Function
- class dolfinx.cpp.fem.Function_float64(self, arg: dolfinx.cpp.fem.FunctionSpace_float64, /)
- class dolfinx.cpp.fem.Function_float64(self, arg0: dolfinx.cpp.fem.FunctionSpace_float64, arg1: dolfinx.cpp.la.Vector_float64, /)
Bases:
object
A finite element function
Overloaded function.
__init__(self, arg: dolfinx.cpp.fem.FunctionSpace_float64, /) -> None
Create a function on the given function space
__init__(self, arg0: dolfinx.cpp.fem.FunctionSpace_float64, arg1: dolfinx.cpp.la.Vector_float64, /) -> None
- collapse
Collapse sub-function view
- eval
Evaluate Function
- property function_space
(self) -> dolfinx::fem::FunctionSpace<double>
- interpolate
Overloaded function.
interpolate(self, f: ndarray[dtype=float64, shape=(*), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, f: ndarray[dtype=float64, shape=(*, *), order='C', writable=False], cells: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate an expression function
interpolate(self, u: dolfinx.cpp.fem.Function_float64, cells0: ndarray[dtype=int32, shape=(*), order='C', writable=False], cells1: ndarray[dtype=int32, shape=(*), order='C', writable=False]) -> None
Interpolate a finite element function
interpolate(self, u: dolfinx.cpp.fem.Function_float64, cells: ndarray[dtype=int32, shape=(*), order='C', writable=False], interpolation_data: dolfinx.cpp.geometry.PointOwnershipData_float64) -> None
Interpolate a finite element function on non-matching meshes
interpolate(self, e0: dolfinx.cpp.fem.Expression_float64, cells0: ndarray[dtype=int32, order='C', writable=False], cells1: ndarray[dtype=int32, order='C', writable=False]) -> None
Interpolate an Expression on a set of cells
- interpolate_ptr
Interpolate using a pointer to an expression with a C signature
- property name
(self) -> str
- sub
Return sub-function (view into parent Function
- property x
Return the vector associated with the finite element Function