|
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 | BasisBase = typename HGRAD_LINE::BasisBase |
|
using | LineBasis = HGRAD_LINE |
|
using | TensorBasis = Basis_TensorBasis< 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 | TensorBasis = Basis_TensorBasis< HGRAD_LINE::BasisBase > |
|
|
| Basis_Derived_HGRAD_QUAD (int polyOrder_x, int polyOrder_y, const EPointType pointType=POINTTYPE_DEFAULT) |
| Constructor. More...
|
|
| Basis_Derived_HGRAD_QUAD (int polyOrder, const EPointType pointType=POINTTYPE_DEFAULT) |
| Constructor. More...
|
|
virtual bool | requireOrientation () const override |
| True if orientation is required.
|
|
virtual OperatorTensorDecomposition | getSimpleOperatorDecomposition (const EOperator operatorType) const override |
| 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 vector corresponds to a single TensorData entry; a multiple-element vector corresponds to a VectorData object with axialComponents = false.
|
|
virtual void | getValues (OutputViewType outputValues, const EOperator operatorType, const PointViewType inputPoints1, const PointViewType inputPoints2, bool tensorPoints) const override |
| multi-component getValues() method (required/called by TensorBasis) More...
|
|
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_TensorBasis (BasisPtr basis1, BasisPtr basis2, EFunctionSpace functionSpace=FUNCTION_SPACE_MAX) |
| Constructor. 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 BasisBase::ScalarViewType dofCoords) const override |
| Fills in spatial locations (coordinates) of degrees of freedom (nodes) on the reference cell. More...
|
|
virtual void | getDofCoeffs (typename BasisBase::ScalarViewType dofCoeffs) const override |
| Fills in coefficients of degrees of freedom on the reference cell. More...
|
|
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...
|
|
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...
|
|
template<class HGRAD_LINE>
class Intrepid2::Basis_Derived_HGRAD_QUAD< HGRAD_LINE >
Definition at line 59 of file Intrepid2_DerivedBasis_HGRAD_QUAD.hpp.