| Nektar++
    | 
#include <Expansion3D.h>


| Public Member Functions | |
| Expansion3D (SpatialDomains::Geometry3DSharedPtr pGeom) | |
| virtual | ~Expansion3D () | 
| void | SetFaceExp (const int face, Expansion2DSharedPtr &f) | 
| Expansion2DSharedPtr | GetFaceExp (const int face) | 
| void | SetTraceToGeomOrientation (Array< OneD, NekDouble > &inout) | 
| Align trace orientation with the geometry orientation.  More... | |
| void | SetFaceToGeomOrientation (const int face, Array< OneD, NekDouble > &inout) | 
| Align face orientation with the geometry orientation.  More... | |
| void | AddHDGHelmholtzFaceTerms (const NekDouble tau, const int edge, Array< OneD, NekDouble > &facePhys, const StdRegions::VarCoeffMap &dirForcing, Array< OneD, NekDouble > &outarray) | 
| void | AddNormTraceInt (const int dir, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, Array< OneD, NekDouble > > &faceCoeffs, Array< OneD, NekDouble > &outarray) | 
| void | AddNormTraceInt (const int dir, Array< OneD, const NekDouble > &inarray, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, NekDouble > &outarray, const StdRegions::VarCoeffMap &varcoeffs) | 
| void | AddFaceBoundaryInt (const int face, ExpansionSharedPtr &FaceExp, Array< OneD, NekDouble > &facePhys, Array< OneD, NekDouble > &outarray, const StdRegions::VarCoeffMap &varcoeffs=StdRegions::NullVarCoeffMap) | 
| SpatialDomains::Geometry3DSharedPtr | GetGeom3D () const | 
|  Public Member Functions inherited from Nektar::LocalRegions::Expansion | |
| Expansion (SpatialDomains::GeometrySharedPtr pGeom) | |
| Expansion (const Expansion &pSrc) | |
| virtual | ~Expansion () | 
| DNekScalMatSharedPtr | GetLocMatrix (const LocalRegions::MatrixKey &mkey) | 
| DNekScalMatSharedPtr | GetLocMatrix (const StdRegions::MatrixType mtype, const StdRegions::ConstFactorMap &factors=StdRegions::NullConstFactorMap, const StdRegions::VarCoeffMap &varcoeffs=StdRegions::NullVarCoeffMap) | 
| SpatialDomains::GeometrySharedPtr | GetGeom () const | 
| void | Reset () | 
| virtual const SpatialDomains::GeomFactorsSharedPtr & | v_GetMetricInfo () const | 
| DNekMatSharedPtr | BuildTransformationMatrix (const DNekScalMatSharedPtr &r_bnd, const StdRegions::MatrixType matrixType) | 
| DNekMatSharedPtr | BuildVertexMatrix (const DNekScalMatSharedPtr &r_bnd) | 
| void | AddEdgeNormBoundaryInt (const int edge, const boost::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray) | 
| void | AddEdgeNormBoundaryInt (const int edge, const boost::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) | 
| void | AddFaceNormBoundaryInt (const int face, const boost::shared_ptr< Expansion > &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) | 
| void | DGDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, ExpansionSharedPtr > &EdgeExp, Array< OneD, Array< OneD, NekDouble > > &coeffs, Array< OneD, NekDouble > &outarray) | 
|  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 | 
| 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, const Array< OneD, const 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) | 
| 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) | 
| 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 | 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 ![$\mathbf{M}[i][j] = \int \phi_i(\mathbf{x}) \phi_j(\mathbf{x}) d\mathbf{x}$](form_123.png) 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 int | v_CalcNumberOfCoefficients (const std::vector< unsigned int > &nummodes, int &modes_offset) | 
| 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, 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 DNekScalBlkMatSharedPtr | v_GetLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| virtual void | v_DropLocStaticCondMatrix (const LocalRegions::MatrixKey &mkey) | 
| 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, ![$ | \epsilon |_{2} = \left [ \int^1_{-1} [u - u_{exact}]^2 dx \right]^{1/2} d\xi_1 $](form_135.png) 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, ![$ | \epsilon |^1_{2} = \left [ \int^1_{-1} [u - u_{exact}]^2 + \nabla(u - u_{exact})\cdot\nabla(u - u_{exact})\cdot dx \right]^{1/2} d\xi_1 $](form_138.png) 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) | 
| 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) | 
| 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... | |
| template<class T > | |
| boost::shared_ptr< T > | as () | 
| void | IProductWRTBase_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool multiplybyweights=true) | 
|  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) | 
| Protected Member Functions | |
| virtual void | v_DGDeriv (const int dir, const Array< OneD, const NekDouble > &incoeffs, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, Array< OneD, NekDouble > > &faceCoeffs, Array< OneD, NekDouble > &out_d) | 
| Evaluate coefficients of weak deriviative in the direction dir given the input coefficicents incoeffs and the imposed boundary values in EdgeExp (which will have its phys space updated).  More... | |
| virtual DNekMatSharedPtr | v_GenMatrix (const StdRegions::StdMatrixKey &mkey) | 
| virtual void | v_AddFaceNormBoundaryInt (const int face, const ExpansionSharedPtr &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_AddRobinMassMatrix (const int face, const Array< OneD, const NekDouble > &primCoeffs, DNekMatSharedPtr &inoutmat) | 
| virtual StdRegions::Orientation | v_GetForient (int face) | 
| virtual Array< OneD, unsigned int > | v_GetEdgeInverseBoundaryMap (int eid) | 
| virtual Array< OneD, unsigned int > | v_GetFaceInverseBoundaryMap (int fid, StdRegions::Orientation faceOrient=StdRegions::eNoOrientation) | 
| virtual DNekMatSharedPtr | v_BuildTransformationMatrix (const DNekScalMatSharedPtr &r_bnd, const StdRegions::MatrixType matrixType) | 
| virtual DNekMatSharedPtr | v_BuildInverseTransformationMatrix (const DNekScalMatSharedPtr &m_transformationmatrix) | 
| Build inverse and inverse transposed transformation matrix:  and  .  More... | |
| virtual DNekMatSharedPtr | v_BuildVertexMatrix (const DNekScalMatSharedPtr &r_bnd) | 
|  Protected Member Functions inherited from Nektar::LocalRegions::Expansion | |
| void | ComputeLaplacianMetric () | 
| void | ComputeQuadratureMetric () | 
| virtual void | v_MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_ComputeLaplacianMetric () | 
| virtual void | v_GetCoords (Array< OneD, NekDouble > &coords_1, Array< OneD, NekDouble > &coords_2, Array< OneD, NekDouble > &coords_3) | 
| virtual DNekScalMatSharedPtr | v_GetLocMatrix (const LocalRegions::MatrixKey &mkey) | 
| virtual void | v_AddEdgeNormBoundaryInt (const int edge, const boost::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_AddEdgeNormBoundaryInt (const int edge, const boost::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) | 
| virtual void | v_AddFaceNormBoundaryInt (const int face, const boost::shared_ptr< Expansion > &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) | 
|  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) | 
|  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_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)=0 | 
| 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)=0 | 
| 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) | 
| Private Attributes | |
| std::vector< Expansion2DWeakPtr > | m_faceExp | 
| std::vector< bool > | m_requireNeg | 
| Additional Inherited Members | |
|  Protected Attributes inherited from Nektar::LocalRegions::Expansion | |
| SpatialDomains::GeometrySharedPtr | m_geom | 
| SpatialDomains::GeomFactorsSharedPtr | m_metricinfo | 
| MetricMap | m_metrics | 
|  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 | 
|  Protected Attributes inherited from Nektar::StdRegions::StdExpansion3D | |
| std::map< int, NormalVector > | m_faceNormals | 
| std::map< int, bool > | m_negatedNormals | 
Definition at line 59 of file Expansion3D.h.
| 
 | inline | 
