Intrepid2
|
Public Types | |
using | BasisBase = typename HGRAD_LINE::BasisBase |
using | ExecutionSpace = typename HGRAD_LINE::ExecutionSpace |
using | OutputValueType = typename HGRAD_LINE::OutputValueType |
using | PointValueType = typename HGRAD_LINE::PointValueType |
![]() | |
using | BasisBase |
using | BasisPtr |
using | DeviceType |
using | ExecutionSpace |
using | OutputValueType |
using | PointValueType |
using | OrdinalTypeArray1DHost |
using | OrdinalTypeArray2DHost |
using | OutputViewType |
using | PointViewType |
using | ScalarViewType |
Public Member Functions | |
Basis_Derived_HCURL_WEDGE (int polyOrder_xy, int polyOrder_z, const EPointType pointType=POINTTYPE_DEFAULT) | |
Constructor. | |
Basis_Derived_HCURL_WEDGE (int polyOrder, const EPointType pointType=POINTTYPE_DEFAULT) | |
Constructor. | |
virtual bool | requireOrientation () const override |
True if orientation is required. | |
virtual const char * | getName () const override |
Returns basis name. | |
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. | |
![]() | |
Basis_DirectSumBasis (BasisPtr basis1, BasisPtr basis2) | |
Constructor. | |
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. | |
virtual void | getDofCoords (ScalarViewType dofCoords) const override |
Fills in spatial locations (coordinates) of degrees of freedom (nodes) on the reference cell. | |
virtual void | getDofCoeffs (ScalarViewType dofCoeffs) const override |
Fills in coefficients of degrees of freedom for Lagrangian basis on the reference cell. | |
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. | |
virtual void | getValues (OutputViewType outputValues, const PointViewType inputPoints, const EOperator operatorType=OPERATOR_VALUE) const override |
Evaluation of a FEM basis on a reference cell. | |
virtual int | getNumTensorialExtrusions () const override |
Protected Attributes | |
std::string | name_ |
ordinal_type | order_xy_ |
ordinal_type | order_z_ |
EPointType | pointType_ |
![]() | |
BasisPtr | basis1_ |
BasisPtr | basis2_ |
std::string | name_ |
Private Types | |
using | Family1 = Basis_Derived_HCURL_Family1_WEDGE<HCURL_TRI, HGRAD_LINE> |
using | Family2 = Basis_Derived_HCURL_Family2_WEDGE<HGRAD_TRI, HVOL_LINE> |
using | DirectSumBasis = Basis_DirectSumBasis <typename HGRAD_LINE::BasisBase> |
Definition at line 387 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
using Intrepid2::Basis_Derived_HCURL_WEDGE< HGRAD_TRI, HCURL_TRI, HGRAD_LINE, HVOL_LINE >::BasisBase = typename HGRAD_LINE::BasisBase |
Definition at line 394 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
private |
Definition at line 392 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
using Intrepid2::Basis_Derived_HCURL_WEDGE< HGRAD_TRI, HCURL_TRI, HGRAD_LINE, HVOL_LINE >::ExecutionSpace = typename HGRAD_LINE::ExecutionSpace |
Definition at line 403 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
private |
Definition at line 390 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
private |
Definition at line 391 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
using Intrepid2::Basis_Derived_HCURL_WEDGE< HGRAD_TRI, HCURL_TRI, HGRAD_LINE, HVOL_LINE >::OutputValueType = typename HGRAD_LINE::OutputValueType |
Definition at line 404 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
using Intrepid2::Basis_Derived_HCURL_WEDGE< HGRAD_TRI, HCURL_TRI, HGRAD_LINE, HVOL_LINE >::PointValueType = typename HGRAD_LINE::PointValueType |
Definition at line 405 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
inline |
Constructor.
[in] | polyOrder_xy | - the polynomial order in the x and y dimensions. |
[in] | polyOrder_z | - the polynomial order in the z dimension. |
[in] | pointType | - type of lattice used for creating the DoF coordinates. |
Definition at line 412 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
References Intrepid2::Basis_DirectSumBasis< BasisBaseClass >::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 432 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
inlineoverridevirtual |
Creates and returns a Basis object whose DeviceType template argument is Kokkos::HostSpace::device_type, but is otherwise identical to this.
Definition at line 456 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
inlineoverridevirtual |
Returns basis name.
Reimplemented from Intrepid2::Basis_DirectSumBasis< HGRAD_LINE::BasisBase >.
Definition at line 447 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
inlineoverridevirtual |
True if orientation is required.
Definition at line 436 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
protected |
Definition at line 397 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
protected |
Definition at line 398 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
protected |
Definition at line 399 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.
|
protected |
Definition at line 400 of file Intrepid2_DerivedBasis_HCURL_WEDGE.hpp.