|
Intrepid2
|
Public Types | |
| using | ExecutionSpace = typename HGRAD_LINE::ExecutionSpace |
| using | OutputValueType = typename HGRAD_LINE::OutputValueType |
| using | PointValueType = typename HGRAD_LINE::PointValueType |
| using | OutputViewType = typename HGRAD_LINE::OutputViewType |
| using | PointViewType = typename HGRAD_LINE::PointViewType |
| using | ScalarViewType = typename HGRAD_LINE::ScalarViewType |
| using | LineBasis = HGRAD_LINE |
| using | QuadBasis = Intrepid2::Basis_Derived_HGRAD_QUAD< HGRAD_LINE > |
| using | BasisBase = typename HGRAD_LINE::BasisBase |
| using | TensorBasis = Basis_TensorBasis< BasisBase > |
Public Types inherited from Intrepid2::Basis_TensorBasis< HGRAD_LINE::BasisBase > | |
| using | BasisBase = BasisBaseClass |
| using | BasisPtr = Teuchos::RCP< HGRAD_LINE::BasisBase > |
| using | DeviceType = typename HGRAD_LINE::BasisBase::DeviceType |
| using | ExecutionSpace = typename HGRAD_LINE::BasisBase::ExecutionSpace |
| using | OutputValueType = typename HGRAD_LINE::BasisBase::OutputValueType |
| using | PointValueType = typename HGRAD_LINE::BasisBase::PointValueType |
| using | OrdinalTypeArray1DHost = typename HGRAD_LINE::BasisBase::OrdinalTypeArray1DHost |
| using | OrdinalTypeArray2DHost = typename HGRAD_LINE::BasisBase::OrdinalTypeArray2DHost |
| using | OutputViewType = typename HGRAD_LINE::BasisBase::OutputViewType |
| using | PointViewType = typename HGRAD_LINE::BasisBase::PointViewType |
| using | TensorBasis = Basis_TensorBasis< BasisBaseClass > |
Public Member Functions | |
| Basis_Derived_HGRAD_HEX (int polyOrder_x, int polyOrder_y, int polyOrder_z, const EPointType pointType=POINTTYPE_DEFAULT) | |
| Constructor. More... | |
| Basis_Derived_HGRAD_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... | |
Public Member Functions inherited from Intrepid2::Basis_TensorBasis< HGRAD_LINE::BasisBase > | |
| Basis_TensorBasis (BasisPtr basis1, BasisPtr basis2, EFunctionSpace functionSpace=FUNCTION_SPACE_MAX, const bool useShardsCellTopologyAndTags=false) | |
| Constructor. More... | |
| void | setShardsTopologyAndTags () |
| virtual int | getNumTensorialExtrusions () const override |
| ordinal_type | getTensorDkEnumeration (ordinal_type dkEnum1, ordinal_type operatorOrder1, ordinal_type dkEnum2, ordinal_type operatorOrder2) const |
| Given "Dk" enumeration indices for the component bases, returns a Dk enumeration index for the composite basis. More... | |
| virtual OperatorTensorDecomposition | getSimpleOperatorDecomposition (const EOperator &operatorType) const |
| Returns a simple decomposition of the specified operator: what operator(s) should be applied to basis1, and what operator(s) to basis2. A one-element OperatorTensorDecomposition corresponds to a single TensorData entry; a multiple-element OperatorTensorDecomposition corresponds to a VectorData object with axialComponents = false. More... | |
| virtual OperatorTensorDecomposition | getOperatorDecomposition (const EOperator operatorType) const |
| Returns a full decomposition of the specified operator. (Full meaning that all TensorBasis components are expanded into their non-TensorBasis components.) | |
| 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... | |
| void | getComponentPoints (const PointViewType inputPoints, const bool attemptTensorDecomposition, PointViewType &inputPoints1, PointViewType &inputPoints2, bool &tensorDecompositionSucceeded) const |
| Method to extract component points from composite points. More... | |
| virtual void | getDofCoords (typename HGRAD_LINE::BasisBase::ScalarViewType dofCoords) const override |
| Fills in spatial locations (coordinates) of degrees of freedom (nodes) on the reference cell. More... | |
| virtual void | getDofCoeffs (typename HGRAD_LINE::BasisBase::ScalarViewType dofCoeffs) const override |
| Fills in coefficients of degrees of freedom on the reference cell. More... | |
| std::vector< BasisPtr > | getTensorBasisComponents () const |
| 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... | |
| void | getValues (OutputViewType outputValues, const PointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const override |
| Evaluation of a FEM basis on a reference cell. More... | |
| virtual void | getValues (OutputViewType outputValues, const EOperator operatorType, const PointViewType inputPoints1, const PointViewType inputPoints2, bool tensorPoints) const |
| Evaluation of a tensor FEM basis on a reference cell; subclasses should override this. More... | |
| void | getValues (OutputViewType outputValues, const PointViewType inputPoints1, const EOperator operatorType1, const PointViewType inputPoints2, const EOperator operatorType2, bool tensorPoints, double weight=1.0) const |
| Evaluation of a tensor FEM basis on a reference cell. More... | |
Public Attributes | |
| std::string | name_ |
| ordinal_type | order_x_ |
| ordinal_type | order_y_ |
| ordinal_type | order_z_ |
| EPointType | pointType_ |
Additional Inherited Members | |
Protected Attributes inherited from Intrepid2::Basis_TensorBasis< HGRAD_LINE::BasisBase > | |
| BasisPtr | basis1_ |
| BasisPtr | basis2_ |
| std::vector< BasisPtr > | tensorComponents_ |
| std::string | name_ |
| int | numTensorialExtrusions_ |
Definition at line 34 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
|
inline |
Constructor.
| [in] | polyOrder_x | - the polynomial order in the x dimension. |
| [in] | polyOrder_y | - the polynomial order in the y dimension. |
| [in] | polyOrder_z | - the polynomial order in the z dimension. |
| [in] | pointType | - type of lattice used for creating the DoF coordinates. |
Definition at line 63 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
References Intrepid2::Basis_TensorBasis< BasisBase >::getName().
|
inline |
Constructor.
| [in] | polyOrder | - the polynomial order to use in all dimensions. |
| [in] | pointType | - type of lattice used for creating the DoF coordinates. |
Definition at line 87 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
|
inlineoverridevirtual |
Creates and returns a Basis object whose DeviceType template argument is Kokkos::HostSpace::device_type, but is otherwise identical to this.
Reimplemented from Intrepid2::Basis_TensorBasis< HGRAD_LINE::BasisBase >.
Definition at line 163 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
|
inlineoverridevirtual |
Returns basis name.
Reimplemented from Intrepid2::Basis_TensorBasis< HGRAD_LINE::BasisBase >.
Definition at line 105 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
|
inlineoverride |
returns the basis associated to a subCell.
The bases of the subCell should be the restriction to the subCell of the bases of the parent cell. TODO: test this method when different orders are used in different directions
| [in] | subCellDim | - dimension of subCell |
| [in] | subCellOrd | - position of the subCell among of the subCells having the same dimension |
Definition at line 119 of file Intrepid2_DerivedBasis_HGRAD_HEX.hpp.
1.8.5