Definition at line 63 of file Expansion3D.h.
| 
 | inlinevirtual | 
Definition at line 64 of file Expansion3D.h.
| 
 | inline | 
For a given face add the {F}_1j contributions
Definition at line 267 of file Expansion3D.cpp.
References Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::StdExpansion::GetBasisNumModes(), and Nektar::StdRegions::StdExpansion::GetForient().
Referenced by AddNormTraceInt().
| 
 | inline | 
Definition at line 48 of file Expansion3D.cpp.
References Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::eInvMass, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::eWrapper, Nektar::StdRegions::StdExpansion::GetBasisNumModes(), Nektar::StdRegions::StdExpansion::GetCoordim(), GetFaceExp(), Nektar::StdRegions::StdExpansion::GetFaceNormal(), Nektar::StdRegions::StdExpansion::GetForient(), Nektar::LocalRegions::Expansion::GetLocMatrix(), Nektar::StdRegions::StdExpansion::GetNcoeffs(), Nektar::StdRegions::StdExpansion3D::m_negatedNormals, Vmath::Neg(), and Vmath::Vmul().
Referenced by v_GenMatrix().
| 
 | inline | 
Definition at line 230 of file Expansion3D.cpp.
References AddFaceBoundaryInt(), Nektar::StdRegions::StdExpansion::GetFaceNormal(), Nektar::StdRegions::StdExpansion::GetNfaces(), Nektar::StdRegions::StdExpansion3D::m_negatedNormals, Vmath::Neg(), and Vmath::Vmul().
Referenced by v_DGDeriv(), and v_GenMatrix().
| 
 | inline | 
