| 
    Intrepid2
    
   | 
 
Implementation of the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell. More...
#include <Intrepid2_HGRAD_TET_COMP12_FEM.hpp>
  
 Public Types | |
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::ordinal_type_array_1d_host  | ordinal_type_array_1d_host | 
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::ordinal_type_array_2d_host  | ordinal_type_array_2d_host | 
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::ordinal_type_array_3d_host  | ordinal_type_array_3d_host | 
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::outputViewType  | outputViewType | 
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::pointViewType  | pointViewType | 
| 
typedef Basis< ExecSpaceType,  outputValueType, pointValueType > ::scalarViewType  | scalarViewType | 
  Public Types inherited from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType > | |
| 
typedef Kokkos::View < ordinal_type, ExecSpaceType >  | ordinal_view_type | 
| View type for ordinal.  | |
| 
typedef Kokkos::View< EBasis,  ExecSpaceType >  | ebasis_view_type | 
| View for basis type.  | |
| 
typedef Kokkos::View < ECoordinates, ExecSpaceType >  | ecoordinates_view_type | 
| View for coordinate system type.  | |
| 
typedef Kokkos::View < ordinal_type *,typename ExecSpaceType::array_layout, Kokkos::HostSpace >  | ordinal_type_array_1d_host | 
| View type for 1d host array.  | |
| 
typedef Kokkos::View < ordinal_type **,typename ExecSpaceType::array_layout, Kokkos::HostSpace >  | ordinal_type_array_2d_host | 
| View type for 2d host array.  | |
| 
typedef Kokkos::View < ordinal_type ***, typename ExecSpaceType::array_layout, Kokkos::HostSpace >  | ordinal_type_array_3d_host | 
| View type for 3d host array.  | |
| 
typedef Kokkos::View < ordinal_type *, Kokkos::LayoutStride, Kokkos::HostSpace >  | ordinal_type_array_stride_1d_host | 
| View type for 1d host array.  | |
| 
typedef Kokkos::View < ordinal_type *,ExecSpaceType >  | ordinal_type_array_1d | 
| View type for 1d device array.  | |
| 
typedef Kokkos::View < ordinal_type **,ExecSpaceType >  | ordinal_type_array_2d | 
| View type for 2d device array.  | |
| 
typedef Kokkos::View < ordinal_type ***, ExecSpaceType >  | ordinal_type_array_3d | 
| View type for 3d device array.  | |
| 
typedef Kokkos::View < ordinal_type *, Kokkos::LayoutStride, ExecSpaceType >  | ordinal_type_array_stride_1d | 
| View type for 1d device array.  | |
| 
typedef ScalarTraits < pointValueType > ::scalar_type  | scalarType | 
| Scalar type for point values.  | |
| 
typedef Kokkos::DynRankView < outputValueType, Kokkos::LayoutStride, ExecSpaceType >  | outputViewType | 
| View type for basis value output.  | |
| 
typedef Kokkos::DynRankView < pointValueType, Kokkos::LayoutStride, ExecSpaceType >  | pointViewType | 
| View type for input points.  | |
| 
typedef Kokkos::DynRankView < scalarType, Kokkos::LayoutStride, ExecSpaceType >  | scalarViewType | 
| View type for scalars.  | |
Public Member Functions | |
| Basis_HGRAD_TET_COMP12_FEM () | |
| Constructor.  | |
| virtual void | getValues (outputViewType outputValues, const pointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const | 
| FEM basis evaluation on a reference Tetrahedron cell.  More... | |
| virtual void | getDofCoords (scalarViewType dofCoords) const | 
| Returns spatial locations (coordinates) of degrees of freedom on a reference Tetrahedron.  More... | |
| virtual const char * | getName () const | 
| Returns basis name.  More... | |
  Public Member Functions inherited from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType > | |
| outputValueType | getDummyOutputValue () | 
| Dummy array to receive input arguments.  | |
| pointValueType | getDummyPointValue () | 
| Dummy array to receive input arguments.  | |
| virtual void | getValues (outputViewType, const pointViewType, const pointViewType, const EOperator=OPERATOR_VALUE) const | 
| Evaluation of an FVD basis evaluation on a physical cell.  More... | |
| virtual void | getDofCoeffs (scalarViewType) const | 
| Coefficients for computing degrees of freedom for Lagrangian basis If P is an element of the space spanned by the basis,  := P(dofCoords(i))  dofCoeffs(i) are the nodal coefficients associated to basis function i.  More... | |
| virtual bool | requireOrientation () const | 
| True if orientation is required.  | |
| ordinal_type | getCardinality () const | 
| Returns cardinality of the basis.  More... | |
| ordinal_type | getDegree () const | 
| Returns the degree of the basis.  More... | |
| shards::CellTopology | getBaseCellTopology () const | 
| Returns the base cell topology for which the basis is defined. See Shards documentation https://trilinos.org/packages/shards for definition of base cell topology.  More... | |
| EBasis | getBasisType () const | 
| Returns the basis type.  More... | |
| ECoordinates | getCoordinateSystem () const | 
| Returns the type of coordinate system for which the basis is defined.  More... | |
| ordinal_type | getDofCount (const ordinal_type subcDim, const ordinal_type subcOrd) const | 
| DoF count for specified subcell.  More... | |
| ordinal_type | getDofOrdinal (const ordinal_type subcDim, const ordinal_type subcOrd, const ordinal_type subcDofOrd) const | 
| DoF tag to ordinal lookup.  More... | |
| const ordinal_type_array_3d_host | getAllDofOrdinal () const | 
| DoF tag to ordinal data structure.  | |
| const  ordinal_type_array_stride_1d_host  | getDofTag (const ordinal_type dofOrd) const | 
| DoF ordinal to DoF tag lookup.  More... | |
| const ordinal_type_array_2d_host | getAllDofTags () const | 
| Retrieves all DoF tags.  More... | |
Additional Inherited Members | |
  Protected Member Functions inherited from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType > | |
| template<typename OrdinalTypeView3D , typename OrdinalTypeView2D , typename OrdinalTypeView1D > | |
| void | setOrdinalTagData (OrdinalTypeView3D &tagToOrdinal, OrdinalTypeView2D &ordinalToTag, const OrdinalTypeView1D tags, const ordinal_type basisCard, const ordinal_type tagSize, const ordinal_type posScDim, const ordinal_type posScOrd, const ordinal_type posDfOrd) | 
| Fills ordinalToTag_ and tagToOrdinal_ by basis-specific tag data.  More... | |
  Protected Attributes inherited from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType > | |
| ordinal_type | basisCardinality_ | 
| Cardinality of the basis, i.e., the number of basis functions/degrees-of-freedom.  | |
| ordinal_type | basisDegree_ | 
| Degree of the largest complete polynomial space that can be represented by the basis.  | |
| shards::CellTopology | basisCellTopology_ | 
| Base topology of the cells for which the basis is defined. See the Shards package for definition of base cell topology.  | |
| EBasis | basisType_ | 
| Type of the basis.  | |
| ECoordinates | basisCoordinates_ | 
| The coordinate system for which the basis is defined.  | |
| ordinal_type_array_2d_host | ordinalToTag_ | 
| "true" if tagToOrdinal_ and ordinalToTag_ have been initialized  More... | |
| ordinal_type_array_3d_host | tagToOrdinal_ | 
| DoF tag to ordinal lookup table.  More... | |
| 
Kokkos::DynRankView < scalarType, ExecSpaceType >  | dofCoords_ | 
| Coordinates of degrees-of-freedom for basis functions defined in physical space.  | |
| Kokkos::DynRankView < scalarType, ExecSpaceType >  | dofCoeffs_ | 
| Coefficients for computing degrees of freedom for Lagrangian basis If P is an element of the space spanned by the basis,  := P(dofCoords_(i))  dofCoeffs_(i) are the nodal coefficients associated to basis functions i.  More... | |
Implementation of the default H(grad)-compatible FEM basis of degree 2 on Tetrahedron cell.
Implements Lagrangian basis of degree 2 on the reference Tetrahedron cell. The basis has cardinality 10 and spans a COMPLETE quadratic polynomial space. Basis functions are dual to a unisolvent set of degrees-of-freedom (DoF) defined and enumerated as follows:
================================================================================================= | | degree-of-freedom-tag table | | | DoF |----------------------------------------------------------| DoF definition | | ordinal | subc dim | subc ordinal | subc DoF ord |subc num DoF | | |=========|==============|==============|==============|=============|===========================| | 0 | 0 | 0 | 0 | 1 | L_0(u) = u(0,0,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 1 | 0 | 1 | 0 | 1 | L_1(u) = u(1,0,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 2 | 0 | 2 | 0 | 1 | L_2(u) = u(0,1,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 3 | 0 | 3 | 0 | 1 | L_3(u) = u(0,0,1) | |---------|--------------|--------------|--------------|-------------|---------------------------| |---------|--------------|--------------|--------------|-------------|---------------------------| | 4 | 1 | 0 | 0 | 1 | L_4(u) = u(1/2,0,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 5 | 1 | 1 | 0 | 1 | L_5(u) = u(1/2,1/2,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 6 | 1 | 2 | 0 | 1 | L_6(u) = u(0,1/2,0) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 7 | 1 | 3 | 0 | 1 | L_7(u) = u(0,0,1/2) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 8 | 1 | 4 | 0 | 1 | L_8(u) = u(1/2,0,1/2) | |---------|--------------|--------------|--------------|-------------|---------------------------| | 9 | 1 | 5 | 0 | 1 | L_9(u) = u(0,1/2,1/2) | |=========|==============|==============|==============|=============|===========================| | MAX | maxScDim=0 | maxScOrd=3 | maxDfOrd=0 | - | | |=========|==============|==============|==============|=============|===========================|
Definition at line 187 of file Intrepid2_HGRAD_TET_COMP12_FEM.hpp.
      
  | 
  inlinevirtual | 
Returns spatial locations (coordinates) of degrees of freedom on a reference Tetrahedron.
| DofCoords | [out] - array with the coordinates of degrees of freedom, dimensioned (F,D) | 
Reimplemented from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >.
Definition at line 241 of file Intrepid2_HGRAD_TET_COMP12_FEM.hpp.
References Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >::dofCoords_, Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >::getBaseCellTopology(), and Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >::getCardinality().
      
  | 
  inlinevirtual | 
Returns basis name.
Reimplemented from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >.
Definition at line 258 of file Intrepid2_HGRAD_TET_COMP12_FEM.hpp.
      
  | 
  inlinevirtual | 
FEM basis evaluation on a reference Tetrahedron cell.
Returns values of operatorType acting on FEM basis functions for a set of points in the reference Tetrahedron cell. For rank and dimensions of I/O array arguments see Section MD array template arguments for basis methods .
| outputValues | [out] - rank-2 or 3 array with the computed basis values | 
| inputPoints | [in] - rank-2 array with dimensions (P,D) containing reference points | 
| operatorType | [in] - operator applied to basis functions | 
For rank and dimension specifications of ArrayScalar arguments see basis_array_specs
Reimplemented from Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >.
Definition at line 217 of file Intrepid2_HGRAD_TET_COMP12_FEM.hpp.
References Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >::getBaseCellTopology(), and Intrepid2::Basis< ExecSpaceType, outputValueType, pointValueType >::getCardinality().
 1.8.5