KASKADE 7 development version
|
A class for assembling Galerkin representation matrices and right hand sides for variational functionals depending on multiple variables. More...
#include <assemblerCore.hh>
A class for assembling Galerkin representation matrices and right hand sides for variational functionals depending on multiple variables.
Template parameters:
F | The variational functional. This has to be a model of the VariationalFunctional concept. |
BoundaryDetector | A policy class type for detecting cells incident to the boundary. Currently CachingBoundaryDetector, ForwardingBoundaryDetector, and TrivialBoundaryDetector may be used. |
QuadRule | allows choice of quadrature formula. Default: provided by DUNE, some special formulas: special_quadrature.hh |
After a grid refinement an assembler is not valid anymore and has to be constructed again. This is, because the assembler copies the index set at construction, which changes, if the grid changes
Definition at line 1430 of file assemblerCore.hh.
Classes | |
struct | BlockToSequence |
struct | BlockToTriplet |
struct | CountNonzeros |
Public Types | |
typedef VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule > | Self |
typedef F | Functional |
functional More... | |
typedef Functional::AnsatzVars | AnsatzVariableSetDescription |
ansatz variables More... | |
typedef Functional::TestVars | TestVariableSetDescription |
test variables More... | |
typedef AnsatzVariableSetDescription::Grid | Grid |
grid More... | |
typedef AnsatzVariableSetDescription::GridView | GridView |
The grid view on which the variables live. More... | |
typedef AnsatzVariableSetDescription::Spaces | Spaces |
spaces More... | |
typedef AnsatzVariableSetDescription::IndexSet | IndexSet |
index set More... | |
typedef Functional::Scalar | field_type |
Underlying field type. More... | |
using | Scalar = field_type |
using | MatrixBlockArray = typename AssemblyDetail::BlockArray< Policy, AnsatzVariables, TestVariables, SparseIndex >::type |
A boost::fusion sequence of AssemblyDetail::MatrixBlock elements for present matrix blocks. More... | |
typedef AssemblyDetail::RhsBlockArray< Policy, TestVariables >::type | RhsBlockArray |
A boost::fusion sequence of AssemblyDetail::RhsBock elements for present rhs blocks. More... | |
typedef TestVariableSetDescription::template CoefficientVectorRepresentation ::type | RhsArray |
A LinearProductSpace type of right hand side coefficient vectors. More... | |
Public Member Functions | |
VariationalFunctionalAssembler (Spaces const &spaces) | |
Construct an empty assembler, gridManager is implicitly obtained from the first space. More... | |
void | assemble (F const &f, unsigned int flags=Assembler::EVERYTHING, int nThreads=0, bool verbose=false) |
Assembly without block filter or cell filter. More... | |
template<class BlockFilter , class CellFilter > | |
void | assemble (F const &f, CellFilter const &cellFilter, unsigned int flags=Assembler::EVERYTHING, int nTasks=0, bool verbose=false) |
Create data in assembler. More... | |
int | valid () |
Returns a bitfield specifyign which of the parts have been assembled since construction or flush() according to the format (VALUE|RHS|MATRX). More... | |
void | flush (int flags=(VALUE|RHS|MATRIX)) |
Destructs parts of the assembled quatities according to the format (VALUE|RHS|MATRX) More... | |
std::pair< size_t, size_t > | size (int row, int col) const |
the size of a matrix block (in terms of scalar rows/columns) More... | |
template<class DataOutIter > | |
void | toSequence (int rbegin, int rend, DataOutIter xi) const |
Writes the subvector defined by the half-open block range [rbegin,rend) to the output iterator xi. More... | |
MatrixBlockArray & | getMatrix () const |
Returns a mutable reference to the sequence of matrix blocks. More... | |
template<int first = 0, int last = TestVariableSetDescription::noOfVariables> | |
TestVariableSetDescription::template CoefficientVectorRepresentation< first, last >::type | rhs () const |
Returns a contiguous subrange of the rhs coefficient vectors. More... | |
Tuning parameters | |
Self & | setNSimultaneousBlocks (int n) |
Defines how many cells are assembled locally before scattering them together into the global data structures. More... | |
Self & | setRowBlockFactor (double a) |
Defines how many more row blocks in each matrix are used compared to the number of threads. More... | |
Self & | setLocalStorageSize (size_t s) |
Defines how many memory the locally assembled matrices may occupy before they are scattered. More... | |
Self & | setGatherTimings (bool gt) |
Whether to gather timing statistics using Kaskade::Timings. More... | |
Submatrix access | |
template<class Matrix > | |
Matrix | get (bool extractOnlyLowerTriangle=false, int rbegin=0, int rend=TestVariableSetDescription::noOfVariables, int cbegin=0, int cend=AnsatzVariableSetDescription::noOfVariables) const |
Extracts the submatrix defined by the half-open block ranges [rbegin,rend), [cbegin,cend). More... | |
template<int row, int col> | |
auto const & | get () const |
Extracts a raw single submatrix block indexed by row and column. More... | |
template<class MatrixType , class BlockInformation > | |
MatrixType | get (bool extractOnlyLowerTriangle) const |
Extracts the submatrix defined by the half-open block ranges given as template parameter. More... | |
General information | |
size_t | nnz (size_t rbegin=0, size_t rend=TestVariableSetDescription::noOfVariables, size_t cbegin=0, size_t cend=AnsatzVariableSetDescription::noOfVariables, bool extractOnlyLowerTriangle=false) const |
Returns the number of structurally nonzero entries in the submatrix defined by the half-open block ranges [rbegin,rend), [cbegin,cend). More... | |
size_t | nrows (int firstBlock=0, int lastBlock=TestVariableSetDescription::noOfVariables) const |
Returns the number of scalar rows in the row block range [firstBlock,lastBlock[. More... | |
size_t | ncols (int firstBlock=0, int lastBlock=AnsatzVariableSetDescription::noOfVariables) const |
Returns the number of scalar cols in the column block range [firstBlock,lastBlock[. More... | |
Spaces const & | spaces () const |
Returns the list of spaces used. More... | |
GridView const & | gridView () const |
The grid view used. More... | |
Static Public Attributes | |
static unsigned int const | VALUE = Assembler::VALUE |
DEPRECATED, enums in the Assembler namespace. More... | |
static unsigned int const | RHS = Assembler::RHS |
static unsigned int const | MATRIX = Assembler::MATRIX |
static unsigned int const | EVERYTHING = Assembler::EVERYTHING |
Protected Types | |
typedef AssemblyDetail::FormulationPolicy< F > | Policy |
typedef AnsatzVariableSetDescription::Variables | AnsatzVariables |
typedef TestVariableSetDescription::Variables | TestVariables |
typedef GridView::template Codim< 0 >::Iterator | CellIterator |
typedef CellIterator::Entity | Entity |
Protected Member Functions | |
std::pair< RhsArray &, RhsBlockArray & > | getRhs () const |
void | reactToRefinement (GridSignals::Status const status) |
Protected Attributes | |
boost::signals2::scoped_connection | refConnection |
Spaces const & | spaces_ |
GridManagerBase< Grid > const & | gridManager |
GridView const & | gv |
IndexSet const & | indexSet |
std::shared_ptr< MatrixBlockArray > | matrixBlocks |
std::shared_ptr< RhsArray > | rhss |
std::shared_ptr< RhsBlockArray > | rhsBlocks |
BoundaryDetector | boundaryDetector |
int | validparts |
int | nSimultaneousBlocks |
double | rowBlockFactor |
size_t | localStorageSize |
bool | gatherTimings = false |
Static Protected Attributes | |
static constexpr bool | innerBoundaries = hasInnerBoundaryCache<Functional> |
|
protected |
Definition at line 1468 of file assemblerCore.hh.
typedef Functional::AnsatzVars Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::AnsatzVariableSetDescription |
ansatz variables
Definition at line 1442 of file assemblerCore.hh.
|
protected |
Definition at line 1607 of file assemblerCore.hh.
|
protected |
Definition at line 1608 of file assemblerCore.hh.
typedef Functional::Scalar Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::field_type |
Underlying field type.
Definition at line 1463 of file assemblerCore.hh.
typedef F Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::Functional |
functional
Definition at line 1440 of file assemblerCore.hh.
typedef AnsatzVariableSetDescription::Grid Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::Grid |
grid
Definition at line 1448 of file assemblerCore.hh.
typedef AnsatzVariableSetDescription::GridView Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::GridView |
The grid view on which the variables live.
Definition at line 1453 of file assemblerCore.hh.
typedef AnsatzVariableSetDescription::IndexSet Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::IndexSet |
index set
Definition at line 1458 of file assemblerCore.hh.
using Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::MatrixBlockArray = typename AssemblyDetail::BlockArray<Policy,AnsatzVariables,TestVariables,SparseIndex>::type |
A boost::fusion sequence of AssemblyDetail::MatrixBlock elements for present matrix blocks.
The elements of this sequence type include both block info and the global matrices.
Definition at line 1486 of file assemblerCore.hh.
|
protected |
Definition at line 1434 of file assemblerCore.hh.
typedef TestVariableSetDescription::template CoefficientVectorRepresentation ::type Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::RhsArray |
A LinearProductSpace type of right hand side coefficient vectors.
Definition at line 1498 of file assemblerCore.hh.
typedef AssemblyDetail::RhsBlockArray<Policy,TestVariables>::type Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::RhsBlockArray |
A boost::fusion sequence of AssemblyDetail::RhsBock elements for present rhs blocks.
The elements of this sequence type include the rhs block infos.
Definition at line 1493 of file assemblerCore.hh.
using Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::Scalar = field_type |
Definition at line 1465 of file assemblerCore.hh.
typedef VariationalFunctionalAssembler<F,SparseIndex,BoundaryDetector,QuadRule> Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::Self |
Definition at line 1437 of file assemblerCore.hh.
typedef AnsatzVariableSetDescription::Spaces Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::Spaces |
spaces
Definition at line 1456 of file assemblerCore.hh.
|
protected |
Definition at line 1469 of file assemblerCore.hh.
typedef Functional::TestVars Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::TestVariableSetDescription |
test variables
Definition at line 1445 of file assemblerCore.hh.
|
inlineexplicit |
Construct an empty assembler, gridManager is implicitly obtained from the first space.
Definition at line 1521 of file assemblerCore.hh.
|
inline |
Create data in assembler.
Assembles the value and/or derivative and/or Hessian (according to the given flags, default is to assemble all three) of the FE-discretized variational functional given by f. The block filter can be used for partial assembly of specified blocks in the matrix and rhs.
The data that is not concerned by the given flags and block filter is left unmodified. Be careful: This allows to drive the Galerkin operator representation into a semantically inconsistent state. This need not be a problem (instead it can be useful and more efficient in certain situations), but one has to be aware of that fact. The data that is not concerned by the cell filter is cleared before assembly (must be, because new values are partially added up to existing data).
BlockFilter | a traits class implementing the BlockFilter concept |
CellFilter | a callable type for deciding on which cells to assemble |
The assembled data can afterwards be accessed via the functional, rhs, and matrix methods.
f | the variational functional or weak formulation to be assembled |
cellFilter | a callable mapping a grid cell to a boolean. Assembly is performed only on those cells for which the cell filter returns true. This can be used, e.g., for subassembly in non-overlapping domain decomposition such as BDDC, or for partial update of stiffness matrices/rhs in case of spatially local changes in Newton's method. |
flags | a bitset determining what to assemble |
nTasks | number of tasks to submit to the thread pool for parallel execution. 0 (default) means to use the default hardware concurrency reported by the system. Sequential computation is performed if the grid is reported not to be thread-safe. You can call GridManagerBase::enforceConcurrentReads to lie about thread-safety in case you know (or believe) the implementation to be thread safe. |
verbose | whether to output status messages to standard output |
Definition at line 1652 of file assemblerCore.hh.
|
inline |
Assembly without block filter or cell filter.
Definition at line 1598 of file assemblerCore.hh.
Referenced by Kaskade::HigherOrderRecovery< Grid, Space >::getErrorFunction(), Kaskade::GoalOrientedErrorEstimator< TemplateFunctional, OriginalVariableSetDescription, ExtensionVariableSetDescription, ExtensionSpace >::operator()(), Kaskade::HierarchicalBasisErrorEstimator2< Functional, VariableSetDescription, ExtensionVariableSetDescription, ExtensionSpace, NormFunctional, LinearSolverLA, LinearSolverHA, LinearSolverLM, LinearSolverHM, lumpM, RefinementStrategy >::operator()(), Kaskade::HierarchicalBasisErrorEstimator< Functional, ExtensionVariableSetDescription, ExtensionSpace, NormFunctional, AdjustRHS >::operator()(), and Kaskade::Limex< Eq >::step().
|
inline |
Destructs parts of the assembled quatities according to the format (VALUE|RHS|MATRX)
The default flag leads to destruction of all three values.
Definition at line 2109 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::reactToRefinement().
|
inline |
Extracts a raw single submatrix block indexed by row and column.
Note that for symmetric matrices, only the lower triangular part is stored.
Compilation will fail if the referenced matrix block is not present.
Definition at line 2188 of file assemblerCore.hh.
|
inline |
Extracts the submatrix defined by the half-open block ranges given as template parameter.
Provide the block information via IstlInterface_Detail::BlockInfo.
Definition at line 2199 of file assemblerCore.hh.
|
inline |
Extracts the submatrix defined by the half-open block ranges [rbegin,rend), [cbegin,cend).
If extractOnlyLowerTriangle is true, the Galerkin operator is treated as if its upper triangle was structurally zero.
In order to be able to read the assembled matrix into the smart pointer a specialization of AssemblyDetail::Fill, i.e. AssemblyDetail::Fill<MatrixType> must be available!!!
Kaskade provides spezializations of AssemblyDetail::Fill for
extractOnlyLowerTriangle | if true, and the matrix is symmetric, only the lower triangular part is extracted |
rbegin | number first block row to store |
rend | number of one past the last block row to store |
cbegin | number first block column to store |
cend | number of one past the last block column to store |
Definition at line 2160 of file assemblerCore.hh.
|
inline |
Returns a mutable reference to the sequence of matrix blocks.
The data structure for the matrix is created on the fly if needed.
Definition at line 2285 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::get(), and Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::nnz().
|
inlineprotected |
Definition at line 2334 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::rhs(), and Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::toSequence().
|
inline |
The grid view used.
Definition at line 2269 of file assemblerCore.hh.
|
inline |
Returns the number of scalar cols in the column block range [firstBlock,lastBlock[.
Definition at line 2253 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::get().
|
inline |
Returns the number of structurally nonzero entries in the submatrix defined by the half-open block ranges [rbegin,rend), [cbegin,cend).
This is the number of elements written by the corresponding call of toTriplet().
Definition at line 2234 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::get(), Kaskade::HigherOrderRecovery< Grid, Space >::getErrorFunction(), and Kaskade::Limex< Eq >::step().
|
inline |
Returns the number of scalar rows in the row block range [firstBlock,lastBlock[.
Definition at line 2245 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::get().
|
inlineprotected |
Definition at line 2362 of file assemblerCore.hh.
|
inline |
Returns a contiguous subrange of the rhs coefficient vectors.
Definition at line 2327 of file assemblerCore.hh.
Referenced by Kaskade::GoalOrientedErrorEstimator< TemplateFunctional, OriginalVariableSetDescription, ExtensionVariableSetDescription, ExtensionSpace >::operator()(), Kaskade::HierarchicalBasisErrorEstimator< Functional, ExtensionVariableSetDescription, ExtensionSpace, NormFunctional, AdjustRHS >::operator()(), and Kaskade::Limex< Eq >::step().
|
inline |
Whether to gather timing statistics using Kaskade::Timings.
Gathering timings can be switched on and off. Note that if several assembler calls are done in parallel, it must be switched off, since the timings functionality is not thread-safe. Defaults to off.
Definition at line 1587 of file assemblerCore.hh.
|
inline |
Defines how many memory the locally assembled matrices may occupy before they are scattered.
The amount of memory (in bytes) should scale with CPU cache, roughly a quarter of the second level cache size should be a reasonable value. Note that this is merely a hint, not a hard limit. The actual local matrix storage can be slightly larger.
Definition at line 1574 of file assemblerCore.hh.
|
inline |
Defines how many cells are assembled locally before scattering them together into the global data structures.
Higher numbers reduce the overhead of locking for mutually exclusive write access to global matrix/rhs and improve memory access locality, but increase the amount of thread-local computation and storage. The default value is 42, but the performance appears to be not very sensitive to this parameter in the range [20,60].
Definition at line 1545 of file assemblerCore.hh.
|
inline |
Defines how many more row blocks in each matrix are used compared to the number of threads.
When scattering the local matrices/rhs into the global data structures, blocks of sequential rows are processed in turn. Each block of rows is equipped with a lock in order to guarantee exclusive write access.
A high number of row blocks allows fine granularity and improves cache locality and simultaneous scattering into different parts of the global data structures, but incurs some inefficiency due to more frequent locking and more thread-local processing. The default value is to use two times the number of threads.
Definition at line 1561 of file assemblerCore.hh.
|
inline |
the size of a matrix block (in terms of scalar rows/columns)
Definition at line 2125 of file assemblerCore.hh.
|
inline |
Returns the list of spaces used.
Definition at line 2261 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::get(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::getRhs(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::ncols(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::nrows(), and Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::size().
|
inline |
Writes the subvector defined by the half-open block range [rbegin,rend) to the output iterator xi.
Definition at line 2213 of file assemblerCore.hh.
Referenced by Kaskade::HigherOrderRecovery< Grid, Space >::getErrorFunction(), and Kaskade::Limex< Eq >::step().
|
inline |
Returns a bitfield specifyign which of the parts have been assembled since construction or flush() according to the format (VALUE|RHS|MATRX).
Definition at line 2102 of file assemblerCore.hh.
|
protected |
Definition at line 2380 of file assemblerCore.hh.
|
static |
Definition at line 1531 of file assemblerCore.hh.
|
protected |
|
protected |
Definition at line 2373 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble().
|
protected |
Definition at line 2374 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::getRhs(), and Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::gridView().
|
protected |
Definition at line 2375 of file assemblerCore.hh.
|
staticconstexprprotected |
Definition at line 1477 of file assemblerCore.hh.
|
protected |
Definition at line 2386 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::setLocalStorageSize().
|
static |
Definition at line 1530 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::DerivativeChecker< Functional, checkD1, SparseInt >::checkSecondDerivative(), Kaskade::DerivativeChecker< Functional, checkD1, SparseInt >::d2ToVTK(), Kaskade::Bridge::KaskadeLinearization< Functional >::flush(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::flush(), Kaskade::Bridge::KaskadeLinearization< Functional >::getMatrixBlocks(), Kaskade::Bridge::KaskadeLinearization< Functional >::getValidAssembler(), and Kaskade::Bridge::KaskadeLinearization< Functional >::precompute().
|
mutableprotected |
|
protected |
Definition at line 2384 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::setNSimultaneousBlocks().
|
protected |
Definition at line 2370 of file assemblerCore.hh.
|
static |
Definition at line 1529 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::DerivativeChecker< Functional, checkD1, SparseInt >::checkFirstDerivative(), Kaskade::DerivativeChecker< Functional, checkD1, SparseInt >::checkSecondDerivative(), Kaskade::Bridge::KaskadeLinearization< Functional >::flush(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::flush(), Kaskade::Bridge::KaskadeLinearization< Functional >::getMatrixBlocks(), Kaskade::Bridge::KaskadeLinearization< Functional >::getRHSBlocks(), Kaskade::Bridge::KaskadeLinearization< Functional >::getValidAssembler(), and Kaskade::Bridge::KaskadeLinearization< Functional >::precompute().
|
mutableprotected |
|
mutableprotected |
|
protected |
|
protected |
Definition at line 2372 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::spaces().
|
protected |
Definition at line 2381 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::flush(), and Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::valid().
|
static |
DEPRECATED, enums in the Assembler namespace.
Definition at line 1528 of file assemblerCore.hh.
Referenced by Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::assemble(), Kaskade::DerivativeChecker< Functional, checkD1, SparseInt >::checkFirstDerivative(), Kaskade::Bridge::KaskadeLinearization< Functional >::eval(), Kaskade::Bridge::KaskadeLinearization< Functional >::evalL1norm(), Kaskade::Bridge::KaskadeLinearization< Functional >::flush(), Kaskade::VariationalFunctionalAssembler< F, SparseIndex, BoundaryDetector, QuadRule >::flush(), Kaskade::Bridge::KaskadeLinearization< Functional >::getMatrixBlocks(), Kaskade::Bridge::KaskadeLinearization< Functional >::getRHSBlocks(), Kaskade::Bridge::KaskadeLinearization< Functional >::getValidAssembler(), and Kaskade::Bridge::KaskadeLinearization< Functional >::precompute().