Computes the C matrix entries due to the presence of the identity matrix in Eqn. 32.
: Document this
Definition at line 175 of file Expansion3D.cpp.
References AddFaceBoundaryInt(), Nektar::StdRegions::StdExpansion::GetFaceNormal(), Nektar::StdRegions::StdExpansion::GetNfaces(), Nektar::StdRegions::StdExpansion3D::m_negatedNormals, Vmath::Neg(), and Vmath::Vmul().
| Expansion2DSharedPtr Nektar::LocalRegions::Expansion3D::GetFaceExp | ( | const int | face | ) | 
Definition at line 913 of file Expansion3D.cpp.
References m_faceExp.
Referenced by AddHDGHelmholtzFaceTerms(), and v_GenMatrix().
| 
 | inline | 
Definition at line 149 of file Expansion3D.h.
References Nektar::LocalRegions::Expansion::m_geom.
Referenced by Nektar::MultiRegions::ExpList2D::ExpList2D(), Nektar::MultiRegions::DisContField3D::SetUpDG(), v_AddFaceNormBoundaryInt(), v_BuildTransformationMatrix(), v_GetEdgeInverseBoundaryMap(), and Nektar::LocalRegions::HexExp::v_GetFaceDGForwards().
| void Nektar::LocalRegions::Expansion3D::SetFaceExp | ( | const int | face, | 
| Expansion2DSharedPtr & | f | ||
| ) | 
Definition at line 902 of file Expansion3D.cpp.
References ASSERTL1, Nektar::StdRegions::StdExpansion::GetNfaces(), and m_faceExp.
| void Nektar::LocalRegions::Expansion3D::SetFaceToGeomOrientation | ( | const int | face, | 
| Array< OneD, NekDouble > & | inout | ||
| ) | 
Align face orientation with the geometry orientation.
Definition at line 310 of file Expansion3D.cpp.
References ASSERTL1, Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eDir1FwdDir1_Dir2FwdDir2, Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::StdExpansion::GetBasisNumModes(), Nektar::StdRegions::StdExpansion::GetFaceNcoeffs(), Nektar::StdRegions::StdExpansion::GetForient(), and Vmath::Vcopy().
Referenced by SetTraceToGeomOrientation(), and v_GenMatrix().
| void Nektar::LocalRegions::Expansion3D::SetTraceToGeomOrientation | ( | Array< OneD, NekDouble > & | inout | ) | 
Align trace orientation with the geometry orientation.
Definition at line 357 of file Expansion3D.cpp.
References Nektar::StdRegions::StdExpansion::GetFaceNcoeffs(), Nektar::StdRegions::StdExpansion::GetNfaces(), and SetFaceToGeomOrientation().
Referenced by v_GenMatrix().
| 
 | protectedvirtual | 
Definition at line 918 of file Expansion3D.cpp.
References Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::eMass, Nektar::LibUtilities::eQuadrilateral, Nektar::LibUtilities::eTriangle, Nektar::StdRegions::StdExpansion::GetBasisNumModes(), Nektar::StdRegions::StdExpansion::GetForient(), GetGeom3D(), Nektar::StdRegions::StdExpansion::GetNfaces(), Nektar::StdRegions::StdExpansion::m_base, m_faceExp, Nektar::StdRegions::StdExpansion3D::m_negatedNormals, and m_requireNeg.
| 
 | protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1094 of file Expansion3D.cpp.
References ASSERTL0, ASSERTL1, ASSERTL2, Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eDir1FwdDir1_Dir2FwdDir2, Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::eMass, Nektar::StdRegions::eVarCoeffMass, Nektar::StdRegions::StdExpansion::GetBasisNumModes(), Nektar::StdRegions::StdExpansion::GetBoundaryMap(), Nektar::StdRegions::StdExpansion::GetFaceNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceToElementMap(), Nektar::StdRegions::StdExpansion::GetForient(), Nektar::StdRegions::StdExpansion::GetNcoeffs(), Nektar::StdRegions::StdExpansion::IsBoundaryInteriorExpansion(), m_faceExp, Nektar::StdRegions::NullConstFactorMap, Nektar::StdRegions::StdExpansion::NumBndryCoeffs(), Nektar::StdRegions::StdExpansion::NumDGBndryCoeffs(), and sign.
| 
 | protectedvirtual | 
