| 
    Nektar++
    
   | 
 
Class representing a hexehedral element in reference space. More...
#include <StdHexExp.h>


Public Member Functions | |
| StdHexExp () | |
| StdHexExp (const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc) | |
| StdHexExp (const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc, NekDouble *coeffs, NekDouble *phys) | |
| StdHexExp (const StdHexExp &T) | |
| ~StdHexExp () | |
  Public Member Functions inherited from Nektar::StdRegions::StdExpansion3D | |
| StdExpansion3D () | |
| StdExpansion3D (int numcoeffs, const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc) | |
| StdExpansion3D (const StdExpansion3D &T) | |
| virtual | ~StdExpansion3D () | 
| void | PhysTensorDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray_d1, Array< OneD, NekDouble > &outarray_d2, Array< OneD, NekDouble > &outarray_d3) | 
| Calculate the 3D derivative in the local tensor/collapsed coordinate at the physical points.  More... | |
| void | BwdTrans_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) | 
| void | IProductWRTBase_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) | 
  Public Member Functions inherited from Nektar::StdRegions::StdExpansion | |
| StdExpansion () | |
| Default Constructor.  More... | |
| StdExpansion (const int numcoeffs, const int numbases, const LibUtilities::BasisKey &Ba=LibUtilities::NullBasisKey, const LibUtilities::BasisKey &Bb=LibUtilities::NullBasisKey, const LibUtilities::BasisKey &Bc=LibUtilities::NullBasisKey) | |
| Constructor.  More... | |
| StdExpansion (const StdExpansion &T) | |
| Copy Constructor.  More... | |
| virtual | ~StdExpansion () | 
| Destructor.  More... | |
| int | GetNumBases () const | 
| This function returns the number of 1D bases used in the expansion.  More... | |
| const Array< OneD, const  LibUtilities::BasisSharedPtr > &  | GetBase () const | 
| This function gets the shared point to basis.  More... | |
| const  LibUtilities::BasisSharedPtr &  | GetBasis (int dir) const | 
| This function gets the shared point to basis in the dir direction.  More... | |
| int | GetNcoeffs (void) const | 
| This function returns the total number of coefficients used in the expansion.  More... | |
| int | GetTotPoints () const | 
| This function returns the total number of quadrature points used in the element.  More... | |
| LibUtilities::BasisType | GetBasisType (const int dir) const | 
| This function returns the type of basis used in the dir direction.  More... | |
| int | GetBasisNumModes (const int dir) const | 
| This function returns the number of expansion modes in the dir direction.  More... | |
| int | EvalBasisNumModesMax (void) const | 
| This function returns the maximum number of expansion modes over all local directions.  More... | |
| LibUtilities::PointsType | GetPointsType (const int dir) const | 
| This function returns the type of quadrature points used in the dir direction.  More... | |
| int | GetNumPoints (const int dir) const | 
| This function returns the number of quadrature points in the dir direction.  More... | |
| const Array< OneD, const  NekDouble > &  | GetPoints (const int dir) const | 
| This function returns a pointer to the array containing the quadrature points in dir direction.  More... | |
| int | GetNverts () const | 
| This function returns the number of vertices of the expansion domain.  More... | |
| int | GetNedges () const | 
| This function returns the number of edges of the expansion domain.  More... | |
| int | GetEdgeNcoeffs (const int i) const | 
| This function returns the number of expansion coefficients belonging to the i-th edge.  More... | |
| int | GetTotalEdgeIntNcoeffs () const | 
| int | GetEdgeNumPoints (const int i) const | 
| This function returns the number of quadrature points belonging to the i-th edge.  More... | |
| int | DetCartesianDirOfEdge (const int edge) | 
| const LibUtilities::BasisKey | DetEdgeBasisKey (const int i) const | 
| const LibUtilities::BasisKey | DetFaceBasisKey (const int i, const int k) const | 
| int | GetFaceNumPoints (const int i) const | 
| This function returns the number of quadrature points belonging to the i-th face.  More... | |
| int | GetFaceNcoeffs (const int i) const | 
| This function returns the number of expansion coefficients belonging to the i-th face.  More... | |
| int | GetFaceIntNcoeffs (const int i) const | 
| int | GetTotalFaceIntNcoeffs () const | 
| int | GetTraceNcoeffs (const int i) const | 
| This function returns the number of expansion coefficients belonging to the i-th edge/face.  More... | |
| LibUtilities::PointsKey | GetFacePointsKey (const int i, const int j) const | 
| int | NumBndryCoeffs (void) const | 
| int | NumDGBndryCoeffs (void) const | 
| LibUtilities::BasisType | GetEdgeBasisType (const int i) const | 
| This function returns the type of expansion basis on the i-th edge.  More... | |
| const LibUtilities::PointsKey | GetNodalPointsKey () const | 
| This function returns the type of expansion Nodal point type if defined.  More... | |
| int | GetNfaces () const | 
| This function returns the number of faces of the expansion domain.  More... | |
| int | GetNtrace () const | 
| Returns the number of trace elements connected to this element.  More... | |
| LibUtilities::ShapeType | DetShapeType () const | 
| This function returns the shape of the expansion domain.  More... | |
| boost::shared_ptr< StdExpansion > | GetStdExp (void) const | 
| int | GetShapeDimension () const | 
| bool | IsBoundaryInteriorExpansion () | 
| bool | IsNodalNonTensorialExp () | 
| void | BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| This function performs the Backward transformation from coefficient space to physical space.  More... | |
| void | FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| This function performs the Forward transformation from physical space to coefficient space.  More... | |
| void | FwdTrans_BndConstrained (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| NekDouble | Integral (const Array< OneD, const NekDouble > &inarray) | 
| This function integrates the specified function over the domain.  More... | |
| void | FillMode (const int mode, Array< OneD, NekDouble > &outarray) | 
| This function fills the array outarray with the mode-th mode of the expansion.  More... | |
| void | IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| this function calculates the inner product of a given function f with the different modes of the expansion  More... | |
| void | IProductWRTBase (const Array< OneD, const NekDouble > &base, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, int coll_check) | 
| void | IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| int | GetElmtId () | 
| Get the element id of this expansion when used in a list by returning value of m_elmt_id.  More... | |
| void | SetElmtId (const int id) | 
| Set the element id of this expansion when used in a list by returning value of m_elmt_id.  More... | |
| void | GetCoords (Array< OneD, NekDouble > &coords_1, Array< OneD, NekDouble > &coords_2=NullNekDouble1DArray, Array< OneD, NekDouble > &coords_3=NullNekDouble1DArray) | 
| this function returns the physical coordinates of the quadrature points of the expansion  More... | |
| void | GetCoord (const Array< OneD, const NekDouble > &Lcoord, Array< OneD, NekDouble > &coord) | 
| given the coordinates of a point of the element in the local collapsed coordinate system, this function calculates the physical coordinates of the point  More... | |
| DNekMatSharedPtr | GetStdMatrix (const StdMatrixKey &mkey) | 
| DNekBlkMatSharedPtr | GetStdStaticCondMatrix (const StdMatrixKey &mkey) | 
| IndexMapValuesSharedPtr | GetIndexMap (const IndexMapKey &ikey) | 
| const Array< OneD, const  NekDouble > &  | GetPhysNormals (void) | 
| void | SetPhysNormals (Array< OneD, const NekDouble > &normal) | 
| virtual void | SetUpPhysNormals (const int edge) | 
| void | NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, Array< OneD, NekDouble > &outarray) | 
| void | NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, const Array< OneD, NekDouble > &Fy, Array< OneD, NekDouble > &outarray) | 
| void | NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, const Array< OneD, const NekDouble > &Fz, Array< OneD, NekDouble > &outarray) | 
| void | NormVectorIProductWRTBase (const Array< OneD, const Array< OneD, NekDouble > > &Fvec, Array< OneD, NekDouble > &outarray) | 
| DNekScalBlkMatSharedPtr | GetLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| void | DropLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| StdRegions::Orientation | GetForient (int face) | 
| StdRegions::Orientation | GetEorient (int edge) | 
| StdRegions::Orientation | GetPorient (int point) | 
| StdRegions::Orientation | GetCartesianEorient (int edge) | 
| void | SetCoeffsToOrientation (Array< OneD, NekDouble > &coeffs, StdRegions::Orientation dir) | 
| void | SetCoeffsToOrientation (StdRegions::Orientation dir, Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| int | CalcNumberOfCoefficients (const std::vector< unsigned int > &nummodes, int &modes_offset) | 
| void | ExtractDataToCoeffs (const NekDouble *data, const std::vector< unsigned int > &nummodes, const int nmodes_offset, NekDouble *coeffs) | 
| NekDouble | StdPhysEvaluate (const Array< OneD, const NekDouble > &Lcoord, const Array< OneD, const NekDouble > &physvals) | 
| int | GetCoordim () | 
| void | GetBoundaryMap (Array< OneD, unsigned int > &outarray) | 
| void | GetInteriorMap (Array< OneD, unsigned int > &outarray) | 
| int | GetVertexMap (const int localVertexId, bool useCoeffPacking=false) | 
| void | GetEdgeInteriorMap (const int eid, const Orientation edgeOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray) | 
| void | GetFaceInteriorMap (const int fid, const Orientation faceOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray) | 
| void | GetEdgeToElementMap (const int eid, const Orientation edgeOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, int P=-1) | 
| void | GetFaceToElementMap (const int fid, const Orientation faceOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, int nummodesA=-1, int nummodesB=-1) | 
| void | GetEdgePhysVals (const int edge, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| Extract the physical values along edge edge from inarray into outarray following the local edge orientation and point distribution defined by defined in EdgeExp.  More... | |
| void | GetEdgePhysVals (const int edge, const boost::shared_ptr< StdExpansion > &EdgeExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | GetTracePhysVals (const int edge, const boost::shared_ptr< StdExpansion > &EdgeExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | GetVertexPhysVals (const int vertex, const Array< OneD, const NekDouble > &inarray, NekDouble &outarray) | 
| void | GetEdgeInterpVals (const int edge, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | GetEdgeQFactors (const int edge, Array< OneD, NekDouble > &outarray) | 
| Extract the metric factors to compute the contravariant fluxes along edge edge and stores them into outarray following the local edge orientation (i.e. anticlockwise convention).  More... | |
| void | GetFacePhysVals (const int face, const boost::shared_ptr< StdExpansion > &FaceExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, StdRegions::Orientation orient=eNoOrientation) | 
| void | GetEdgePhysMap (const int edge, Array< OneD, int > &outarray) | 
| void | GetFacePhysMap (const int face, Array< OneD, int > &outarray) | 
| void | MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | MultiplyByStdQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| DNekMatSharedPtr | CreateGeneralMatrix (const StdMatrixKey &mkey) | 
this function generates the mass matrix    More... | |
| void | GeneralMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | MassMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LaplacianMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | ReduceOrderCoeffs (int numMin, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | SVVLaplacianFilter (Array< OneD, NekDouble > &array, const StdMatrixKey &mkey) | 
| void | LaplacianMatrixOp (const int k1, const int k2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | WeakDerivMatrixOp (const int i, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | WeakDirectionalDerivMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | MassLevelCurvatureMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LinearAdvectionDiffusionReactionMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey, bool addDiffusionTerm=true) | 
| void | HelmholtzMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| DNekMatSharedPtr | GenMatrix (const StdMatrixKey &mkey) | 
| void | PhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1=NullNekDouble1DArray, Array< OneD, NekDouble > &out_d2=NullNekDouble1DArray) | 
| void | PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | PhysDeriv_s (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_ds) | 
| void | PhysDeriv_n (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_dn) | 
| void | PhysDirectionalDeriv (const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &direction, Array< OneD, NekDouble > &outarray) | 
| void | StdPhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1=NullNekDouble1DArray, Array< OneD, NekDouble > &out_d2=NullNekDouble1DArray) | 
| void | StdPhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | AddRobinMassMatrix (const int edgeid, const Array< OneD, const NekDouble > &primCoeffs, DNekMatSharedPtr &inoutmat) | 
| void | AddRobinEdgeContribution (const int edgeid, const Array< OneD, const NekDouble > &primCoeffs, Array< OneD, NekDouble > &coeffs) | 
| NekDouble | PhysEvaluate (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &physvals) | 
| This function evaluates the expansion at a single (arbitrary) point of the domain.  More... | |
| NekDouble | PhysEvaluate (const Array< OneD, DNekMatSharedPtr > &I, const Array< OneD, const NekDouble > &physvals) | 
| This function evaluates the expansion at a single (arbitrary) point of the domain.  More... | |
| void | LocCoordToLocCollapsed (const Array< OneD, const NekDouble > &xi, Array< OneD, NekDouble > &eta) | 
| Convert local cartesian coordinate xi into local collapsed coordinates eta.  More... | |
| const boost::shared_ptr < SpatialDomains::GeomFactors > &  | GetMetricInfo (void) const | 
| virtual int | v_GetElmtId () | 
| Get the element id of this expansion when used in a list by returning value of m_elmt_id.  More... | |
| virtual const Array< OneD,  const NekDouble > &  | v_GetPhysNormals (void) | 
| virtual void | v_SetPhysNormals (Array< OneD, const NekDouble > &normal) | 
| virtual void | v_SetUpPhysNormals (const int edge) | 
| virtual void | v_ExtractDataToCoeffs (const NekDouble *data, const std::vector< unsigned int > &nummodes, const int nmode_offset, NekDouble *coeffs) | 
| Unpack data from input file assuming it comes from the same expansion type.  More... | |
| virtual void | v_NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_NormVectorIProductWRTBase (const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, const Array< OneD, const NekDouble > &Fz, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_NormVectorIProductWRTBase (const Array< OneD, const Array< OneD, NekDouble > > &Fvec, Array< OneD, NekDouble > &outarray) | 
| virtual DNekScalBlkMatSharedPtr | v_GetLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| virtual void | v_DropLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| virtual StdRegions::Orientation | v_GetForient (int face) | 
| virtual StdRegions::Orientation | v_GetEorient (int edge) | 
| virtual StdRegions::Orientation | v_GetCartesianEorient (int edge) | 
| virtual StdRegions::Orientation | v_GetPorient (int point) | 
| NekDouble | Linf (const Array< OneD, const NekDouble > &phys, const Array< OneD, const NekDouble > &sol=NullNekDouble1DArray) | 
Function to evaluate the discrete   error   where   is given by the array sol.  More... | |
| NekDouble | L2 (const Array< OneD, const NekDouble > &phys, const Array< OneD, const NekDouble > &sol=NullNekDouble1DArray) | 
Function to evaluate the discrete   error,   where   is given by the array sol.  More... | |
| NekDouble | H1 (const Array< OneD, const NekDouble > &phys, const Array< OneD, const NekDouble > &sol=NullNekDouble1DArray) | 
Function to evaluate the discrete   error,   where   is given by the array sol.  More... | |
| const NormalVector & | GetEdgeNormal (const int edge) const | 
| void | ComputeEdgeNormal (const int edge) | 
| void | NegateEdgeNormal (const int edge) | 
| bool | EdgeNormalNegated (const int edge) | 
| void | ComputeFaceNormal (const int face) | 
| void | NegateFaceNormal (const int face) | 
| bool | FaceNormalNegated (const int face) | 
| void | ComputeVertexNormal (const int vertex) | 
| const NormalVector & | GetFaceNormal (const int face) const | 
| const NormalVector & | GetVertexNormal (const int vertex) const | 
| const NormalVector & | GetSurfaceNormal (const int id) const | 
| const LibUtilities::PointsKeyVector | GetPointsKeys () const | 
| Array< OneD, unsigned int > | GetEdgeInverseBoundaryMap (int eid) | 
| Array< OneD, unsigned int > | GetFaceInverseBoundaryMap (int fid, StdRegions::Orientation faceOrient=eNoOrientation) | 
| DNekMatSharedPtr | BuildInverseTransformationMatrix (const DNekScalMatSharedPtr &m_transformationmatrix) | 
| void | PhysInterpToSimplexEquiSpaced (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, int npset=-1) | 
| This function performs an interpolation from the physical space points provided at input into an array of equispaced points which are not the collapsed coordinate. So for a tetrahedron you will only get a tetrahedral number of values.  More... | |
| void | GetSimplexEquiSpacedConnectivity (Array< OneD, int > &conn, bool standard=true) | 
| This function provides the connectivity of local simplices (triangles or tets) to connect the equispaced data points provided by PhysInterpToSimplexEquiSpaced.  More... | |
| void | EquiSpacedToCoeffs (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| This function performs a projection/interpolation from the equispaced points sometimes used in post-processing onto the coefficient space.  More... | |
| template<class T > | |
| boost::shared_ptr< T > | as () | 
| void | IProductWRTBase_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool multiplybyweights=true) | 
Protected Member Functions | |
| virtual void | v_PhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2) | 
| Differentiation Methods.  More... | |
| virtual void | v_PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_StdPhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2) | 
| virtual void | v_StdPhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_BwdTrans_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_BwdTrans_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) | 
| virtual void | v_FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_IProductWRTBase_MatOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_IProductWRTBase_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool multbyweights=true) | 
| virtual void | v_IProductWRTBase_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) | 
| virtual void | v_IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_IProductWRTDerivBase_MatOp (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_IProductWRTDerivBase_SumFac (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_LocCoordToLocCollapsed (const Array< OneD, const NekDouble > &xi, Array< OneD, NekDouble > &eta) | 
| virtual void | v_FillMode (const int mode, Array< OneD, NekDouble > &outarray) | 
| virtual int | v_GetNverts () const | 
| virtual int | v_GetNedges () const | 
| virtual int | v_GetNfaces () const | 
| virtual LibUtilities::ShapeType | v_DetShapeType () const | 
| virtual int | v_NumBndryCoeffs () const | 
| virtual int | v_NumDGBndryCoeffs () const | 
| virtual int | v_GetEdgeNcoeffs (const int i) const | 
| virtual int | v_GetTotalEdgeIntNcoeffs () const | 
| virtual int | v_GetFaceNcoeffs (const int i) const | 
| virtual int | v_GetFaceIntNcoeffs (const int i) const | 
| virtual int | v_GetTotalFaceIntNcoeffs () const | 
| virtual int | v_GetFaceNumPoints (const int i) const | 
| virtual LibUtilities::PointsKey | v_GetFacePointsKey (const int i, const int j) const | 
| virtual int | v_CalcNumberOfCoefficients (const std::vector< unsigned int > &nummodes, int &modes_offset) | 
| virtual const  LibUtilities::BasisKey  | v_DetFaceBasisKey (const int i, const int k) const | 
| virtual LibUtilities::BasisType | v_GetEdgeBasisType (const int i) const | 
| virtual bool | v_IsBoundaryInteriorExpansion () | 
| virtual void | v_GetCoords (Array< OneD, NekDouble > &coords_x, Array< OneD, NekDouble > &coords_y, Array< OneD, NekDouble > &coords_z) | 
| virtual void | v_GetFaceToElementMap (const int fid, const Orientation faceOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, int nummodesA=-1, int nummodesB=-1) | 
| virtual int | v_GetVertexMap (int localVertexId, bool useCoeffPacking=false) | 
| virtual void | v_GetEdgeInteriorMap (const int eid, const Orientation edgeOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray) | 
| virtual void | v_GetFaceInteriorMap (const int fid, const Orientation faceOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray) | 
| virtual void | v_GetInteriorMap (Array< OneD, unsigned int > &outarray) | 
| virtual void | v_GetBoundaryMap (Array< OneD, unsigned int > &outarray) | 
| virtual DNekMatSharedPtr | v_GenMatrix (const StdMatrixKey &mkey) | 
| virtual DNekMatSharedPtr | v_CreateStdMatrix (const StdMatrixKey &mkey) | 
| virtual void | v_MassMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_LaplacianMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_LaplacianMatrixOp (const int k1, const int k2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_WeakDerivMatrixOp (const int i, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_HelmholtzMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_GeneralMatrixOp_MatOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_MultiplyByStdQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_SVVLaplacianFilter (Array< OneD, NekDouble > &array, const StdMatrixKey &mkey) | 
  Protected Member Functions inherited from Nektar::StdRegions::StdExpansion3D | |
| virtual NekDouble | v_PhysEvaluate (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &physvals) | 
| This function evaluates the expansion at a single (arbitrary) point of the domain.  More... | |
| virtual NekDouble | v_PhysEvaluate (const Array< OneD, DNekMatSharedPtr > &I, const Array< OneD, const NekDouble > &physvals) | 
| virtual void | v_LaplacianMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) | 
| virtual void | v_HelmholtzMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) | 
| virtual NekDouble | v_Integral (const Array< OneD, const NekDouble > &inarray) | 
| Integrates the specified function over the domain.  More... | |
| virtual void | v_NegateFaceNormal (const int face) | 
| virtual bool | v_FaceNormalNegated (const int face) | 
| virtual int | v_GetTraceNcoeffs (const int i) const | 
  Protected Member Functions inherited from Nektar::StdRegions::StdExpansion | |
| DNekMatSharedPtr | CreateStdMatrix (const StdMatrixKey &mkey) | 
| DNekBlkMatSharedPtr | CreateStdStaticCondMatrix (const StdMatrixKey &mkey) | 
| Create the static condensation of a matrix when using a boundary interior decomposition.  More... | |
| IndexMapValuesSharedPtr | CreateIndexMap (const IndexMapKey &ikey) | 
| Create an IndexMap which contains mapping information linking any specific element shape with either its boundaries, edges, faces, verteces, etc.  More... | |
| void | BwdTrans_MatOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | BwdTrans_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | IProductWRTDerivBase_SumFac (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| void | GeneralMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | MassMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LaplacianMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LaplacianMatrixOp_MatFree_Kernel (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp) | 
| void | LaplacianMatrixOp_MatFree_GenericImpl (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LaplacianMatrixOp_MatFree (const int k1, const int k2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | WeakDerivMatrixOp_MatFree (const int i, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | WeakDirectionalDerivMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | MassLevelCurvatureMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | LinearAdvectionDiffusionReactionMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey, bool addDiffusionTerm=true) | 
| void | HelmholtzMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| void | HelmholtzMatrixOp_MatFree_GenericImpl (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) | 
| virtual void | v_SetCoeffsToOrientation (StdRegions::Orientation dir, Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_SetCoeffsToOrientation (Array< OneD, NekDouble > &coeffs, StdRegions::Orientation dir) | 
| virtual NekDouble | v_StdPhysEvaluate (const Array< OneD, const NekDouble > &Lcoord, const Array< OneD, const NekDouble > &physvals) | 
Additional Inherited Members | |
  Protected Attributes inherited from Nektar::StdRegions::StdExpansion3D | |
| std::map< int, NormalVector > | m_faceNormals | 
| std::map< int, bool > | m_negatedNormals | 
  Protected Attributes inherited from Nektar::StdRegions::StdExpansion | |
| Array< OneD,  LibUtilities::BasisSharedPtr >  | m_base | 
| int | m_elmt_id | 
| int | m_ncoeffs | 
| LibUtilities::NekManager < StdMatrixKey, DNekMat, StdMatrixKey::opLess >  | m_stdMatrixManager | 
| LibUtilities::NekManager < StdMatrixKey, DNekBlkMat, StdMatrixKey::opLess >  | m_stdStaticCondMatrixManager | 
| LibUtilities::NekManager < IndexMapKey, IndexMapValues, IndexMapKey::opLess >  | m_IndexMapManager | 
Class representing a hexehedral element in reference space.
Definition at line 48 of file StdHexExp.h.
| Nektar::StdRegions::StdHexExp::StdHexExp | ( | ) | 
Definition at line 49 of file StdHexExp.cpp.
| Nektar::StdRegions::StdHexExp::StdHexExp | ( | const LibUtilities::BasisKey & | Ba, | 
| const LibUtilities::BasisKey & | Bb, | ||
| const LibUtilities::BasisKey & | Bc | ||
| ) | 
Definition at line 54 of file StdHexExp.cpp.
| Nektar::StdRegions::StdHexExp::StdHexExp | ( | const LibUtilities::BasisKey & | Ba, | 
| const LibUtilities::BasisKey & | Bb, | ||
| const LibUtilities::BasisKey & | Bc, | ||
| NekDouble * | coeffs, | ||
| NekDouble * | phys | ||
| ) | 
Definition at line 65 of file StdHexExp.cpp.
| Nektar::StdRegions::StdHexExp::StdHexExp | ( | const StdHexExp & | T | ) | 
Definition at line 74 of file StdHexExp.cpp.
| Nektar::StdRegions::StdHexExp::~StdHexExp | ( | ) | 
Definition at line 81 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Backward transformation is three dimensional tensorial expansion 
 And sumfactorizing step of the form is as:\ 
| inarray | ? | 
| outarray | ? | 
Implements Nektar::StdRegions::StdExpansion.
Definition at line 184 of file StdHexExp.cpp.
References ASSERTL1, Nektar::StdRegions::StdExpansion::BwdTrans_SumFac(), Nektar::LibUtilities::eModified_B, Nektar::LibUtilities::eModified_C, Nektar::LibUtilities::eOrtho_B, Nektar::LibUtilities::eOrtho_C, Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::GetNumPoints(), Nektar::StdRegions::StdExpansion::m_base, and Vmath::Vcopy().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 214 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion3D::BwdTrans_SumFacKernel(), Nektar::StdRegions::StdExpansion::GetNumPoints(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
| base0 | x-dirn basis matrix | 
| base1 | y-dirn basis matrix | 
| base2 | z-dirn basis matrix | 
| inarray | Input vector of modes. | 
| outarray | Output vector of physical space data. | 
| wsp | Workspace of size Q_x*P_z*(P_y+Q_y) | 
| doCheckCollDir0 | Check for collocation of basis. | 
| doCheckCollDir1 | Check for collocation of basis. | 
| doCheckCollDir2 | Check for collocation of basis. | 
Implements Nektar::StdRegions::StdExpansion3D.
Definition at line 241 of file StdHexExp.cpp.
References ASSERTL1, Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::m_ncoeffs, and Vmath::Vcopy().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 848 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2219 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::CreateGeneralMatrix().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 857 of file StdHexExp.cpp.
References ASSERTL2, Nektar::StdRegions::EvaluateQuadFaceBasisKey(), Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::GetNumPoints(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 693 of file StdHexExp.cpp.
References Nektar::LibUtilities::eHexahedron.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 624 of file StdHexExp.cpp.
References ASSERTL2, Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::m_ncoeffs, Vmath::Vcopy(), and Vmath::Vmul().
      
  | 
  protectedvirtual | 
Solves the system 
| inarray | array of physical quadrature points to be transformed,  .  | 
| outarray | array of expansion coefficients,  .  | 
Implements Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 305 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eInvMass, Nektar::eWrapper, Nektar::StdRegions::StdExpansion::GetNcoeffs(), Nektar::StdRegions::StdExpansion::GetStdMatrix(), Nektar::StdRegions::StdExpansion::IProductWRTBase(), Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::m_ncoeffs, and Vmath::Vcopy().
      
  | 
  protectedvirtual | 
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2271 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::m_ncoeffs, Nektar::StdRegions::StdExpansion::m_stdMatrixManager, and Vmath::Vcopy().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2213 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::CreateGeneralMatrix().
      
  | 
  protectedvirtual | 
| outarray | Storage for computed map. | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 2122 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::m_base, and Nektar::StdRegions::StdExpansion::NumBndryCoeffs().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 904 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::GetNumPoints(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 886 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::GetBasisType().
      
  | 
  protectedvirtual | 
| eid | The edge to compute the numbering for. | 
| edgeOrient | Orientation of the edge. | 
| maparray | Storage for computed mapping array. | 
| signarray | ? | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1420 of file StdHexExp.cpp.
References ASSERTL1, Nektar::StdRegions::eBackwards, Nektar::StdRegions::eForwards, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::GetEdgeNcoeffs(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 740 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::GetBasisNumModes().
      
  | 
  protectedvirtual | 
Generate mapping describing which elemental modes lie on the interior of a given face. Accounts for face orientation.
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1718 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::GetFaceIntNcoeffs(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 782 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::GetBasisNumModes().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 764 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::GetBasisNumModes().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 807 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 828 of file StdHexExp.cpp.
References ASSERTL2, and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Only for basis type Modified_A or GLL_LAGRANGE in all directions.
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 934 of file StdHexExp.cpp.
References ASSERTL0, ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetEdgeBasisType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
| outarray | Storage area for computed map. | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 2058 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::m_ncoeffs, and Nektar::StdRegions::StdExpansion::NumBndryCoeffs().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 681 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 687 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Implements Nektar::StdRegions::StdExpansion.
Definition at line 675 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 758 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::GetBasisNumModes().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 800 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::GetBasisNumModes().
      
  | 
  protectedvirtual | 
Expansions in each of the three dimensions must be of type LibUtilities::eModified_A or LibUtilities::eGLL_Lagrange.
| localVertexId | ID of vertex (0..7) | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1286 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2262 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree().
      
  | 
  protectedvirtual | 
 
where 
 
which can be implemented as 
 
 
 
 
 
| inarray | ? | 
| outarray | ? | 
Implements Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 366 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::MultiplyByQuadratureMetric(), and v_IProductWRTBase_SumFac().
      
  | 
  protectedvirtual | 
Implementation of the local matrix inner product operation.
Definition at line 385 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eIProductWRTBase, Nektar::StdRegions::StdExpansion::GetStdMatrix(), Nektar::StdRegions::StdExpansion::GetTotPoints(), and Nektar::StdRegions::StdExpansion::m_ncoeffs.
      
  | 
  protectedvirtual | 
Implementation of the sum-factorization inner product operation.
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 399 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion3D::IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdExpansion::m_base, and Nektar::StdRegions::StdExpansion::MultiplyByQuadratureMetric().
Referenced by v_IProductWRTBase().
      
  | 
  protectedvirtual | 
Implementation of the sum-factorisation inner product operation.
Implements Nektar::StdRegions::StdExpansion3D.
Definition at line 437 of file StdHexExp.cpp.
References ASSERTL1, Nektar::StdRegions::StdExpansion::m_base, Nektar::StdRegions::StdExpansion::m_ncoeffs, and Vmath::Vcopy().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 524 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::IProductWRTDerivBase_SumFac().
      
  | 
  protectedvirtual | 
Definition at line 532 of file StdHexExp.cpp.
References ASSERTL0, Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eIProductWRTDerivBase0, Nektar::StdRegions::eIProductWRTDerivBase1, Nektar::StdRegions::eIProductWRTDerivBase2, Nektar::StdRegions::StdExpansion::GetStdMatrix(), Nektar::StdRegions::StdExpansion::GetTotPoints(), and Nektar::StdRegions::StdExpansion::m_ncoeffs.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 562 of file StdHexExp.cpp.
References ASSERTL0, Nektar::StdRegions::StdExpansion3D::IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdExpansion::m_base, and Nektar::StdRegions::StdExpansion::MultiplyByQuadratureMetric().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 85 of file StdHexExp.cpp.
References Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2234 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion3D::v_LaplacianMatrixOp_MatFree().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2243 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::LaplacianMatrixOp_MatFree().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 613 of file StdHexExp.cpp.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2225 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::MassMatrixOp_MatFree().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 2294 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::m_base, Vmath::Smul(), and Vmath::Vmul().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 699 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 720 of file StdHexExp.cpp.
References ASSERTL1, Nektar::LibUtilities::eGLL_Lagrange, Nektar::LibUtilities::eModified_A, Nektar::StdRegions::StdExpansion::GetBasisType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Differentiation Methods.
For Hexahedral region can use the PhysTensorDeriv function defined under StdExpansion. Following tenserproduct:
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 100 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion3D::PhysTensorDeriv().
Referenced by v_StdPhysDeriv().
      
  | 
  protectedvirtual | 
| dir | Direction in which to compute derivative. Valid values are 0, 1, 2. | 
| inarray | Input array. | 
| outarray | Output array. | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 115 of file StdHexExp.cpp.
References ASSERTL1, Nektar::NullNekDouble1DArray, and Nektar::StdRegions::StdExpansion::PhysDeriv().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 147 of file StdHexExp.cpp.
References v_PhysDeriv().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 157 of file StdHexExp.cpp.
References v_PhysDeriv().
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2327 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::BwdTrans(), Nektar::StdRegions::eFactorSVVCutoffRatio, Nektar::StdRegions::eFactorSVVDiffCoeff, Nektar::LibUtilities::eOrtho_A, Nektar::StdRegions::StdExpansion::FwdTrans(), Nektar::StdRegions::StdMatrixKey::GetConstFactor(), Nektar::StdRegions::StdExpansion::GetNcoeffs(), Nektar::StdRegions::StdExpansion::GetPointsType(), and Nektar::StdRegions::StdExpansion::m_base.
      
  | 
  protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp.
Definition at line 2253 of file StdHexExp.cpp.
References Nektar::StdRegions::StdExpansion::WeakDerivMatrixOp_MatFree().
 1.8.8