hp2D::hpAdaptiveSpaceH1 Class Referenceabstract

#include <hpAdaptiveSpaceH1.hh>

Inheritance diagram for hp2D::hpAdaptiveSpaceH1:
hp2D::hpAdaptiveSpace< Real > concepts::SpaceOnCoarseCells< 2, Real > concepts::AdaptiveSpace< Real, concepts::AdaptiveAdjustP< 2 > > concepts::Subspace concepts::SpaceOnCells< Real > concepts::Space< Real >

Public Types

typedef concepts::Scan< hp2D::Element< Real > > Scan
 
typedef Scan< ElementWithCell< Real > > Scanner
 
typedef Real t_type
 
typedef ElementWithCell< Real > type
 

Public Member Functions

virtual void adjust (const concepts::Element< Real > &elm, const concepts::AdaptiveAdjustP< 2 > &a)
 Adjusts the space in the next rebuild step for this element. More...
 
virtual void adjust (const Element< Real > &elm, const concepts::AdaptiveAdjustP< 2 > &a)=0
 Adjusts the space in the next rebuild step for this element. More...
 
const std::set< concepts::Cell2 * > allCells () const
 
std::pair< bool, uint > available () const
 Returns 0 if the space has to be rebuilt with rebuild(), otherwise the number of the build. More...
 
uint dim ()
 
virtual uint dim () const
 Returns the dimension of the space. More...
 
virtual uint getOutputDimension () const
 Returns the default output dimension, when we consider plotting a real-valued operator on this space. More...
 
concepts::SubspaceHelper< Real, SpacePreBuilder > & helper ()
 
const concepts::SubspaceHelper< Real, SpacePreBuilder > & helper () const
 
 hpAdaptiveSpaceH1 (concepts::Mesh2 &msh, const concepts::InOutParameters input)
 Constructor with boundary conditions and refinement strategy from input parameters. More...
 
 hpAdaptiveSpaceH1 (concepts::Mesh2 &msh, uint l, uint p, concepts::BoundaryConditions *bc=0, concepts::CellConditions *cc=0)
 Constructor. More...
 
 hpAdaptiveSpaceH1 (const hpAdaptiveSpaceH1 &spc)
 Copy constructor. More...
 
 hpAdaptiveSpaceH1 (hpFull &prebuild, concepts::BoundaryConditions *bc=0, concepts::CellConditions *cc=0, uint spcNo=0, uint *offset=0, uint *idx=0)
 Constructor for using same mesh and distribution of degrees of freedom object as another space. More...
 
virtual uint & lastIdx ()
 Returns last global index of the space. More...
 
virtual const uint & lastIdx () const
 
uint nelm ()
 
virtual uint nelm () const
 Returns the number of elements in the space. More...
 
virtual uint offset () const
 Returns the offset. More...
 
virtual uint offset () const =0
 Returns the offset. More...
 
hpFullprebuild ()
 
hpFullprebuild () const
 
void rebuild (bool sameIndices=false)
 Rebuilds the mesh and the elements due to adjustment orders. More...
 
Scanscan ()
 
virtual Scanscan () const
 Returns a scanner to iterate over the elements of the space. More...
 
void set_bc (const concepts::BoundaryConditions *bc)
 Reset boundary conditions to bc
More...
 
virtual ~hpAdaptiveSpaceH1 ()
 

Protected Attributes

uint idxEdge_
 
uint idxInner_
 
uint idxVtx_
 Number of indices on entities, just for statistics. More...
 
uint nelm_
 Number of elements currently active in the mesh. More...
 
uint offset_
 Initially given offset, holden for control, if in there are changes in the previous subspace. More...
 
hpFull *const prebuild_
 Mesh and degrees of freedoms. More...
 
concepts::SubspaceHelper< Real, SpacePreBuilderspc_
 Helper class for building elements with space pre builder, boundary conditions and index. More...
 
bool zeroDim_
 Control, if dimension at last build is zero. More...
 

