Intrepid2
Classes | Functions
Intrepid2_TensorBasis.hpp File Reference

Implementation of bases that are tensor products of two or three component bases. More...

#include <Kokkos_DynRankView.hpp>
#include <Teuchos_RCP.hpp>
#include <Intrepid2_config.h>
#include <map>
#include <set>
#include <vector>
#include "Intrepid2_Basis.hpp"
#include "Intrepid2_DeviceAssert.hpp"
#include "Intrepid2_TensorTopologyMap.hpp"
#include "Intrepid2_TensorViewIterator.hpp"
#include "Intrepid2_Utils.hpp"
#include "Intrepid2_CellTopology.hpp"

Go to the source code of this file.

Classes

class  Intrepid2::Basis_TensorBasis< BasisBase >
 Basis defined as the tensor product of two component bases. More...
 
struct  Intrepid2::OperatorTensorDecomposition
 For a multi-component tensor basis, specifies the operators to be applied to the components to produce the composite operator on the tensor basis. More...
 
class  Intrepid2::TensorViewFunctor< ExecutionSpace, OutputScalar, OutputFieldType >
 Functor for computing values for the TensorBasis class. More...
 
class  Intrepid2::Basis_TensorBasis< BasisBase >
 Basis defined as the tensor product of two component bases. More...
 
struct  Intrepid2::TensorBasis3_Functor< ExecutionSpace, OutputScalar, OutputFieldType >
 Functor for computing values for the TensorBasis3 class. More...
 
class  Intrepid2::Basis_TensorBasis3< BasisBaseClass >
 

Functions

template<ordinal_type spaceDim>
KOKKOS_INLINE_FUNCTION ordinal_type Intrepid2::getDkEnumeration (const Kokkos::Array< int, spaceDim > &entries)
 
template<ordinal_type spaceDim>
KOKKOS_INLINE_FUNCTION void Intrepid2::getDkEnumerationInverse (Kokkos::Array< int, spaceDim > &entries, const ordinal_type dkEnum, const ordinal_type operatorOrder)
 
template<>
KOKKOS_INLINE_FUNCTION void Intrepid2::getDkEnumerationInverse< 1 > (Kokkos::Array< int, 1 > &entries, const ordinal_type dkEnum, const ordinal_type operatorOrder)
 
template<>
KOKKOS_INLINE_FUNCTION void Intrepid2::getDkEnumerationInverse< 2 > (Kokkos::Array< int, 2 > &entries, const ordinal_type dkEnum, const ordinal_type operatorOrder)
 
template<>
KOKKOS_INLINE_FUNCTION void Intrepid2::getDkEnumerationInverse< 3 > (Kokkos::Array< int, 3 > &entries, const ordinal_type dkEnum, const ordinal_type operatorOrder)
 
template<>
KOKKOS_INLINE_FUNCTION ordinal_type Intrepid2::getDkEnumeration< 1 > (const Kokkos::Array< int, 1 > &entries)
 
template<ordinal_type spaceDim1, ordinal_type spaceDim2>
KOKKOS_INLINE_FUNCTION ordinal_type Intrepid2::getDkTensorIndex (const ordinal_type dkEnum1, const ordinal_type operatorOrder1, const ordinal_type dkEnum2, const ordinal_type operatorOrder2)
 

Detailed Description

Implementation of bases that are tensor products of two or three component bases.

Author
Created by N.V. Roberts.

Definition in file Intrepid2_TensorBasis.hpp.