Build inverse and inverse transposed transformation matrix:  and
 and  .
. 
{R^{-T}}=[[{array}{ccc} {I} & -{R}_{ef} & -{R}_{ve}+{R}_{ve}{R}_{vf} \ 0 & {I} & {R}_{ef} \ 0 & 0 & {I}} {array}]]
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1680 of file Expansion3D.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::eFULL, Nektar::StdRegions::StdExpansion::GetEdgeInverseBoundaryMap(), Nektar::StdRegions::StdExpansion::GetEdgeNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceIntNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceInverseBoundaryMap(), Nektar::StdRegions::StdExpansion::GetNedges(), Nektar::StdRegions::StdExpansion::GetNfaces(), Nektar::StdRegions::StdExpansion::GetNverts(), Nektar::StdRegions::StdExpansion::GetVertexMap(), Nektar::StdRegions::StdExpansion::NumBndryCoeffs(), and Vmath::Vcopy().
| 
 | protectedvirtual | 
The matrix component of  is given by
 is given by 
![\[ \mathbf{R^{T}_{v}}= -\mathbf{S}^{-1}_{ef,ef}\mathbf{S}^{T}_{v,ef}\]](form_211.png) 
For every vertex mode we extract the submatrices from statically condensed matrix  corresponding to the coupling between the attached edges and faces of a vertex (
 corresponding to the coupling between the attached edges and faces of a vertex (  ). This matrix is then inverted and multiplied by the submatrix representing the coupling between a vertex and the attached edges and faces (
). This matrix is then inverted and multiplied by the submatrix representing the coupling between a vertex and the attached edges and faces (  ).
).
Reimplemented from Nektar::LocalRegions::Expansion.
Definition at line 1259 of file Expansion3D.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), ErrorUtil::efatal, Nektar::eFULL, Nektar::StdRegions::ePreconR, Nektar::StdRegions::ePreconRMass, Nektar::StdRegions::ePreconRT, Nektar::StdRegions::ePreconRTMass, Nektar::StdRegions::StdExpansion::GetEdgeInverseBoundaryMap(), Nektar::StdRegions::StdExpansion::GetEdgeNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceIntNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceInverseBoundaryMap(), GetGeom3D(), Nektar::StdRegions::StdExpansion::GetNedges(), Nektar::StdRegions::StdExpansion::GetNverts(), Nektar::StdRegions::StdExpansion::GetVertexMap(), NEKERROR, Nektar::NullDNekMatSharedPtr, Nektar::StdRegions::StdExpansion::NumBndryCoeffs(), and Vmath::Vcopy().
| 
 | protectedvirtual | 
Reimplemented from Nektar::LocalRegions::Expansion.
Definition at line 1228 of file Expansion3D.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::eFULL, Nektar::StdRegions::StdExpansion::GetNverts(), and Nektar::StdRegions::StdExpansion::GetVertexMap().
| 
 | protectedvirtual | 
Evaluate coefficients of weak deriviative in the direction dir given the input coefficicents incoeffs and the imposed boundary values in EdgeExp (which will have its phys space updated).
Reimplemented from Nektar::LocalRegions::Expansion.
Definition at line 1064 of file Expansion3D.cpp.
References AddNormTraceInt(), Nektar::StdRegions::eInvMass, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::eWrapper, Nektar::LocalRegions::Expansion::GetLocMatrix(), Nektar::StdRegions::StdExpansion::GetNcoeffs(), Vmath::Neg(), and Nektar::Transpose().
| 
 | protectedvirtual | 