Strategies to Build the Degrees of Freedom

bool ownPrebuild_
 If prebuild object is created here and not given. More...
 
uint dofBuild_
 Number of the build of prebuild_ at last call of rebuild() More...
 
uint build_
 Number of the build. More...
 
concepts::Joiner< Element< Real > *, 1 > * elm_
 Linked list of the elements. More...
 
std::unique_ptr< const BuildTColumnsBase< Real > > buildVertexDofs_
 Strategy to build the vertex degrees of freedom. More...
 
std::unique_ptr< const BuildTColumnsBase< Real > > buildEdgeDofs_
 Strategy to build the edge degrees of freedom. More...
 
std::unique_ptr< const BuildTColumnsBase< Real > > buildInnerDofs_
 Strategy to build the inner degrees of freedom. More...
 
bool notAvailable_
 Flag indicating some reasons the space is not available. More...
 
void setBuildVertexDofs_ (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the vertices are built. More...
 
void setBuildEdgeDofs_ (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the edge are built. More...
 
void setBuildInnerDofs_ (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the interior are built. More...
 
void buildElements_ (concepts::Cell2 &cell, ushort *Pmax, concepts::TColumn< Real > *T0=0)
 If prebuild object is created here and not given. More...
 
void setVtxPassive_ (G &cntr, bool forChildren=false, bool always=false)
 Set vertices passive. More...
 
void setEdgePassive_ (const concepts::Connector1 &cntr)
 Set this edge and all children edges passive. More...
 

Strategies to Build the Degrees of Freedom

std::unique_ptr< concepts::SMatrix1DS1left_
 S matrices in 1D. More...
 
std::unique_ptr< concepts::SMatrix1DS1right_
 S matrices in 1D. More...
 
std::unique_ptr< concepts::SMatrixBase< Real > > Smatrices2H_ [2]
 S matrices for horizontal subdivision. More...
 
std::unique_ptr< concepts::SMatrixBase< Real > > Smatrices2V_ [2]
 S matrices for vertical subdivision. More...
 
std::unique_ptr< concepts::SMatrixBase< Real > > Smatrices4_ [4]
 S matrices for subdivision into 4 quads. More...
 
void buildVertexDofs (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the vertices are built. More...
 
void buildEdgeDofs (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the edge are built. More...
 
void buildInnerDofs (const BuildTColumnsBase< Real > *b)
 Change the strategy how the degrees of freedom for the interior are built. More...
 
virtual void recomputeShapefunctions ()
 Recompute shape functions, e.g. More...
 
virtual std::ostream & info (std::ostream &os) const
 S matrices in 1D. More...
 
virtual Element< Real > * newElement_ (concepts::Cell2 &cell, ushort *pMax, concepts::TColumn< Real > *T0, concepts::TColumn< Real > *T1) const
 Creates and returns an element for cell. More...
 
virtual concepts::TColumn< Real > * applySmatrices_ (const concepts::Element< Real > &elm, uint i, const concepts::TColumn< Real > *T0, const concepts::TColumn< Real > *T1)
 Apply i -th S matrix to T-Columns T0 and T1 of the element elm, where i is the number of child of elm. More...
 
void recomputeSmatrices_ (const Quad< Real > &elm)
 Checks if the S matrices need to be recomputed and does so if necessary. More...
 

Detailed Description

Member Typedef Documentation

◆ Scan

◆ Scanner

typedef Scan<ElementWithCell<Real > > concepts::SpaceOnCells< Real >::Scanner
inherited

Definition at line 84 of file space.hh.

◆ t_type

typedef Real hp2D::hpAdaptiveSpace< Real >::t_type
inherited

Definition at line 39 of file hpAdaptiveSpace.hh.

◆ type

typedef ElementWithCell<Real > concepts::SpaceOnCells< Real >::type
inherited

Definition at line 83 of file space.hh.

Constructor & Destructor Documentation

◆ hpAdaptiveSpaceH1() [1/4]

hp2D::hpAdaptiveSpaceH1::hpAdaptiveSpaceH1 ( concepts::Mesh2 msh,
uint  l,
uint  p,
concepts::BoundaryConditions bc = 0,
concepts::CellConditions cc = 0 
)

Constructor.

Scans the mesh and sets the cells in the mesh active and the level of refinement and the polynomial degree in all cells to the given values. rebuild_ is set to true, ie. if the mesh is used it will firstly be rebuilt.

Parameters
mshThe domain of interest partitioned into a mesh.
lLevel of refinement
pDegree of the polynomials to be used.
bcBoundary conditions
ccCell conditions

REMARK: If and only if the flag emptyElements of the cell conditions cc is set to false, empty elements will not be built for inactive cells.

◆ hpAdaptiveSpaceH1() [2/4]

hp2D::hpAdaptiveSpaceH1::hpAdaptiveSpaceH1 ( concepts::Mesh2 msh,
const concepts::InOutParameters  input 
)

Constructor with boundary conditions and refinement strategy from input parameters.

See also
hpAdaptiveSpaceH1FromInput

◆ hpAdaptiveSpaceH1() [3/4]

hp2D::hpAdaptiveSpaceH1::hpAdaptiveSpaceH1 ( hpFull prebuild,
concepts::BoundaryConditions bc = 0,
concepts::CellConditions cc = 0,
uint  spcNo = 0,
uint *  offset = 0,
uint *  idx = 0 
)

Constructor for using same mesh and distribution of degrees of freedom object as another space.

The global indices are sorted by the topological entities, on which the degrees of freedoms lie. Spaces could have no common entities, e.g. first space has Dirichlet boundary and this has only dof on the boundary. If they have common entities, like in mixed problems, the global indices per topological entity can be uniquely given by spcNo.

Parameters
prebuildspace pre builder
bcBoundary conditions
ccCell conditions
spcNoNumber for distinguish between global indices on same topological entity.
offsetLast index of previous space.
idxpointer to index, when wanting a common index

REMARK: If and only if the flag emptyElements of the cell conditions cc is set to false, empty elements will not be built for inactive cells.

◆ hpAdaptiveSpaceH1() [4/4]

hp2D::hpAdaptiveSpaceH1::hpAdaptiveSpaceH1 ( const hpAdaptiveSpaceH1 spc)

Copy constructor.

Copies mesh, boundary conditions and ctrl2_ (information about refinements and polynomial degrees of the elements).

◆ ~hpAdaptiveSpaceH1()

virtual hp2D::hpAdaptiveSpaceH1::~hpAdaptiveSpaceH1 ( )
virtual

Member Function Documentation

◆ adjust() [1/2]

virtual void hp2D::hpAdaptiveSpace< Real >::adjust ( const concepts::Element< Real > &  elm,
const concepts::AdaptiveAdjustP< 2 > &  a 
)
virtualinherited

Adjusts the space in the next rebuild step for this element.

◆ adjust() [2/2]

virtual void concepts::AdaptiveSpace< Real , concepts::AdaptiveAdjustP< 2 > >::adjust ( const Element< Real > &  elm,
const concepts::AdaptiveAdjustP< 2 > &  a 
)
pure virtualinherited

Adjusts the space in the next rebuild step for this element.

◆ allCells()

const std::set<concepts::Cell2* > hp2D::hpAdaptiveSpace< Real >::allCells
inlinevirtualinherited

Implements concepts::SpaceOnCoarseCells< 2, Real >.

Definition at line 126 of file hpAdaptiveSpace.hh.

◆ applySmatrices_()

virtual concepts::TColumn<Real>* hp2D::hpAdaptiveSpaceH1::applySmatrices_ ( const concepts::Element< Real > &  elm,
uint  i,
const concepts::TColumn< Real > *  T0,
const concepts::TColumn< Real > *  T1 
)
protectedvirtual

Apply i -th S matrix to T-Columns T0 and T1 of the element elm, where i is the number of child of elm.

Returns resulting T-Columns.

Implements hp2D::hpAdaptiveSpace< Real >.

◆ available()

std::pair<bool, uint> hp2D::hpAdaptiveSpace< Real >::available
inherited

Returns 0 if the space has to be rebuilt with rebuild(), otherwise the number of the build.

This number helps in the decision of availability.

◆ buildEdgeDofs()

void hp2D::hpAdaptiveSpaceH1::buildEdgeDofs ( const BuildTColumnsBase< Real > *  b)
inline

Change the strategy how the degrees of freedom for the edge are built.

The default strategy is BuildH1EdgeTColumns. You can change this strategy any time you chose.

buildEdgeDofs_ is reset with a clone of b.

Parameters
bNew strategy

Definition at line 145 of file hpAdaptiveSpaceH1.hh.

◆ buildElements_()

void hp2D::hpAdaptiveSpace< Real >::buildElements_ ( concepts::Cell2 cell,
ushort *  Pmax,
concepts::TColumn< Real > *  T0 = 0 
)
privateinherited

If prebuild object is created here and not given.

◆ buildInnerDofs()

void hp2D::hpAdaptiveSpaceH1::buildInnerDofs ( const BuildTColumnsBase< Real > *  b)
inline

Change the strategy how the degrees of freedom for the interior are built.

The default strategy is BuildH1InnerTColumns. You can change this strategy any time you chose.

buildInnerDofs_ is reset with a clone of b.

Parameters
bNew strategy

Definition at line 156 of file hpAdaptiveSpaceH1.hh.

◆ buildVertexDofs()

void hp2D::hpAdaptiveSpaceH1::buildVertexDofs ( const BuildTColumnsBase< Real > *  b)
inline

Change the strategy how the degrees of freedom for the vertices are built.

The default strategy is BuildH1VtxTColumns. You can change this strategy any time you chose.

buildVertexDofs_ is reset with a clone of b.

Parameters
bNew strategy

Definition at line 135 of file hpAdaptiveSpaceH1.hh.

◆ dim() [1/2]

uint hp2D::hpAdaptiveSpace< Real >::dim
inlinevirtualinherited

Implements concepts::SpaceOnCells< Real >.

Definition at line 100 of file hpAdaptiveSpace.hh.

◆ dim() [2/2]

uint hp2D::hpAdaptiveSpace< Real >::dim
inlinevirtualinherited

Returns the dimension of the space.

Implements concepts::SpaceOnCells< Real >.

Examples
exactDtN.cc, and inhomDirichletBCsLagrange.cc.

Definition at line 96 of file hpAdaptiveSpace.hh.

◆ getOutputDimension()

virtual uint concepts::Space< Real >::getOutputDimension ( ) const
inlinevirtualinherited

Returns the default output dimension, when we consider plotting a real-valued operator on this space.

Definition at line 50 of file space.hh.

◆ helper() [1/2]

concepts::SubspaceHelper<Real , SpacePreBuilder>& hp2D::hpAdaptiveSpace< Real >::helper
inlineinherited

Definition at line 91 of file hpAdaptiveSpace.hh.

◆ helper() [2/2]

const concepts::SubspaceHelper<Real , SpacePreBuilder>& hp2D::hpAdaptiveSpace< Real >::helper
inlineinherited

Definition at line 89 of file hpAdaptiveSpace.hh.

◆ info()

virtual std::ostream& hp2D::hpAdaptiveSpaceH1::info ( std::ostream &  os) const
protectedvirtual

S matrices in 1D.

Reimplemented from hp2D::hpAdaptiveSpace< Real >.

◆ lastIdx() [1/2]

virtual uint& hp2D::hpAdaptiveSpace< Real >::lastIdx
inlinevirtualinherited

Returns last global index of the space.

Implements concepts::Subspace.

Definition at line 92 of file hpAdaptiveSpace.hh.

◆ lastIdx() [2/2]

virtual const uint& hp2D::hpAdaptiveSpace< Real >::lastIdx ( ) const
inlinevirtualinherited

Implements concepts::Subspace.

Definition at line 93 of file hpAdaptiveSpace.hh.

◆ nelm() [1/2]

uint hp2D::hpAdaptiveSpace< Real >::nelm
inlinevirtualinherited

Implements concepts::SpaceOnCells< Real >.

Definition at line 101 of file hpAdaptiveSpace.hh.

◆ nelm() [2/2]

uint hp2D::hpAdaptiveSpace< Real >::nelm
inlinevirtualinherited

Returns the number of elements in the space.

Implements concepts::SpaceOnCells< Real >.

Definition at line 97 of file hpAdaptiveSpace.hh.

◆ newElement_()

virtual Element<Real>* hp2D::hpAdaptiveSpaceH1::newElement_ ( concepts::Cell2 cell,
ushort *  pMax,
concepts::TColumn< Real > *  T0,
concepts::TColumn< Real > *  T1 
) const
protectedvirtual

Creates and returns an element for cell.

Implements hp2D::hpAdaptiveSpace< Real >.

◆ offset() [1/2]

virtual uint hp2D::hpAdaptiveSpace< Real >::offset
inlinevirtualinherited

Returns the offset.

Definition at line 94 of file hpAdaptiveSpace.hh.

◆ offset() [2/2]

virtual uint concepts::Subspace::offset ( ) const
pure virtualinherited

Returns the offset.

Implemented in concepts::DomainDecomp< F >, and hp2D::hpAdaptiveSpace< F >.

◆ prebuild() [1/2]

hpFull& hp2D::hpAdaptiveSpace< Real >::prebuild
inlineinherited

Definition at line 86 of file hpAdaptiveSpace.hh.

◆ prebuild() [2/2]

hpFull& hp2D::hpAdaptiveSpace< Real >::prebuild
inlineinherited

Definition at line 87 of file hpAdaptiveSpace.hh.

◆ rebuild()

void hp2D::hpAdaptiveSpace< Real >::rebuild ( bool  sameIndices = false)
inherited

Rebuilds the mesh and the elements due to adjustment orders.

Parameters
sameIndicesIf true, the already existing indices (stored in the space pre builder) won't be cleared. That is useful for domain decomposition for example.
Examples
cig_load_input_data.cc, exactDtN.cc, howToGetStarted.cc, inhomDirichletBCs.cc, inhomDirichletBCsLagrange.cc, inhomNeumannBCs.cc, parallelizationTutorial.cc, and RobinBCs.cc.

◆ recomputeShapefunctions()

virtual void hp2D::hpAdaptiveSpaceH1::recomputeShapefunctions ( )
virtual

Recompute shape functions, e.g.

for other abscissas redefined through setIntegrationRule

Implements hp2D::hpAdaptiveSpace< Real >.

Examples
exactDtN.cc, howToGetStarted.cc, inhomDirichletBCs.cc, inhomDirichletBCsLagrange.cc, inhomNeumannBCs.cc, parallelizationTutorial.cc, and RobinBCs.cc.

◆ recomputeSmatrices_()

void hp2D::hpAdaptiveSpaceH1::recomputeSmatrices_ ( const Quad< Real > &  elm)
private

Checks if the S matrices need to be recomputed and does so if necessary.

Parameters
elmCell for which the S matrices are needed (the polynomial degrees and shape functions are important)

◆ scan() [1/2]

hpAdaptiveSpace< Real >::Scan * hp2D::hpAdaptiveSpace< Real >::scan
inlinevirtualinherited

Implements concepts::SpaceOnCells< Real >.

Definition at line 102 of file hpAdaptiveSpace.hh.

◆ scan() [2/2]

hpAdaptiveSpace< Real >::Scan * hp2D::hpAdaptiveSpace< Real >::scan
inlinevirtualinherited

Returns a scanner to iterate over the elements of the space.

Implements concepts::SpaceOnCells< Real >.

Definition at line 98 of file hpAdaptiveSpace.hh.

◆ set_bc()

void hp2D::hpAdaptiveSpace< Real >::set_bc ( const concepts::BoundaryConditions bc)
inlineinherited

Reset boundary conditions to bc

Definition at line 122 of file hpAdaptiveSpace.hh.

◆ setBuildEdgeDofs_()

void hp2D::hpAdaptiveSpace< Real >::setBuildEdgeDofs_ ( const BuildTColumnsBase< Real > *  b)
protectedinherited

Change the strategy how the degrees of freedom for the edge are built.

The default strategy is BuildEdgeDofs. You can change this strategy any time you chose.

buildEdgeDofs_ is reset with a clone of b.

Parameters
bNew strategy

◆ setBuildInnerDofs_()

void hp2D::hpAdaptiveSpace< Real >::setBuildInnerDofs_ ( const BuildTColumnsBase< Real > *  b)
protectedinherited

Change the strategy how the degrees of freedom for the interior are built.

The default strategy is BuildInnerDofsLinTrunk. You can change this strategy any time you chose.

buildInnerDofs_ is reset with a clone of b.

Parameters
bNew strategy

◆ setBuildVertexDofs_()

void hp2D::hpAdaptiveSpace< Real >::setBuildVertexDofs_ ( const BuildTColumnsBase< Real > *  b)
protectedinherited

Change the strategy how the degrees of freedom for the vertices are built.

The default strategy is BuildVertexDofs. You can change this strategy any time you chose.

buildVertexDofs_ is reset with a clone of b.

Parameters
bNew strategy

◆ setEdgePassive_()

void hp2D::hpAdaptiveSpace< Real >::setEdgePassive_ ( const concepts::Connector1 cntr)
privateinherited

Set this edge and all children edges passive.

◆ setVtxPassive_()

void hp2D::hpAdaptiveSpace< Real >::setVtxPassive_ ( G &  cntr,
bool  forChildren = false,
bool  always = false 
)
privateinherited

Set vertices passive.

  • For dirichlet vertices of a cell. (always = false, forChildren = false)
  • For vertices of a dirichlet edge, also inside edge. (always = false, forChildren = true)
  • All vertices of cells. (always = true, forChildren = false)

Member Data Documentation

◆ build_

uint hp2D::hpAdaptiveSpace< Real >::build_
privateinherited

Number of the build.

Definition at line 212 of file hpAdaptiveSpace.hh.

◆ buildEdgeDofs_

std::unique_ptr<const BuildTColumnsBase<Real > > hp2D::hpAdaptiveSpace< Real >::buildEdgeDofs_
privateinherited

Strategy to build the edge degrees of freedom.

Can be changed with buildEdgeDofs.

Definition at line 222 of file hpAdaptiveSpace.hh.

◆ buildInnerDofs_

std::unique_ptr<const BuildTColumnsBase<Real > > hp2D::hpAdaptiveSpace< Real >::buildInnerDofs_
privateinherited

Strategy to build the inner degrees of freedom.

Can be changed with buildInnerDofs.

Definition at line 226 of file hpAdaptiveSpace.hh.

◆ buildVertexDofs_

std::unique_ptr<const BuildTColumnsBase<Real > > hp2D::hpAdaptiveSpace< Real >::buildVertexDofs_
privateinherited

Strategy to build the vertex degrees of freedom.

Can be changed with buildVertexDofs.

Definition at line 218 of file hpAdaptiveSpace.hh.

◆ dofBuild_

uint hp2D::hpAdaptiveSpace< Real >::dofBuild_
privateinherited

Number of the build of prebuild_ at last call of rebuild()

Definition at line 210 of file hpAdaptiveSpace.hh.

◆ elm_

concepts::Joiner<Element<Real >*, 1>* hp2D::hpAdaptiveSpace< Real >::elm_
privateinherited

Linked list of the elements.

Definition at line 214 of file hpAdaptiveSpace.hh.

◆ idxEdge_

uint hp2D::hpAdaptiveSpace< Real >::idxEdge_
protectedinherited

Definition at line 158 of file hpAdaptiveSpace.hh.

◆ idxInner_

uint hp2D::hpAdaptiveSpace< Real >::idxInner_
protectedinherited

Definition at line 158 of file hpAdaptiveSpace.hh.

◆ idxVtx_

uint hp2D::hpAdaptiveSpace< Real >::idxVtx_
protectedinherited

Number of indices on entities, just for statistics.

Definition at line 158 of file hpAdaptiveSpace.hh.

◆ nelm_

uint hp2D::hpAdaptiveSpace< Real >::nelm_
protectedinherited

Number of elements currently active in the mesh.

Definition at line 145 of file hpAdaptiveSpace.hh.

◆ notAvailable_

bool hp2D::hpAdaptiveSpace< Real >::notAvailable_
privateinherited

Flag indicating some reasons the space is not available.

Definition at line 228 of file hpAdaptiveSpace.hh.

◆ offset_

uint hp2D::hpAdaptiveSpace< Real >::offset_
protectedinherited

Initially given offset, holden for control, if in there are changes in the previous subspace.

Definition at line 150 of file hpAdaptiveSpace.hh.

◆ ownPrebuild_

bool hp2D::hpAdaptiveSpace< Real >::ownPrebuild_
privateinherited

If prebuild object is created here and not given.

Definition at line 208 of file hpAdaptiveSpace.hh.

◆ prebuild_

hpFull* const hp2D::hpAdaptiveSpace< Real >::prebuild_
protectedinherited

Mesh and degrees of freedoms.

Definition at line 137 of file hpAdaptiveSpace.hh.

◆ S1left_

std::unique_ptr<concepts::SMatrix1D> hp2D::hpAdaptiveSpaceH1::S1left_
private

S matrices in 1D.

Definition at line 192 of file hpAdaptiveSpaceH1.hh.

◆ S1right_

std::unique_ptr<concepts::SMatrix1D> hp2D::hpAdaptiveSpaceH1::S1right_
private

S matrices in 1D.

Definition at line 192 of file hpAdaptiveSpaceH1.hh.

◆ Smatrices2H_

std::unique_ptr<concepts::SMatrixBase<Real> > hp2D::hpAdaptiveSpaceH1::Smatrices2H_[2]
private

S matrices for horizontal subdivision.

See also
concepts::Quad2dSubdiv2H

Definition at line 197 of file hpAdaptiveSpaceH1.hh.

◆ Smatrices2V_

std::unique_ptr<concepts::SMatrixBase<Real> > hp2D::hpAdaptiveSpaceH1::Smatrices2V_[2]
private

S matrices for vertical subdivision.

See also
concepts::Quad2dSubdiv2V

Definition at line 202 of file hpAdaptiveSpaceH1.hh.

◆ Smatrices4_

std::unique_ptr<concepts::SMatrixBase<Real> > hp2D::hpAdaptiveSpaceH1::Smatrices4_[4]
private

S matrices for subdivision into 4 quads.

See also
concepts::Quad2dSubdiv4

Definition at line 207 of file hpAdaptiveSpaceH1.hh.

◆ spc_

concepts::SubspaceHelper<Real , SpacePreBuilder> hp2D::hpAdaptiveSpace< Real >::spc_
protectedinherited

Helper class for building elements with space pre builder, boundary conditions and index.

Definition at line 142 of file hpAdaptiveSpace.hh.

◆ zeroDim_

bool hp2D::hpAdaptiveSpace< Real >::zeroDim_
protectedinherited

Control, if dimension at last build is zero.

That is needed to distinguish from not built state, if the index counter is reset.

Definition at line 155 of file hpAdaptiveSpace.hh.


The documentation for this class was generated from the following file:
Page URL: http://wiki.math.ethz.ch/bin/view/Concepts/WebHome
21 August 2020
© 2020 Eidgenössische Technische Hochschule Zürich