|
using | ExecutionSpace = typename HGRAD_LINE::ExecutionSpace |
|
using | OutputValueType = typename HGRAD_LINE::OutputValueType |
|
using | PointValueType = typename HGRAD_LINE::PointValueType |
|
using | BasisBase = typename HGRAD_LINE::BasisBase |
|
using | BasisBase = HGRAD_LINE::BasisBase |
|
using | BasisPtr = Teuchos::RCP< BasisBase > |
|
using | DeviceType = typename BasisBase::DeviceType |
|
using | ExecutionSpace = typename BasisBase::ExecutionSpace |
|
using | OutputValueType = typename BasisBase::OutputValueType |
|
using | PointValueType = typename BasisBase::PointValueType |
|
using | OrdinalTypeArray1DHost = typename BasisBase::OrdinalTypeArray1DHost |
|
using | OrdinalTypeArray2DHost = typename BasisBase::OrdinalTypeArray2DHost |
|
using | OutputViewType = typename BasisBase::OutputViewType |
|
using | PointViewType = typename BasisBase::PointViewType |
|
using | ScalarViewType = typename BasisBase::ScalarViewType |
|
|
| Basis_Derived_HDIV_HEX (int polyOrder_x, int polyOrder_y, int polyOrder_z, const EPointType pointType=POINTTYPE_DEFAULT) |
| Constructor. More...
|
|
| Basis_Derived_HDIV_HEX (int polyOrder, const EPointType pointType=POINTTYPE_DEFAULT) |
| Constructor. More...
|
|
virtual bool | requireOrientation () const override |
| True if orientation is required.
|
|
virtual const char * | getName () const override |
| Returns basis name. More...
|
|
Teuchos::RCP< BasisBase > | getSubCellRefBasis (const ordinal_type subCellDim, const ordinal_type subCellOrd) const override |
| returns the basis associated to a subCell. More...
|
|
virtual HostBasisPtr< OutputValueType, PointValueType > | getHostBasis () const override |
| Creates and returns a Basis object whose DeviceType template argument is Kokkos::HostSpace::device_type, but is otherwise identical to this. More...
|
|
| Basis_DirectSumBasis (BasisPtr basis1, BasisPtr basis2) |
| Constructor. More...
|
|
virtual BasisValues< OutputValueType, DeviceType > | allocateBasisValues (TensorPoints< PointValueType, DeviceType > points, const EOperator operatorType=OPERATOR_VALUE) const override |
| Allocate BasisValues container suitable for passing to the getValues() variant that takes a TensorPoints container as argument. More...
|
|
virtual void | getDofCoords (ScalarViewType dofCoords) const override |
| Fills in spatial locations (coordinates) of degrees of freedom (nodes) on the reference cell. More...
|
|
virtual void | getDofCoeffs (ScalarViewType dofCoeffs) const override |
| Fills in coefficients of degrees of freedom for Lagrangian basis on the reference cell. More...
|
|
virtual void | getValues (BasisValues< OutputValueType, DeviceType > outputValues, const TensorPoints< PointValueType, DeviceType > inputPoints, const EOperator operatorType=OPERATOR_VALUE) const override |
| Evaluation of a FEM basis on a reference cell, using point and output value containers that allow preservation of tensor-product structure. More...
|
|
virtual void | getValues (OutputViewType outputValues, const PointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const override |
| Evaluation of a FEM basis on a reference cell. More...
|
|
template<class HGRAD_LINE, class HVOL_LINE>
class Intrepid2::Basis_Derived_HDIV_HEX< HGRAD_LINE, HVOL_LINE >
Definition at line 507 of file Intrepid2_DerivedBasis_HDIV_HEX.hpp.
template<class HGRAD_LINE , class HVOL_LINE >
Teuchos::RCP<BasisBase> Intrepid2::Basis_Derived_HDIV_HEX< HGRAD_LINE, HVOL_LINE >::getSubCellRefBasis |
( |
const ordinal_type |
subCellDim, |
|
|
const ordinal_type |
subCellOrd |
|
) |
| const |
|
inlineoverride |
returns the basis associated to a subCell.
The bases of the subCell are the restriction to the subCell of the bases of the parent cell, projected along normal to the subCell.
TODO: test this method when different orders are used in different directions
- Parameters
-
[in] | subCellDim | - dimension of subCell |
[in] | subCellOrd | - position of the subCell among of the subCells having the same dimension |
- Returns
- pointer to the subCell basis of dimension subCellDim and position subCellOrd
Definition at line 581 of file Intrepid2_DerivedBasis_HDIV_HEX.hpp.