Intrepid
Public Member Functions | Private Member Functions | List of all members
Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar > Class Template Reference
Inheritance diagram for Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >:
Intrepid::Basis< Scalar, ArrayScalar > Intrepid::DofCoordsInterface< ArrayScalar >

Public Member Functions

 Basis_HGRAD_TET_COMP12_FEM ()
 Constructor.
 
void getValues (ArrayScalar &outputValues, const ArrayScalar &inputPoints, const EOperator operatorType) const
 FEM basis evaluation on a reference Tetrahedron cell. More...
 
void getValues (ArrayScalar &outputValues, const ArrayScalar &inputPoints, const ArrayScalar &cellVertices, const EOperator operatorType=OPERATOR_VALUE) const
 FVD basis evaluation: invocation of this method throws an exception.
 
void getDofCoords (ArrayScalar &DofCoords) const
 Returns spatial locations (coordinates) of degrees of freedom on a reference Tetrahedron. More...
 
Teuchos::Array< int > getLocalSubTetrahedra (Scalar, Scalar, Scalar) const
 Returns array of local sub-tetrahdera that the given point resides in. More...
 
Intrepid::FieldContainer< Scalar > getWeights (const ArrayScalar &) const
 Returns FieldContainer of local integration weights. More...
 
Intrepid::FieldContainer< Scalar > getSubTetGrads () const
 Returns FieldContainer of local sub-tet gradients. More...
 
Intrepid::FieldContainer< Scalar > getSubTetDetF () const
 Returns FieldContainer of local sub-tet detF. More...
 
Intrepid::FieldContainer< Scalar > getBarycentricCoords (const ArrayScalar &) const
 Returns FieldContainer of Barycentric Coordinates for the input points. More...
 
Scalar det44 (const Intrepid::FieldContainer< Scalar >) const
 Returns FieldContainer of Barycentric Coordinates for the input points. More...
 
Intrepid::FieldContainer< Scalar > inverse44 (const Intrepid::FieldContainer< Scalar >) const
 Returns FieldContainer of Barycentric Coordinates for the input points. More...
 
- Public Member Functions inherited from Intrepid::Basis< Scalar, ArrayScalar >
virtual ~Basis ()
 Destructor.
 
virtual int getCardinality () const
 Returns cardinality of the basis. More...
 
virtual int getDegree () const
 Returns the degree of the basis. More...
 
virtual const shards::CellTopology getBaseCellTopology () const
 Returns the base cell topology for which the basis is defined. See Shards documentation http://trilinos.sandia.gov/packages/shards for definition of base cell topology. More...
 
virtual EBasis getBasisType () const
 Returns the basis type. More...
 
virtual ECoordinates getCoordinateSystem () const
 Returns the type of coordinate system for which the basis is defined. More...
 
virtual int getDofOrdinal (const int subcDim, const int subcOrd, const int subcDofOrd)
 DoF tag to ordinal lookup. More...
 
virtual const std::vector
< std::vector< std::vector
< int > > > & 
getDofOrdinalData ()
 DoF tag to ordinal data structure.
 
virtual const std::vector< int > & getDofTag (const int dofOrd)
 DoF ordinal to DoF tag lookup. More...
 
virtual const std::vector
< std::vector< int > > & 
getAllDofTags ()
 Retrieves all DoF tags. More...
 
- Public Member Functions inherited from Intrepid::DofCoordsInterface< ArrayScalar >
virtual ~DofCoordsInterface ()=0
 Pure virtual destructor (gives warnings if not included). Following "Effective C++: 3rd Ed." item 7 the implementation is included in the definition file.
 

Private Member Functions

void initializeTags ()
 Initializes tagToOrdinal_ and ordinalToTag_ lookup arrays.
 

Additional Inherited Members

- Protected Attributes inherited from Intrepid::Basis< Scalar, ArrayScalar >
int basisCardinality_
 Cardinality of the basis, i.e., the number of basis functions/degrees-of-freedom.
 
int 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 http://trilinos.sandia.gov/packages/shards for definition of base cell topology.
 
EBasis basisType_
 Type of the basis.
 
ECoordinates basisCoordinates_
 The coordinate system for which the basis is defined.
 
bool basisTagsAreSet_
 "true" if tagToOrdinal_ and ordinalToTag_ have been initialized
 
std::vector< std::vector< int > > ordinalToTag_
 DoF ordinal to tag lookup table. More...
 
std::vector< std::vector
< std::vector< int > > > 
tagToOrdinal_
 DoF tag to ordinal lookup table. More...
 

Detailed Description

template<class Scalar, class ArrayScalar>
class Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >

Definition at line 99 of file Intrepid_HGRAD_TET_COMP12_FEM.hpp.

Member Function Documentation

template<class Scalar , class ArrayScalar >
Scalar Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::det44 ( const Intrepid::FieldContainer< Scalar >  a) const

Returns FieldContainer of Barycentric Coordinates for the input points.

Definition at line 509 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

template<class Scalar , class ArrayScalar >
Intrepid::FieldContainer< Scalar > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getBarycentricCoords ( const ArrayScalar &  inPts) const

Returns FieldContainer of Barycentric Coordinates for the input points.

Definition at line 491 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

References Intrepid::FieldContainer< Scalar, ArrayTypeId >::dimension().

template<class Scalar , class ArrayScalar >
void Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getDofCoords ( ArrayScalar &  DofCoords) const
virtual

Returns spatial locations (coordinates) of degrees of freedom on a reference Tetrahedron.

Parameters
DofCoords[out] - array with the coordinates of degrees of freedom, dimensioned (F,D)

Implements Intrepid::DofCoordsInterface< ArrayScalar >.

Definition at line 336 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

template<class Scalar , class ArrayScalar >
Teuchos::Array< int > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getLocalSubTetrahedra ( Scalar  x,
Scalar  y,
Scalar  z 
) const

Returns array of local sub-tetrahdera that the given point resides in.

Definition at line 363 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

template<class Scalar , class ArrayScalar >
Intrepid::FieldContainer< Scalar > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getSubTetDetF ( ) const

Returns FieldContainer of local sub-tet detF.

Definition at line 670 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

template<class Scalar , class ArrayScalar >
Intrepid::FieldContainer< Scalar > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getSubTetGrads ( ) const

Returns FieldContainer of local sub-tet gradients.

Definition at line 571 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

References Intrepid::FieldContainer< Scalar, ArrayTypeId >::initialize().

template<class Scalar , class ArrayScalar >
void Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getValues ( ArrayScalar &  outputValues,
const ArrayScalar &  inputPoints,
const EOperator  operatorType 
) const
virtual

FEM basis evaluation on a reference Tetrahedron cell.

      Returns values of <var>operatorType</var> acting on FEM basis functions for a set of
      points in the <strong>reference Tetrahedron</strong> cell. For rank and dimensions of 
      I/O array arguments see Section \ref basis_md_array_sec .
Parameters
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

Implements Intrepid::Basis< Scalar, ArrayScalar >.

Definition at line 102 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.

template<class Scalar , class ArrayScalar >
Intrepid::FieldContainer< Scalar > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::getWeights ( const ArrayScalar &  inPts) const
template<class Scalar , class ArrayScalar >
Intrepid::FieldContainer< Scalar > Intrepid::Basis_HGRAD_TET_COMP12_FEM< Scalar, ArrayScalar >::inverse44 ( const Intrepid::FieldContainer< Scalar >  a) const

Returns FieldContainer of Barycentric Coordinates for the input points.

Definition at line 541 of file Intrepid_HGRAD_TET_COMP12_FEMDef.hpp.


The documentation for this class was generated from the following files: