Gridap.FESpaces
Gridap.FESpaces
— ModuleThe exported names are
AffineFEOperator
AffineFETerm
AffineFETermFromCellMatVec
Assembler
AssemblyStrategy
CLagrangianFESpace
ConformingFESpace
DefaultAssemblyStrategy
DirichletFESpace
DiscontinuousFESpace
EvaluationFunction
ExtendedFESpace
FECellBasisStyle
FEEnergy
FEFunction
FEFunctionStyle
FEOperator
FEOperatorFromTerms
FESolver
FESource
FESpace
FESpaceWithConstantFixed
FESpaceWithLastDofRemoved
FESpaceWithLinearConstraints
FETerm
FETermFromCellJacRes
GenericSparseMatrixAssembler
GradConformingFESpace
HomogeneousTrialFESpace
HomogeneousTrialFESpace!
LinearFESolver
LinearFETerm
NonlinearFESolver
SingleFieldFEFunction
SingleFieldFESpace
SparseMatrixAssembler
TestFESpace
TrialFESpace
TrialFESpace!
UnconstrainedFESpace
ZeroMeanFESpace
allocate_matrix
allocate_matrix_and_vector
allocate_vector
assemble_matrix
assemble_matrix!
assemble_matrix_add!
assemble_matrix_and_vector
assemble_matrix_and_vector!
assemble_matrix_and_vector_add!
assemble_vector
assemble_vector!
assemble_vector_add!
autodiff_cell_jacobian_from_energy
autodiff_cell_jacobian_from_residual
autodiff_cell_residual_from_energy
col_map
col_mask
collect_cell_jacobian
collect_cell_jacobian_and_residual
collect_cell_matrix
collect_cell_matrix_and_vector
collect_cell_residual
collect_cell_vector
compute_conforming_cell_dofs
compute_dirichlet_values
compute_dirichlet_values_for_tags
compute_dirichlet_values_for_tags!
compute_free_and_dirichlet_values
compute_free_values
constraint_style
count_matrix_and_vector_nnz_coo
count_matrix_nnz_coo
fill_matrix_and_vector_coo_numeric!
fill_matrix_and_vector_coo_symbolic!
fill_matrix_coo_numeric!
fill_matrix_coo_symbolic!
gather_dirichlet_values
gather_dirichlet_values!
gather_free_and_dirichlet_values
gather_free_and_dirichlet_values!
gather_free_values
gather_free_values!
get_algebraic_operator
get_cell_axes
get_cell_axes_with_constraints
get_cell_basis
get_cell_constraints
get_cell_dof_basis
get_cell_dofs
get_cell_isconstrained
get_cell_jacobian
get_cell_jacobian_and_residual
get_cell_matrix
get_cell_residual
get_cell_values
get_cell_vector
get_dirichlet_dof_tag
get_dirichlet_values
get_fe_space
get_free_values
get_matrix_type
get_test
get_trial
get_vector_type
has_constraints
interpolate
interpolate!
interpolate_dirichlet
interpolate_dirichlet!
interpolate_everywhere
interpolate_everywhere!
is_a_fe_cell_basis
is_a_fe_function
num_dirichlet_dofs
num_dirichlet_tags
num_free_dofs
row_map
row_mask
scatter_free_and_dirichlet_values
test_assembler
test_fe_function
test_fe_operator
test_fe_solver
test_fe_space
test_single_field_fe_space
test_sparse_matrix_assembler
zero_dirichlet_values
zero_free_values
Gridap.FESpaces.AffineFEOperator
— TypeAffineFEOperator
Reprepresent a fully assembled affine (linear) finite element problem. See also FEOperator
Gridap.FESpaces.AffineFEOperator
— MethodGridap.FESpaces.AffineFEOperator
— MethodAffineFEOperator(test::FESpace,trial::FESpace,assem::Assembler,terms::AffineFETerm...) AffineFEOperator(test::FESpace,trial::FESpace,terms::AffineFETerm...)
Gridap.FESpaces.AffineFETerm
— TypeSee also FETerm.
Gridap.FESpaces.AffineFETerm
— MethodGridap.FESpaces.AffineFETermFromCellMatVec
— TypeGridap.FESpaces.Assembler
— TypeGridap.FESpaces.AssemblyStrategy
— TypeGridap.FESpaces.CLagrangianFESpace
— Typestruct CLagrangianFESpace{S} <: SingleFieldFESpace
grid::Grid
dof_to_node::Vector{Int}
dof_to_comp::Vector{Int8}
node_and_comp_to_dof::Vector{S}
# + private fields
end
Gridap.FESpaces.CLagrangianFESpace
— MethodCLagrangianFESpace(::Type{T},grid::Grid) where T
Gridap.FESpaces.DirichletFESpace
— Typestruct DirichletFESpace <: SingleFieldFESpace
space::SingleFieldFESpace
end
Gridap.FESpaces.ExtendedFESpace
— TypeGridap.FESpaces.FEOperator
— Typeabstract type FEOperator <: GridapType
A FEOperator
contains finite element problem, that is assembled as far as possible and ready to be solved. See also FETerm
Gridap.FESpaces.FEOperator
— MethodGridap.FESpaces.FEOperator
— MethodGridap.FESpaces.FESolver
— TypeGridap.FESpaces.FESolver
— MethodGridap.FESpaces.FESource
— TypeGridap.FESpaces.FESource
— MethodGridap.FESpaces.FESpace
— TypeGridap.FESpaces.FESpace
— MethodFESpace(; kwargs...)
Construct a FESpace
. Supported keywords are: [:reffe, :conformity, :order, :labels, :valuetype, :model, :triangulation, :dirichlettags, :dirichletmasks, :dofspace, :constraint, :zeromeantrian, :zeromean_quad]
Gridap.FESpaces.FESpaceWithConstantFixed
— TypeFESpaceWithConstantFixed(space::SingleFieldFESpace, fix_constant::Bool,
dof_to_fix::Int=num_free_dofs(space))
Gridap.FESpaces.FETerm
— Typeabstract type FETerm <: GridapType end
A FETerm
is a lazy representation of a summand of a finite element problem. It is not assembled. See also FEOperator.
Gridap.FESpaces.FETerm
— MethodGridap.FESpaces.FETerm
— MethodGridap.FESpaces.FETermFromCellJacRes
— TypeGridap.FESpaces.LinearFESolver
— TypeThe solver that solves a LinearFEOperator
Gridap.FESpaces.LinearFESolver
— MethodGridap.FESpaces.LinearFETerm
— TypeSee also FETerm.
Gridap.FESpaces.LinearFETerm
— MethodGridap.FESpaces.NonlinearFESolver
— TypeA general NonlinearFESolver
Gridap.FESpaces.NonlinearFESolver
— MethodGridap.FESpaces.SingleFieldFEFunction
— TypeGridap.FESpaces.SingleFieldFEFunction
— MethodGridap.FESpaces.SingleFieldFESpace
— TypeGridap.FESpaces.SparseMatrixAssembler
— TypeGridap.FESpaces.SparseMatrixAssembler
— MethodGridap.FESpaces.TrialFESpace
— MethodGridap.FESpaces.TrialFESpace
— MethodGridap.FESpaces.UnconstrainedFESpace
— TypeGeneric implementation of an unconstrained single-field FE space Private fields and type parameters
Gridap.FESpaces.ZeroMeanFESpace
— Typestruct ZeroMeanFESpace <: SingleFieldFESpace
# private fields
end
Gridap.FESpaces.ZeroMeanFESpace
— MethodZeroMeanFESpace(
space::SingleFieldFESpace,
trian::Triangulation,
quad::CellQuadrature)
Gridap.Algebra.allocate_matrix
— MethodGridap.Algebra.allocate_matrix_and_vector
— MethodGridap.Algebra.allocate_vector
— MethodGridap.CellData.get_cell_axes
— MethodGridap.FESpaces.ConformingFESpace
— FunctionGridap.FESpaces.DiscontinuousFESpace
— FunctionDiscontinuousFESpace(reffes::Vector{<:ReferenceFE}, trian::Triangulation)
Gridap.FESpaces.FEFunction
— MethodGridap.FESpaces.FEFunction
— MethodFEFunction(
fs::SingleFieldFESpace, free_values::AbstractVector, dirichlet_values::AbstractVector)
The resulting FEFunction will be in the space if and only if dirichlet_values
are the ones provided by get_dirichlet_values(fs)
Gridap.FESpaces.FEFunctionStyle
— MethodTypes marked with this trait need to implement the following queries
- [
get_free_values(object)
] - [
get_fe_space(object)
]
Gridap.FESpaces.GradConformingFESpace
— FunctionGridap.FESpaces.TestFESpace
— MethodGridap.FESpaces.TrialFESpace!
— MethodGridap.FESpaces.TrialFESpace!
— MethodGridap.FESpaces.assemble_matrix!
— MethodGridap.FESpaces.assemble_matrix
— MethodGridap.FESpaces.assemble_matrix_add!
— MethodGridap.FESpaces.assemble_matrix_and_vector!
— MethodGridap.FESpaces.assemble_matrix_and_vector
— MethodGridap.FESpaces.assemble_vector!
— MethodGridap.FESpaces.assemble_vector
— MethodGridap.FESpaces.assemble_vector_add!
— MethodGridap.FESpaces.autodiff_cell_jacobian_from_energy
— FunctionGridap.FESpaces.autodiff_cell_jacobian_from_residual
— FunctionGridap.FESpaces.autodiff_cell_residual_from_energy
— FunctionGridap.FESpaces.col_map
— MethodGridap.FESpaces.col_mask
— MethodGridap.FESpaces.collect_cell_jacobian
— MethodGridap.FESpaces.collect_cell_jacobian_and_residual
— MethodGridap.FESpaces.collect_cell_matrix
— MethodGridap.FESpaces.collect_cell_matrix_and_vector
— MethodGridap.FESpaces.collect_cell_residual
— MethodGridap.FESpaces.collect_cell_vector
— MethodGridap.FESpaces.compute_conforming_cell_dofs
— Functioncomputeconformingcelldofs( reffes, conf, gridtopology, facelabeling, dirichlettags)
computeconformingcelldofs( reffes, conf, gridtopology, facelabeling, dirichlettags, dirichlet_components)
The result is the tuple
(cell_dofs, nfree, ndiri, dirichlet_dof_tag, dirichlet_cells)
Assumes that the reffes are aligned with the cell type in the grid_topology and that it is possible to build a conforming space without imposing constraints
If dirichlet_components
is given, then get_dof_to_comp
has to be defined for the reference elements in reffes
.
Gridap.FESpaces.compute_dirichlet_values_for_tags
— MethodGridap.FESpaces.constraint_style
— MethodGridap.FESpaces.count_matrix_and_vector_nnz_coo
— MethodGridap.FESpaces.count_matrix_nnz_coo
— MethodGridap.FESpaces.fill_matrix_and_vector_coo_numeric!
— FunctionGridap.FESpaces.fill_matrix_coo_numeric!
— FunctionGridap.FESpaces.fill_matrix_coo_symbolic!
— FunctionGridap.FESpaces.gather_dirichlet_values!
— MethodGridap.FESpaces.gather_dirichlet_values
— MethodGridap.FESpaces.gather_free_and_dirichlet_values!
— MethodGridap.FESpaces.gather_free_and_dirichlet_values
— MethodGridap.FESpaces.gather_free_values!
— MethodGridap.FESpaces.gather_free_values
— MethodGridap.FESpaces.get_algebraic_operator
— Methodget_algebraic_operator(feop)
Return an "algebraic view" of an operator. Algebraic means, that the resulting operator acts on plain arrays, instead of FEFunctions
. This can be useful for solving with external tools like NLsolve.jl
. See also FEOperator
.
Gridap.FESpaces.get_cell_axes_with_constraints
— MethodGridap.FESpaces.get_cell_basis
— MethodGridap.FESpaces.get_cell_dof_basis
— MethodGridap.FESpaces.get_cell_dofs
— MethodGridap.FESpaces.get_cell_jacobian
— MethodReturns an object representing the contribution to the Jacobian of the given term. Returns nothing if the term has not contribution to the Jacobian (typically for source terms)
Gridap.FESpaces.get_cell_jacobian_and_residual
— MethodGridap.FESpaces.get_cell_matrix
— MethodReturns an object representing the contribution to the system matrix of the given term. Returns nothing if the term has not contribution (typically for source terms)
Gridap.FESpaces.get_cell_residual
— MethodReturns an object representing the contribution to the residual of the given term. Returns always something.
Gridap.FESpaces.get_cell_values
— MethodGridap.FESpaces.get_cell_vector
— MethodReturns an object (e.g. a CellVector) representing the contribution to the system rhs of the given term (with Dirichlet bcs included). Returns nothing if the term has not contribution (typically for linear terms)
Gridap.FESpaces.get_cell_vector
— MethodReturns an object (e.g. a CellVector) representing the contribution to the system rhs of the given term (without Dirichlet bcs). Returns nothing if the term has not contribution (typically for linear terms)
Gridap.FESpaces.get_dirichlet_dof_tag
— MethodGridap.FESpaces.get_dirichlet_values
— MethodGridap.FESpaces.get_fe_space
— MethodGridap.FESpaces.get_free_values
— MethodGridap.FESpaces.get_matrix_type
— MethodGridap.FESpaces.get_test
— MethodGridap.FESpaces.get_test
— MethodGridap.FESpaces.get_trial
— MethodGridap.FESpaces.get_trial
— MethodGridap.FESpaces.get_vector_type
— MethodGridap.FESpaces.has_constraints
— MethodGridap.FESpaces.interpolate!
— MethodGridap.FESpaces.interpolate
— MethodThe resulting FE function is in the space (in particular it fulfills Dirichlet BCs even in the case that the given cell field does not fulfill them)
Gridap.FESpaces.interpolate_dirichlet!
— MethodGridap.FESpaces.interpolate_dirichlet
— MethodGridap.FESpaces.interpolate_everywhere!
— MethodGridap.FESpaces.interpolate_everywhere
— Methodlike interpolate, but also compute new degrees of freedom for the dirichlet component. The resulting FEFunction does not necessary belongs to the underlying space
Gridap.FESpaces.is_a_fe_cell_basis
— MethodGridap.FESpaces.is_a_fe_function
— MethodGridap.FESpaces.num_dirichlet_dofs
— MethodGridap.FESpaces.num_dirichlet_tags
— MethodGridap.FESpaces.num_free_dofs
— MethodGridap.FESpaces.row_map
— MethodGridap.FESpaces.row_mask
— MethodGridap.FESpaces.scatter_free_and_dirichlet_values
— MethodGridap.FESpaces.test_assembler
— MethodGridap.FESpaces.test_fe_function
— MethodGridap.FESpaces.test_fe_operator
— MethodGridap.FESpaces.test_fe_solver
— FunctionGridap.FESpaces.test_fe_space
— MethodGridap.FESpaces.test_single_field_fe_space
— FunctionGridap.FESpaces.zero_dirichlet_values
— MethodGridap.FESpaces.zero_free_values
— MethodBase.zero
— MethodGridap.Algebra.allocate_jacobian
— MethodGridap.Algebra.allocate_residual
— MethodGridap.Algebra.get_matrix
— MethodGridap.Algebra.get_vector
— MethodGridap.Algebra.jacobian!
— Methodjacobian!(A, op, u)
Inplace version of jacobian
.
Gridap.Algebra.jacobian
— Methodjacobian(op, u)
Compute the jacobian of an operator op
. See also get_algebraic_operator
, residual_and_jacobian!
.
Gridap.Algebra.residual!
— Methodresidual!(b, op, u)
Inplace version of residual
.
Gridap.Algebra.residual
— Methodresidual(op, u)
Compute the residual of op
at u
. See also residual_and_jacobian
Gridap.Algebra.residual_and_jacobian!
— Methodresidual_and_jacobian!(b, A, op, u)
Inplace version of residual_and_jacobian
.
Gridap.Algebra.residual_and_jacobian
— Methodresidual, jacobian =
residual_and_jacobian(op, u)
Compute the residual and jacobian of an operator op
at a given point u
. Depending on the nature of op
the point u
can either be a plain array or a FEFunction
.
See also jacobian
, residual
, get_algebraic_operator
.
Gridap.Algebra.solve!
— Methoduh, cache = solve!(uh,solver,op,cache)
This function changes the state of the input and can render it in a corrupted state. It is recommended to rewrite the input uh
with the output as illustrated to prevent any issue. If cache===nothing
, then it creates a new cache object.
Gridap.Algebra.solve!
— Methoduh, cache = solve!(uh,solver,op)
This function changes the state of the input and can render it in a corrupted state. It is recommended to rewrite the input uh
with the output as illustrated to prevent any issue.
Gridap.Algebra.solve
— MethodGridap.Algebra.solve
— MethodSolve that allocates, and sets initial guess to zero and returns the solution
Gridap.CellData.get_cell_map
— MethodGridap.FESpaces.compute_cell_space
— MethodGridap.FESpaces.compute_cell_space_physical
— MethodIt creates the cell-wise DOF basis and shape functions, when the DOFs are evaluated at the physical space. The DOFs (moments) for the prebasis are assumed to be computable at a reference FE space.
Gridap.FESpaces.compute_discontinuous_cell_dofs
— MethodGridap.FESpaces.get_assembly_strategy
— MethodGridap.FESpaces.get_cell_matrix_and_vector
— MethodGridap.Geometry.get_cell_id
— Method