Computes matrices needed for the HDG formulation. References to equations relate to the following paper (with a suitable changes in formulation to adapt to 3D): R. M. Kirby, S. J. Sherwin, B. Cockburn, To CG or to HDG: A Comparative Study, J. Sci. Comp P1-30 DOI 10.1007/s10915-011-9501-7 NOTE: VARIABLE COEFFICIENTS CASE IS NOT IMPLEMENTED
Reimplemented from Nektar::StdRegions::StdExpansion.
Reimplemented in Nektar::LocalRegions::HexExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::LocalRegions::PyrExp.
Definition at line 380 of file Expansion3D.cpp.
References AddHDGHelmholtzFaceTerms(), AddNormTraceInt(), Nektar::MemoryManager< DataType >::AllocateSharedPtr(), ASSERTL0, ASSERTL1, Nektar::StdRegions::StdExpansion::DetShapeType(), Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eFactorTau, Nektar::StdRegions::eHybridDGHelmBndLam, Nektar::StdRegions::eHybridDGHelmholtz, Nektar::StdRegions::eHybridDGLamToQ0, Nektar::StdRegions::eHybridDGLamToQ1, Nektar::StdRegions::eHybridDGLamToQ2, Nektar::StdRegions::eHybridDGLamToU, Nektar::StdRegions::eInvHybridDGHelmholtz, Nektar::StdRegions::eInvLaplacianWithUnityMean, Nektar::StdRegions::eInvMass, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eMass, Nektar::StdRegions::eVarCoeffD00, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::eWrapper, Vmath::Fill(), Nektar::StdRegions::StdExpansion::GetBasisNumModes(), Nektar::StdRegions::StdMatrixKey::GetConstFactor(), Nektar::StdRegions::StdMatrixKey::GetConstFactors(), Nektar::StdRegions::StdExpansion::GetCoordim(), GetFaceExp(), Nektar::StdRegions::StdExpansion::GetFaceNcoeffs(), Nektar::StdRegions::StdExpansion::GetFaceNormal(), Nektar::StdRegions::StdExpansion::GetForient(), Nektar::LocalRegions::Expansion::GetLocMatrix(), Nektar::StdRegions::StdMatrixKey::GetMatrixType(), Nektar::StdRegions::StdExpansion::GetNcoeffs(), Nektar::StdRegions::StdExpansion::GetNfaces(), Nektar::StdRegions::StdExpansion::GetTotPoints(), Nektar::StdRegions::StdMatrixKey::GetVarCoeffs(), Nektar::StdRegions::StdMatrixKey::HasVarCoeff(), Nektar::StdRegions::StdExpansion::IProductWRTBase(), Nektar::StdRegions::StdExpansion::IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdExpansion::m_ncoeffs, Nektar::StdRegions::StdExpansion3D::m_negatedNormals, Vmath::Neg(), Nektar::StdRegions::StdExpansion::NumDGBndryCoeffs(), SetFaceToGeomOrientation(), SetTraceToGeomOrientation(), sign, Vmath::Svtvp(), Nektar::Transpose(), Vmath::Vcopy(), Vmath::Vmul(), Vmath::Vvtvp(), and Vmath::Zero().
Referenced by Nektar::LocalRegions::PyrExp::v_GenMatrix(), Nektar::LocalRegions::TetExp::v_GenMatrix(), Nektar::LocalRegions::PrismExp::v_GenMatrix(), and Nektar::LocalRegions::HexExp::v_GenMatrix().
| 
 | protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1806 of file Expansion3D.cpp.
References Nektar::StdRegions::StdExpansion::GetBoundaryMap(), Nektar::StdRegions::StdExpansion::GetEdgeInteriorMap(), Nektar::StdRegions::StdExpansion::GetEdgeNcoeffs(), GetGeom3D(), and Nektar::StdRegions::StdExpansion::NumBndryCoeffs().
| 
 | protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1849 of file Expansion3D.cpp.
References Nektar::StdRegions::eNoOrientation, Nektar::StdRegions::StdExpansion::GetBoundaryMap(), Nektar::StdRegions::StdExpansion::GetFaceInteriorMap(), Nektar::StdRegions::StdExpansion::GetFaceIntNcoeffs(), Nektar::StdRegions::StdExpansion::GetForient(), and Nektar::StdRegions::StdExpansion::NumBndryCoeffs().
| 
 | protectedvirtual | 
Reimplemented from Nektar::StdRegions::StdExpansion.
Definition at line 1897 of file Expansion3D.cpp.
References Nektar::LocalRegions::Expansion::m_geom.
| 
 | private | 
Definition at line 145 of file Expansion3D.h.
Referenced by GetFaceExp(), SetFaceExp(), v_AddFaceNormBoundaryInt(), and v_AddRobinMassMatrix().
| 
 | private | 
Definition at line 146 of file Expansion3D.h.
Referenced by v_AddFaceNormBoundaryInt().
 1.8.9.1
 1.8.9.1