Nektar++
|
The base class for all shapes. More...
#include <StdExpansion.h>
Public Member Functions | |
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 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, 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) |
Private Member Functions | |
virtual int | v_GetNverts () const =0 |
virtual int | v_GetNedges () const |
virtual int | v_GetNfaces () 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_GetEdgeNumPoints (const int i) const |
virtual int | v_DetCartesianDirOfEdge (const int edge) |
virtual const LibUtilities::BasisKey | v_DetEdgeBasisKey (const int i) const |
virtual const LibUtilities::BasisKey | v_DetFaceBasisKey (const int i, const int k) const |
virtual int | v_GetFaceNumPoints (const int i) 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_GetTraceNcoeffs (const int i) const |
virtual LibUtilities::PointsKey | v_GetFacePointsKey (const int i, const int j) const |
virtual LibUtilities::BasisType | v_GetEdgeBasisType (const int i) const |
virtual const LibUtilities::PointsKey | v_GetNodalPointsKey () const |
virtual LibUtilities::ShapeType | v_DetShapeType () const |
virtual boost::shared_ptr < StdExpansion > | v_GetStdExp (void) const |
virtual int | v_GetShapeDimension () const |
virtual bool | v_IsBoundaryInteriorExpansion () |
virtual bool | v_IsNodalNonTensorialExp () |
virtual void | v_BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)=0 |
virtual void | v_FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)=0 |
Transform a given function from physical quadrature space to coefficient space. More... | |
virtual void | v_IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)=0 |
Calculates the inner product of a given function f with the different modes of the expansion. More... | |
virtual void | v_IProductWRTBase (const Array< OneD, const NekDouble > &base, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, int coll_check) |
virtual void | v_IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual void | v_FwdTrans_BndConstrained (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual NekDouble | v_Integral (const Array< OneD, const NekDouble > &inarray) |
Integrates the specified function over the domain. More... | |
virtual void | v_PhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2, Array< OneD, NekDouble > &out_d3) |
Calculate the derivative of the physical points. More... | |
virtual void | v_PhysDeriv_s (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_ds) |
virtual void | v_PhysDeriv_n (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_dn) |
virtual void | v_PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0) |
Calculate the derivative of the physical points in a given direction. More... | |
virtual void | v_PhysDirectionalDeriv (const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &direction, Array< OneD, NekDouble > &outarray) |
Physical derivative along a direction vector. More... | |
virtual void | v_StdPhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2, Array< OneD, NekDouble > &out_d3) |
virtual void | v_StdPhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual void | v_AddRobinMassMatrix (const int edgeid, const Array< OneD, const NekDouble > &primCoeffs, DNekMatSharedPtr &inoutmat) |
virtual void | v_AddRobinEdgeContribution (const int edgeid, const Array< OneD, const NekDouble > &primCoeffs, Array< OneD, NekDouble > &coeffs) |
virtual NekDouble | v_PhysEvaluate (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &physvals) |
virtual NekDouble | v_PhysEvaluate (const Array< OneD, DNekMatSharedPtr > &I, const Array< OneD, const NekDouble > &physvals) |
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 DNekMatSharedPtr | v_GenMatrix (const StdMatrixKey &mkey) |
virtual DNekMatSharedPtr | v_CreateStdMatrix (const StdMatrixKey &mkey) |
virtual void | v_GetCoords (Array< OneD, NekDouble > &coords_0, Array< OneD, NekDouble > &coords_1, Array< OneD, NekDouble > &coords_2) |
virtual void | v_GetCoord (const Array< OneD, const NekDouble > &Lcoord, Array< OneD, NekDouble > &coord) |
virtual int | v_GetCoordim (void) |
virtual void | v_GetBoundaryMap (Array< OneD, unsigned int > &outarray) |
virtual void | v_GetInteriorMap (Array< OneD, unsigned int > &outarray) |
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_GetEdgeToElementMap (const int eid, const Orientation edgeOrient, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, int P=-1) |
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 void | v_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... | |
virtual void | v_GetEdgePhysVals (const int edge, const boost::shared_ptr< StdExpansion > &EdgeExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual void | v_GetTracePhysVals (const int edge, const boost::shared_ptr< StdExpansion > &EdgeExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, StdRegions::Orientation orient=eNoOrientation) |
virtual void | v_GetVertexPhysVals (const int vertex, const Array< OneD, const NekDouble > &inarray, NekDouble &outarray) |
virtual void | v_GetEdgeInterpVals (const int edge, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual void | v_GetEdgeQFactors (const int edge, Array< OneD, NekDouble > &outarray) |
virtual void | v_GetFacePhysVals (const int face, const boost::shared_ptr< StdExpansion > &FaceExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, StdRegions::Orientation orient) |
virtual void | v_GetEdgePhysMap (const int edge, Array< OneD, int > &outarray) |
virtual void | v_GetFacePhysMap (const int face, Array< OneD, int > &outarray) |
virtual void | v_MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual void | v_MultiplyByStdQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
virtual const boost::shared_ptr < SpatialDomains::GeomFactors > & | v_GetMetricInfo () const |
virtual void | v_BwdTrans_SumFac (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 multiplybyweights=true) |
virtual void | v_IProductWRTDerivBase_SumFac (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
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_SVVLaplacianFilter (Array< OneD, NekDouble > &array, const StdMatrixKey &mkey) |
virtual void | v_ReduceOrderCoeffs (int numMin, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
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_WeakDirectionalDerivMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
virtual void | v_MassLevelCurvatureMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
virtual void | v_LinearAdvectionDiffusionReactionMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey, bool addDiffusionTerm=true) |
virtual void | v_HelmholtzMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
virtual void | v_LaplacianMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
virtual void | v_LaplacianMatrixOp_MatFree_Kernel (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp) |
virtual void | v_HelmholtzMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
virtual const NormalVector & | v_GetEdgeNormal (const int edge) const |
virtual void | v_ComputeEdgeNormal (const int edge) |
virtual void | v_NegateEdgeNormal (const int edge) |
virtual bool | v_EdgeNormalNegated (const int edge) |
virtual void | v_ComputeFaceNormal (const int face) |
virtual void | v_NegateFaceNormal (const int face) |
virtual bool | v_FaceNormalNegated (const int face) |
virtual const NormalVector & | v_GetVertexNormal (const int vertex) const |
virtual void | v_ComputeVertexNormal (const int vertex) |
virtual const NormalVector & | v_GetFaceNormal (const int face) const |
virtual const NormalVector & | v_GetSurfaceNormal (const int id) const |
virtual Array< OneD, unsigned int > | v_GetEdgeInverseBoundaryMap (int eid) |
virtual Array< OneD, unsigned int > | v_GetFaceInverseBoundaryMap (int fid, StdRegions::Orientation faceOrient=eNoOrientation) |
virtual DNekMatSharedPtr | v_BuildInverseTransformationMatrix (const DNekScalMatSharedPtr &m_transformationmatrix) |
virtual void | v_GetSimplexEquiSpacedConnectivity (Array< OneD, int > &conn, bool standard=true) |
The base class for all shapes.
This is the lowest level basic class for all shapes and so contains the definition of common data and common routine to all elements
Definition at line 69 of file StdExpansion.h.
Nektar::StdRegions::StdExpansion::StdExpansion | ( | void | ) |
Nektar::StdRegions::StdExpansion::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.
Definition at line 50 of file StdExpansion.cpp.
References ASSERTL2, Nektar::LibUtilities::BasisManager(), m_base, and Nektar::LibUtilities::NullBasisKey().
Nektar::StdRegions::StdExpansion::StdExpansion | ( | const StdExpansion & | T | ) |
Copy Constructor.
Definition at line 92 of file StdExpansion.cpp.
|
virtual |
|
inline |
Definition at line 1108 of file StdExpansion.h.
References v_AddRobinEdgeContribution().
|
inline |
Definition at line 1103 of file StdExpansion.h.
References v_AddRobinMassMatrix().
|
inline |
Definition at line 1402 of file StdExpansion.h.
References ASSERTL1.
Referenced by Nektar::MultiRegions::PreconditionerLowEnergy::v_BuildPreconditioner().
|
inline |
Definition at line 1350 of file StdExpansion.h.
References v_BuildInverseTransformationMatrix().
|
inline |
This function performs the Backward transformation from coefficient space to physical space.
This function is a wrapper around the virtual function v_BwdTrans()
Based on the expansion coefficients, this function evaluates the expansion at the quadrature points. This is equivalent to the operation
which can be evaluated as with
This function requires that the coefficient array provided as inarray.
The resulting array containing the expansion evaluated at the quadrature points, is stored in the outarray.
inarray | contains the values of the expansion coefficients (input of the function) |
outarray | contains the values of the expansion evaluated at the quadrature points (output of the function) |
Definition at line 525 of file StdExpansion.h.
References v_BwdTrans().
Referenced by Extractlayerdata(), Nektar::LocalRegions::SegExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::SegExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdPrismExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTetExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTriExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdPrismExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdQuadExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdTetExp::v_SVVLaplacianFilter(), and Nektar::StdRegions::StdHexExp::v_SVVLaplacianFilter().
|
protected |
Definition at line 951 of file StdExpansion.cpp.
References DetShapeType(), Nektar::StdRegions::eBwdTrans, GetStdMatrix(), GetTotPoints(), and m_ncoeffs.
|
inlineprotected |
Definition at line 1460 of file StdExpansion.h.
References v_BwdTrans_SumFac().
Referenced by CreateGeneralMatrix(), and Nektar::StdRegions::StdHexExp::v_BwdTrans().
|
inline |
Definition at line 792 of file StdExpansion.h.
References v_CalcNumberOfCoefficients().
|
inline |
Definition at line 1278 of file StdExpansion.h.
References v_ComputeEdgeNormal().
Referenced by Nektar::LocalRegions::Expansion2D::v_SetUpPhysNormals().
|
inline |
Definition at line 1293 of file StdExpansion.h.
References v_ComputeFaceNormal().
|
inline |
Definition at line 1308 of file StdExpansion.h.
References v_ComputeVertexNormal().
Referenced by Nektar::StdRegions::StdExpansion1D::v_SetUpPhysNormals().
DNekMatSharedPtr Nektar::StdRegions::StdExpansion::CreateGeneralMatrix | ( | const StdMatrixKey & | mkey | ) |
this function generates the mass matrix
Definition at line 322 of file StdExpansion.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), ASSERTL0, BwdTrans_SumFac(), Nektar::StdRegions::eBwdTrans, Nektar::StdRegions::eEquiSpacedToCoeffs, ErrorUtil::efatal, Nektar::StdRegions::eHelmholtz, Nektar::StdRegions::eInvMass, Nektar::StdRegions::eInvNBasisTrans, Nektar::StdRegions::eIProductWRTBase, Nektar::StdRegions::eIProductWRTDerivBase0, Nektar::StdRegions::eIProductWRTDerivBase1, Nektar::StdRegions::eIProductWRTDerivBase2, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eLaplacian00, Nektar::StdRegions::eLaplacian01, Nektar::StdRegions::eLaplacian02, Nektar::StdRegions::eLaplacian11, Nektar::StdRegions::eLaplacian12, Nektar::StdRegions::eLaplacian22, Nektar::StdRegions::eLinearAdvectionDiffusionReaction, Nektar::StdRegions::eLinearAdvectionReaction, Nektar::StdRegions::eMass, Nektar::StdRegions::eMassLevelCurvature, Nektar::StdRegions::eNBasisTrans, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::StdRegions::eWeakDirectionalDeriv, FillMode(), GeneralMatrixOp_MatFree(), Nektar::StdRegions::StdMatrixKey::GetMatrixType(), Nektar::StdRegions::StdMatrixKey::GetNodalPointsType(), Nektar::StdRegions::StdMatrixKey::GetShapeType(), GetStdMatrix(), GetTotPoints(), IProductWRTBase_SumFac(), IProductWRTDerivBase_SumFac(), m_base, m_ncoeffs, NEKERROR, Nektar::StdRegions::NullConstFactorMap, Nektar::StdRegions::NullVarCoeffMap, PhysInterpToSimplexEquiSpaced(), Vmath::Vcopy(), and Vmath::Zero().
Referenced by Nektar::StdRegions::StdHexExp::v_CreateStdMatrix(), Nektar::StdRegions::StdPointExp::v_GenMatrix(), Nektar::StdRegions::StdNodalTetExp::v_GenMatrix(), Nektar::StdRegions::StdNodalPrismExp::v_GenMatrix(), Nektar::StdRegions::StdNodalTriExp::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GenMatrix(), Nektar::StdRegions::StdTriExp::v_GenMatrix(), Nektar::StdRegions::StdPrismExp::v_GenMatrix(), Nektar::StdRegions::StdTetExp::v_GenMatrix(), Nektar::StdRegions::StdHexExp::v_GenMatrix(), and Nektar::StdRegions::StdPyrExp::v_GenMatrix().
|
protected |
Create an IndexMap which contains mapping information linking any specific element shape with either its boundaries, edges, faces, verteces, etc.
The index member of the IndexMapValue struct gives back an integer associated with an entity index The sign member of the same struct gives back a sign to algebrically apply entities orientation
Definition at line 260 of file StdExpansion.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), ASSERTL0, Nektar::StdRegions::eBoundary, Nektar::StdRegions::eEdgeInterior, Nektar::StdRegions::eEdgeToElement, Nektar::StdRegions::eFaceInterior, Nektar::StdRegions::eFaceToElement, Nektar::StdRegions::eVertex, Nektar::StdRegions::IndexMapKey::GetIndexEntity(), Nektar::StdRegions::IndexMapKey::GetIndexMapType(), Nektar::StdRegions::IndexMapKey::GetIndexOrientation(), sign, v_GetEdgeInteriorMap(), v_GetEdgeToElementMap(), v_GetFaceInteriorMap(), and v_GetFaceToElementMap().
|
inlineprotected |
Definition at line 1429 of file StdExpansion.h.
References v_CreateStdMatrix().
|
protected |
Create the static condensation of a matrix when using a boundary interior decomposition.
If a matrix system can be represented by This routine creates a matrix containing the statically condense system of the form
Definition at line 193 of file StdExpansion.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), GetBoundaryMap(), GetInteriorMap(), GetStdMatrix(), m_ncoeffs, and NumBndryCoeffs().
|
inline |
Definition at line 314 of file StdExpansion.h.
References v_DetCartesianDirOfEdge().
|
inline |
Definition at line 319 of file StdExpansion.h.
References v_DetEdgeBasisKey().
|
inline |
Definition at line 324 of file StdExpansion.h.
References v_DetFaceBasisKey().
Referenced by Nektar::LocalRegions::PyrExp::v_ComputeFaceNormal(), Nektar::LocalRegions::TetExp::v_ComputeFaceNormal(), Nektar::LocalRegions::PrismExp::v_ComputeFaceNormal(), and Nektar::LocalRegions::HexExp::v_ComputeFaceNormal().
|
inline |
This function returns the shape of the expansion domain.
This function is a wrapper around the virtual function v_DetShapeType()
The different shape types implemented in the code are defined in the ::ShapeType enumeration list. As a result, the function will return one of the types of this enumeration list.
Definition at line 470 of file StdExpansion.h.
References v_DetShapeType().
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), BwdTrans_MatOp(), Nektar::LocalRegions::PyrExp::CreateMatrix(), Nektar::LocalRegions::NodalTriExp::CreateMatrix(), Nektar::LocalRegions::PrismExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), Nektar::LocalRegions::TriExp::CreateMatrix(), Nektar::LocalRegions::SegExp::CreateMatrix(), Nektar::LocalRegions::HexExp::CreateMatrix(), EquiSpacedToCoeffs(), Nektar::LocalRegions::NodalTriExp::FwdTrans(), Nektar::LinearisedAdvection::GetFloquetBlockMatrix(), Nektar::AdjointAdvection::GetFloquetBlockMatrix(), Nektar::LocalRegions::Expansion::GetLocMatrix(), HelmholtzMatrixOp_MatFree_GenericImpl(), Nektar::LocalRegions::NodalTriExp::IProductWRTBase_MatOp(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_MatOp(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), Nektar::StdRegions::StdNodalPrismExp::ModalToNodal(), Nektar::StdRegions::StdNodalTriExp::ModalToNodal(), Nektar::LocalRegions::SegExp::MultiplyByElmtInvMass(), Nektar::StdRegions::StdNodalPrismExp::NodalToModal(), Nektar::StdRegions::StdNodalTriExp::NodalToModal(), Nektar::StdRegions::StdNodalPrismExp::NodalToModalTranspose(), Nektar::StdRegions::StdNodalTriExp::NodalToModalTranspose(), PhysInterpToSimplexEquiSpaced(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::LocalRegions::PrismExp::v_FwdTrans(), Nektar::LocalRegions::PyrExp::v_FwdTrans(), Nektar::StdRegions::StdNodalPrismExp::v_FwdTrans(), Nektar::StdRegions::StdNodalTriExp::v_FwdTrans(), Nektar::LocalRegions::SegExp::v_FwdTrans(), Nektar::LocalRegions::TriExp::v_FwdTrans(), Nektar::LocalRegions::QuadExp::v_FwdTrans(), Nektar::LocalRegions::HexExp::v_FwdTrans(), Nektar::StdRegions::StdTriExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::StdRegions::StdPrismExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans(), Nektar::StdRegions::StdPyrExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdTriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::LocalRegions::QuadExp::v_GetEdgeInterpVals(), Nektar::LocalRegions::SegExp::v_GetVertexPhysVals(), Nektar::LocalRegions::TriExp::v_IProductWRTBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_MatOp(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_MatOp(), and Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_MatOp().
|
inline |
Definition at line 752 of file StdExpansion.h.
References v_DropLocStaticCondMatrix().
|
inline |
Definition at line 1288 of file StdExpansion.h.
References v_EdgeNormalNegated().
void Nektar::StdRegions::StdExpansion::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.
This is primarily used for output purposes to use a more even distribution of points more suitable for alot of postprocessing
Definition at line 1806 of file StdExpansion.cpp.
References DetShapeType(), Nektar::StdRegions::eEquiSpacedToCoeffs, Nektar::StdRegions::eFactorConst, Nektar::eWrapper, GetStdMatrix(), m_base, and m_ncoeffs.
|
inline |
This function returns the maximum number of expansion modes over all local directions.
Definition at line 191 of file StdExpansion.h.
References m_base.
|
inline |
Definition at line 797 of file StdExpansion.h.
References v_ExtractDataToCoeffs().
|
inline |
Definition at line 1303 of file StdExpansion.h.
References v_FaceNormalNegated().
|
inline |
This function fills the array outarray with the mode-th mode of the expansion.
This function is a wrapper around the virtual function v_FillMode()
The requested mode is evaluated at the quadrature points
mode | the mode that should be filled |
outarray | contains the values of the mode-th mode of the expansion evaluated at the quadrature points (output of the function) |
Definition at line 592 of file StdExpansion.h.
References v_FillMode().
Referenced by CreateGeneralMatrix().
|
inline |
This function performs the Forward transformation from physical space to coefficient space.
This function is a wrapper around the virtual function v_FwdTrans()
Given a function evaluated at the quadrature points, this function calculates the expansion coefficients such that the resulting expansion approximates the original function.
The calculation of the expansion coefficients is done using a Galerkin projection. This is equivalent to the operation:
where
This function takes the array inarray as the values of the function evaluated at the quadrature points (i.e. ), and stores the resulting coefficients in the outarray
inarray | array of the function discretely evaluated at the quadrature points |
outarray | array of the function coefficieints |
Definition at line 1905 of file StdExpansion.h.
References v_FwdTrans().
Referenced by Nektar::Utilities::ProcessEquiSpacedOutput::GenOrthoModes(), Nektar::LocalRegions::Expansion2D::GetPhysEdgeVarCoeffsFromElement(), Nektar::SolverUtils::UpdateGeometry(), Nektar::StdRegions::StdPrismExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTetExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTriExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdPrismExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdQuadExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdTetExp::v_SVVLaplacianFilter(), and Nektar::StdRegions::StdHexExp::v_SVVLaplacianFilter().
|
inline |
Definition at line 538 of file StdExpansion.h.
References v_FwdTrans_BndConstrained().
void Nektar::StdRegions::StdExpansion::GeneralMatrixOp | ( | const Array< OneD, const NekDouble > & | inarray, |
Array< OneD, NekDouble > & | outarray, | ||
const StdMatrixKey & | mkey | ||
) |
Definition at line 530 of file StdExpansion.cpp.
References ErrorUtil::efatal, Nektar::StdRegions::eHelmholtz, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eLaplacian00, Nektar::StdRegions::eLaplacian01, Nektar::StdRegions::eLaplacian02, Nektar::StdRegions::eLaplacian10, Nektar::StdRegions::eLaplacian11, Nektar::StdRegions::eLaplacian12, Nektar::StdRegions::eLaplacian20, Nektar::StdRegions::eLaplacian21, Nektar::StdRegions::eLaplacian22, Nektar::StdRegions::eLinearAdvectionDiffusionReaction, Nektar::StdRegions::eLinearAdvectionReaction, Nektar::StdRegions::eMass, Nektar::StdRegions::eMassLevelCurvature, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::StdRegions::eWeakDirectionalDeriv, Nektar::StdRegions::StdMatrixKey::GetMatrixType(), HelmholtzMatrixOp(), LaplacianMatrixOp(), LinearAdvectionDiffusionReactionMatrixOp(), MassLevelCurvatureMatrixOp(), MassMatrixOp(), NEKERROR, WeakDerivMatrixOp(), and WeakDirectionalDerivMatrixOp().
|
protected |
Definition at line 599 of file StdExpansion.cpp.
References ErrorUtil::efatal, Nektar::StdRegions::eHelmholtz, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eLaplacian00, Nektar::StdRegions::eLaplacian01, Nektar::StdRegions::eLaplacian02, Nektar::StdRegions::eLaplacian10, Nektar::StdRegions::eLaplacian11, Nektar::StdRegions::eLaplacian12, Nektar::StdRegions::eLaplacian20, Nektar::StdRegions::eLaplacian21, Nektar::StdRegions::eLaplacian22, Nektar::StdRegions::eLinearAdvectionDiffusionReaction, Nektar::StdRegions::eLinearAdvectionReaction, Nektar::StdRegions::eMass, Nektar::StdRegions::eMassLevelCurvature, Nektar::StdRegions::eWeakDeriv0, Nektar::StdRegions::eWeakDeriv1, Nektar::StdRegions::eWeakDeriv2, Nektar::StdRegions::eWeakDirectionalDeriv, Nektar::StdRegions::StdMatrixKey::GetMatrixType(), HelmholtzMatrixOp_MatFree(), LaplacianMatrixOp_MatFree(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), MassLevelCurvatureMatrixOp_MatFree(), MassMatrixOp_MatFree(), NEKERROR, WeakDerivMatrixOp_MatFree(), and WeakDirectionalDerivMatrixOp_MatFree().
Referenced by CreateGeneralMatrix().
|
inline |
Definition at line 1049 of file StdExpansion.h.
References v_GenMatrix().
Referenced by Nektar::LocalRegions::PyrExp::CreateMatrix(), Nektar::LocalRegions::NodalTriExp::CreateMatrix(), Nektar::LocalRegions::TetExp::CreateMatrix(), Nektar::LocalRegions::PrismExp::CreateMatrix(), Nektar::LocalRegions::TriExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), Nektar::LocalRegions::SegExp::CreateMatrix(), Nektar::LocalRegions::HexExp::CreateMatrix(), and Nektar::StdRegions::StdQuadExp::v_CreateStdMatrix().
|
inline |
This function gets the shared point to basis.
Definition at line 107 of file StdExpansion.h.
References m_base.
|
inline |
This function gets the shared point to basis in the dir direction.
Definition at line 118 of file StdExpansion.h.
References ASSERTL1, and m_base.
Referenced by Nektar::StdRegions::StdQuadExp::v_DetEdgeBasisKey(), Nektar::StdRegions::StdTriExp::v_DetEdgeBasisKey(), and Nektar::LocalRegions::SegExp::v_GetBasis().
|
inline |
This function returns the number of expansion modes in the dir direction.
dir | the direction |
Definition at line 178 of file StdExpansion.h.
References ASSERTL1, and m_base.
Referenced by Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GetEdgeNcoeffs(), Nektar::StdRegions::StdTriExp::v_GetEdgeNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetEdgeNcoeffs(), Nektar::StdRegions::StdHexExp::v_GetEdgeNcoeffs(), Nektar::StdRegions::StdPyrExp::v_GetEdgeNcoeffs(), Nektar::StdRegions::StdHexExp::v_GetFaceIntNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetFaceIntNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetFaceNcoeffs(), Nektar::StdRegions::StdHexExp::v_GetFaceNcoeffs(), Nektar::StdRegions::StdTetExp::v_GetFaceNcoeffs(), Nektar::StdRegions::StdPyrExp::v_GetFaceNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetTotalEdgeIntNcoeffs(), Nektar::StdRegions::StdHexExp::v_GetTotalEdgeIntNcoeffs(), Nektar::StdRegions::StdHexExp::v_GetTotalFaceIntNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetTotalFaceIntNcoeffs(), Nektar::StdRegions::StdNodalTriExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdTriExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdQuadExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdTriExp::v_NumDGBndryCoeffs(), and Nektar::StdRegions::StdQuadExp::v_NumDGBndryCoeffs().
|
inline |
This function returns the type of basis used in the dir direction.
The different types of bases implemented in the code are defined in the LibUtilities::BasisType enumeration list. As a result, the function will return one of the types of this enumeration list.
dir | the direction |
Definition at line 165 of file StdExpansion.h.
References ASSERTL1, and m_base.
Referenced by Nektar::LocalRegions::SegExp::ReverseCoeffsAndSign(), Nektar::StdRegions::StdHexExp::v_BwdTrans(), Nektar::StdRegions::StdPrismExp::v_BwdTrans(), Nektar::StdRegions::StdTetExp::v_BwdTrans(), Nektar::StdRegions::StdTriExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdPrismExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdTetExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdTriExp::v_DetEdgeBasisKey(), Nektar::StdRegions::StdPrismExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdHexExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdTetExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdPyrExp::v_DetFaceBasisKey(), Nektar::LocalRegions::TetExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::PrismExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::HexExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::TriExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::QuadExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::SegExp::v_ExtractDataToCoeffs(), Nektar::StdRegions::StdTriExp::v_FillMode(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GetBoundaryMap(), Nektar::StdRegions::StdQuadExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTriExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPrismExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTetExp::v_GetBoundaryMap(), Nektar::StdRegions::StdHexExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPyrExp::v_GetBoundaryMap(), Nektar::StdRegions::StdQuadExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdTriExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdPrismExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdHexExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdTetExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdPyrExp::v_GetEdgeBasisType(), Nektar::StdRegions::StdHexExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetFaceInteriorMap(), Nektar::StdRegions::StdSegExp::v_GetInteriorMap(), Nektar::StdRegions::StdQuadExp::v_GetInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetInteriorMap(), Nektar::StdRegions::StdPyrExp::v_GetInteriorMap(), Nektar::StdRegions::StdSegExp::v_GetVertexMap(), Nektar::StdRegions::StdQuadExp::v_GetVertexMap(), Nektar::StdRegions::StdHexExp::v_GetVertexMap(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdQuadExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdPrismExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdHexExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdSegExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdTetExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdTriExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdQuadExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdPrismExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdHexExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdTetExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdPyrExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdTriExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdQuadExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdPrismExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdHexExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdTetExp::v_NumDGBndryCoeffs(), Nektar::LocalRegions::HexExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTriExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdQuadExp::v_ReduceOrderCoeffs(), Nektar::LocalRegions::TriExp::v_ReduceOrderCoeffs(), and Nektar::LocalRegions::QuadExp::v_ReduceOrderCoeffs().
|
inline |
Definition at line 816 of file StdExpansion.h.
References v_GetBoundaryMap().
Referenced by Nektar::LocalRegions::PyrExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TetExp::CreateStaticCondMatrix(), Nektar::LocalRegions::PrismExp::CreateStaticCondMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::SegExp::CreateStaticCondMatrix(), Nektar::LocalRegions::HexExp::CreateStaticCondMatrix(), CreateStdStaticCondMatrix(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), and Nektar::LocalRegions::Expansion2D::v_GetEdgeInverseBoundaryMap().
|
inline |
Definition at line 772 of file StdExpansion.h.
References v_GetCartesianEorient().
Referenced by Nektar::LocalRegions::QuadExp::v_GetEdgePhysVals(), and Nektar::LocalRegions::TriExp::v_GetEdgePhysVals().
|
inline |
given the coordinates of a point of the element in the local collapsed coordinate system, this function calculates the physical coordinates of the point
This function is a wrapper around the virtual function v_GetCoord()
Lcoords | the coordinates in the local collapsed coordinate system |
coords | the physical coordinates (output of the function) |
Definition at line 694 of file StdExpansion.h.
References v_GetCoord().
|
inline |
Definition at line 811 of file StdExpansion.h.
References v_GetCoordim().
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), LaplacianMatrixOp_MatFree(), LaplacianMatrixOp_MatFree_GenericImpl(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::LocalRegions::QuadExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::TriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::NodalTriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::PyrExp::v_ComputeFaceNormal(), Nektar::LocalRegions::TetExp::v_ComputeFaceNormal(), Nektar::LocalRegions::PrismExp::v_ComputeFaceNormal(), Nektar::LocalRegions::HexExp::v_ComputeFaceNormal(), Nektar::LocalRegions::TriExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::SegExp::v_ComputeVertexNormal(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::LocalRegions::PointExp::v_GetCoords(), Nektar::LocalRegions::Expansion2D::v_NegateEdgeNormal(), and Nektar::StdRegions::StdExpansion3D::v_NegateFaceNormal().
|
inline |
this function returns the physical coordinates of the quadrature points of the expansion
This function is a wrapper around the virtual function v_GetCoords()
coords | an array containing the coordinates of the quadrature points (output of the function) |
Definition at line 676 of file StdExpansion.h.
References v_GetCoords().
Referenced by main().
|
inline |
This function returns the type of expansion basis on the i-th edge.
This function is a wrapper around the virtual function v_GetEdgeBasisType()
The different types of bases implemented in the code are defined in the LibUtilities::BasisType enumeration list. As a result, the function will return one of the types of this enumeration list.
i | specifies which edge |
Definition at line 413 of file StdExpansion.h.
References v_GetEdgeBasisType().
Referenced by Nektar::StdRegions::StdQuadExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetEdgeToElementMap(), Nektar::StdRegions::StdQuadExp::v_GetEdgeToElementMap(), Nektar::StdRegions::StdPrismExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdHexExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdPyrExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdTriExp::v_GetVertexMap(), Nektar::StdRegions::StdPrismExp::v_GetVertexMap(), Nektar::StdRegions::StdTetExp::v_GetVertexMap(), and Nektar::StdRegions::StdPyrExp::v_GetVertexMap().
|
inline |
Definition at line 832 of file StdExpansion.h.
References v_GetEdgeInteriorMap().
Referenced by Nektar::LocalRegions::Expansion2D::v_GetEdgeInverseBoundaryMap().
|
inline |
Definition at line 898 of file StdExpansion.h.
References v_GetEdgeInterpVals().
|
inline |
Definition at line 1339 of file StdExpansion.h.
References v_GetEdgeInverseBoundaryMap().
|
inline |
This function returns the number of expansion coefficients belonging to the i-th edge.
This function is a wrapper around the virtual function v_GetEdgeNcoeffs()
i | specifies which edge |
Definition at line 287 of file StdExpansion.h.
References v_GetEdgeNcoeffs().
Referenced by Nektar::CoupledLocalToGlobalC0ContMap::CoupledLocalToGlobalC0ContMap(), Nektar::LocalRegions::Expansion2D::SetTraceToGeomOrientation(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), Nektar::MultiRegions::PreconditionerLowEnergy::v_BuildPreconditioner(), Nektar::StdRegions::StdNodalTriExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdQuadExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetEdgeInteriorMap(), Nektar::LocalRegions::Expansion2D::v_GetEdgeInverseBoundaryMap(), Nektar::StdRegions::StdNodalTriExp::v_GetEdgeToElementMap(), and Nektar::StdRegions::StdExpansion2D::v_GetTraceNcoeffs().
|
inline |
Definition at line 1273 of file StdExpansion.h.
References v_GetEdgeNormal().
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), Nektar::LocalRegions::Expansion2D::AddNormTraceInt(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), and Nektar::LocalRegions::SegExp::v_NormVectorIProductWRTBase().
|
inline |
This function returns the number of quadrature points belonging to the i-th edge.
This function is a wrapper around the virtual function v_GetEdgeNumPoints()
i | specifies which edge |
Definition at line 308 of file StdExpansion.h.
References v_GetEdgeNumPoints().
|
inline |
Definition at line 928 of file StdExpansion.h.
References v_GetEdgePhysMap().
|
inline |
Extract the physical values along edge edge from inarray into outarray following the local edge orientation and point distribution defined by defined in EdgeExp.
Definition at line 871 of file StdExpansion.h.
References v_GetEdgePhysVals().
Referenced by Nektar::MultiRegions::DisContField3DHomogeneous1D::GetBCValues().
|
inline |
Definition at line 878 of file StdExpansion.h.
References v_GetEdgePhysVals().
|
inline |
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).
Definition at line 911 of file StdExpansion.h.
References v_GetEdgeQFactors().
|
inline |
Definition at line 846 of file StdExpansion.h.
References v_GetEdgeToElementMap().
Referenced by Nektar::LocalRegions::Expansion2D::AddEdgeBoundaryInt(), Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), Nektar::LocalRegions::Expansion2D::GetPhysEdgeVarCoeffsFromElement(), Nektar::LocalRegions::Expansion2D::v_AddRobinEdgeContribution(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), and Nektar::LocalRegions::Expansion2D::v_GenMatrix().
|
inline |
Get the element id of this expansion when used in a list by returning value of m_elmt_id.
Definition at line 654 of file StdExpansion.h.
References m_elmt_id.
|
inline |
Definition at line 762 of file StdExpansion.h.
References v_GetEorient().
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), Nektar::LocalRegions::Expansion2D::GetPhysEdgeVarCoeffsFromElement(), Nektar::LocalRegions::Expansion2D::SetTraceToGeomOrientation(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), Nektar::LocalRegions::QuadExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::TriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::LocalRegions::QuadExp::v_GetEdgePhysVals(), and Nektar::LocalRegions::TriExp::v_GetEdgePhysVals().
|
inline |
Definition at line 839 of file StdExpansion.h.
References v_GetFaceInteriorMap().
|
inline |
Definition at line 359 of file StdExpansion.h.
References v_GetFaceIntNcoeffs().
Referenced by Nektar::MultiRegions::PreconditionerLowEnergy::v_BuildPreconditioner(), and Nektar::StdRegions::StdHexExp::v_GetFaceInteriorMap().
|
inline |
Definition at line 1345 of file StdExpansion.h.
References v_GetFaceInverseBoundaryMap().
|
inline |
This function returns the number of expansion coefficients belonging to the i-th face.
This function is a wrapper around the virtual function v_GetFaceNcoeffs()
i | specifies which face |
Definition at line 354 of file StdExpansion.h.
References v_GetFaceNcoeffs().
Referenced by Nektar::StdRegions::StdPrismExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdPyrExp::v_GetFaceToElementMap(), and Nektar::StdRegions::StdExpansion3D::v_GetTraceNcoeffs().
|
inline |
Definition at line 1313 of file StdExpansion.h.
References v_GetFaceNormal().
|
inline |
This function returns the number of quadrature points belonging to the i-th face.
This function is a wrapper around the virtual function v_GetFaceNumPoints()
i | specifies which face |
Definition at line 339 of file StdExpansion.h.
References v_GetFaceNumPoints().
|
inline |
Definition at line 935 of file StdExpansion.h.
References v_GetFacePhysMap().
|
inline |
Definition at line 918 of file StdExpansion.h.
References v_GetFacePhysVals().
|
inline |
Definition at line 385 of file StdExpansion.h.
References v_GetFacePointsKey().
|
inline |
Definition at line 855 of file StdExpansion.h.
References v_GetFaceToElementMap().
|
inline |
Definition at line 757 of file StdExpansion.h.
References v_GetForient().
|
inline |
Definition at line 710 of file StdExpansion.h.
References m_IndexMapManager.
|
inline |
Definition at line 821 of file StdExpansion.h.
References v_GetInteriorMap().
Referenced by Nektar::LocalRegions::PyrExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TetExp::CreateStaticCondMatrix(), Nektar::LocalRegions::PrismExp::CreateStaticCondMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::SegExp::CreateStaticCondMatrix(), Nektar::LocalRegions::HexExp::CreateStaticCondMatrix(), CreateStdStaticCondMatrix(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), and Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained().
|
inline |
Definition at line 747 of file StdExpansion.h.
References v_GetLocStaticCondMatrix().
Referenced by Nektar::LocalRegions::TetExp::CreateMatrix(), Nektar::LocalRegions::PrismExp::CreateMatrix(), Nektar::LocalRegions::TriExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), and Nektar::LocalRegions::HexExp::CreateMatrix().
|
inline |
Definition at line 1179 of file StdExpansion.h.
References v_GetMetricInfo().
Referenced by Nektar::SolverUtils::DiffusionLFR::v_DerCFlux_1D(), Nektar::SolverUtils::DiffusionLFRNS::v_DerCFlux_1D(), Nektar::SolverUtils::DiffusionLFR::v_DerCFlux_2D(), Nektar::SolverUtils::DiffusionLFRNS::v_DerCFlux_2D(), Nektar::SolverUtils::AdvectionFR::v_SetupMetrics(), Nektar::SolverUtils::DiffusionLFR::v_SetupMetrics(), and Nektar::SolverUtils::DiffusionLFRNS::v_SetupMetrics().
|
inline |
This function returns the total number of coefficients used in the expansion.
Definition at line 131 of file StdExpansion.h.
References m_ncoeffs.
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzEdgeTerms(), Nektar::CoupledLocalToGlobalC0ContMap::CoupledLocalToGlobalC0ContMap(), Nektar::LocalRegions::Expansion2D::GetPhysEdgeVarCoeffsFromElement(), LaplacianMatrixOp_MatFree(), Nektar::LocalRegions::Expansion2D::v_AddRobinEdgeContribution(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), Nektar::LocalRegions::Expansion2D::v_DGDeriv(), Nektar::LocalRegions::TetExp::v_FwdTrans(), Nektar::LocalRegions::PrismExp::v_FwdTrans(), Nektar::LocalRegions::PyrExp::v_FwdTrans(), Nektar::LocalRegions::HexExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GetBoundaryMap(), Nektar::StdRegions::StdNodalTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdSegExp::v_GetInteriorMap(), Nektar::StdRegions::StdQuadExp::v_GetInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdTriExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdPrismExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdQuadExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdTetExp::v_SVVLaplacianFilter(), and Nektar::StdRegions::StdHexExp::v_SVVLaplacianFilter().
|
inline |
This function returns the number of edges of the expansion domain.
This function is a wrapper around the virtual function v_GetNedges()
Definition at line 272 of file StdExpansion.h.
References v_GetNedges().
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzTraceTerms(), Nektar::LocalRegions::Expansion2D::AddNormTraceInt(), Nektar::MultiRegions::ExpList1D::ExpList1D(), Nektar::LocalRegions::Expansion2D::GetEdgeExp(), GetNtrace(), Nektar::LocalRegions::Expansion2D::SetEdgeExp(), Nektar::LocalRegions::Expansion2D::SetTraceToGeomOrientation(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), and Nektar::LocalRegions::Expansion2D::v_GenMatrix().
|
inline |
This function returns the number of faces of the expansion domain.
This function is a wrapper around the virtual function v_GetNFaces()
Definition at line 438 of file StdExpansion.h.
References v_GetNfaces().
Referenced by Nektar::MultiRegions::ExpList2D::ExpList2D(), and GetNtrace().
|
inline |
This function returns the type of expansion Nodal point type if defined.
This function is a wrapper around the virtual function v_GetNodalPointsKey()
Definition at line 425 of file StdExpansion.h.
References v_GetNodalPointsKey().
|
inline |
Returns the number of trace elements connected to this element.
For example, a quadrilateral has four edges, so this function would return 4.
Definition at line 450 of file StdExpansion.h.
References GetNedges(), GetNfaces(), and m_base.
|
inline |
This function returns the number of 1D bases used in the expansion.
Definition at line 98 of file StdExpansion.h.
References m_base.
|
inline |
This function returns the number of quadrature points in the dir direction.
dir | the direction |
Definition at line 229 of file StdExpansion.h.
References ASSERTL1, and m_base.
Referenced by Nektar::StdRegions::StdHexExp::v_BwdTrans(), Nektar::StdRegions::StdQuadExp::v_BwdTrans(), Nektar::StdRegions::StdPrismExp::v_BwdTrans(), Nektar::StdRegions::StdTetExp::v_BwdTrans(), Nektar::StdRegions::StdPyrExp::v_BwdTrans(), Nektar::StdRegions::StdHexExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdTriExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdQuadExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdTriExp::v_DetEdgeBasisKey(), Nektar::StdRegions::StdPrismExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdHexExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdTetExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdPyrExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdPointExp::v_GetCoords(), Nektar::StdRegions::StdPrismExp::v_GetCoords(), Nektar::StdRegions::StdTetExp::v_GetCoords(), Nektar::StdRegions::StdSegExp::v_GetCoords(), Nektar::StdRegions::StdTriExp::v_GetCoords(), Nektar::StdRegions::StdQuadExp::v_GetCoords(), Nektar::StdRegions::StdPyrExp::v_GetCoords(), Nektar::StdRegions::StdHexExp::v_GetCoords(), Nektar::StdRegions::StdQuadExp::v_GetEdgeNumPoints(), Nektar::StdRegions::StdTriExp::v_GetEdgeNumPoints(), Nektar::LocalRegions::SegExp::v_GetNumPoints(), Nektar::LocalRegions::TriExp::v_GetNumPoints(), and Nektar::LocalRegions::QuadExp::v_GetNumPoints().
|
inline |
This function returns the number of vertices of the expansion domain.
This function is a wrapper around the virtual function v_GetNverts()
Definition at line 259 of file StdExpansion.h.
References v_GetNverts().
Referenced by Nektar::LocalRegions::Expansion2D::v_BuildVertexMatrix().
|
inline |
Definition at line 715 of file StdExpansion.h.
References v_GetPhysNormals().
|
inline |
This function returns a pointer to the array containing the quadrature points in dir direction.
dir | the direction |
Definition at line 243 of file StdExpansion.h.
References m_base.
|
inline |
Definition at line 1328 of file StdExpansion.h.
References m_base.
Referenced by Nektar::LocalRegions::Expansion::ComputeQuadratureMetric(), Nektar::LocalRegions::PyrExp::CreateMatrix(), Nektar::LocalRegions::NodalTriExp::CreateMatrix(), Nektar::LocalRegions::TetExp::CreateMatrix(), Nektar::LocalRegions::PrismExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), Nektar::LocalRegions::TriExp::CreateMatrix(), Nektar::LocalRegions::SegExp::CreateMatrix(), Nektar::LocalRegions::HexExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::Integral(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::PhysDeriv(), Nektar::LocalRegions::QuadExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::TriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::NodalTriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::PyrExp::v_ComputeFaceNormal(), Nektar::LocalRegions::TetExp::v_ComputeFaceNormal(), Nektar::LocalRegions::PrismExp::v_ComputeFaceNormal(), Nektar::LocalRegions::HexExp::v_ComputeFaceNormal(), Nektar::LocalRegions::PyrExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TetExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::HexExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TriExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::QuadExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::SegExp::v_ComputeVertexNormal(), Nektar::LocalRegions::QuadExp::v_GetEdgeQFactors(), Nektar::LocalRegions::SegExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::SegExp::v_Integral(), Nektar::LocalRegions::PrismExp::v_Integral(), Nektar::LocalRegions::TetExp::v_Integral(), Nektar::LocalRegions::PyrExp::v_Integral(), Nektar::LocalRegions::TriExp::v_Integral(), Nektar::LocalRegions::QuadExp::v_Integral(), Nektar::LocalRegions::HexExp::v_Integral(), Nektar::LocalRegions::PyrExp::v_IProductWRTBase(), Nektar::LocalRegions::SegExp::v_IProductWRTBase(), Nektar::LocalRegions::TetExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::SegExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::PrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::SegExp::v_LaplacianMatrixOp(), Nektar::LocalRegions::PrismExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::SegExp::v_PhysDeriv(), Nektar::LocalRegions::TetExp::v_PhysDeriv(), Nektar::LocalRegions::PrismExp::v_PhysDeriv(), Nektar::LocalRegions::PyrExp::v_PhysDeriv(), Nektar::LocalRegions::TriExp::v_PhysDeriv(), Nektar::LocalRegions::QuadExp::v_PhysDeriv(), Nektar::LocalRegions::HexExp::v_PhysDeriv(), Nektar::LocalRegions::SegExp::v_PhysDeriv_n(), Nektar::LocalRegions::SegExp::v_PhysDeriv_s(), Nektar::LocalRegions::TriExp::v_PhysDirectionalDeriv(), Nektar::LocalRegions::QuadExp::v_PhysDirectionalDeriv(), Nektar::LocalRegions::TetExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::PrismExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::HexExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::TriExp::v_SVVLaplacianFilter(), and Nektar::LocalRegions::QuadExp::v_SVVLaplacianFilter().
|
inline |
This function returns the type of quadrature points used in the dir direction.
The different types of quadrature points implemented in the code are defined in the LibUtilities::PointsType enumeration list. As a result, the function will return one of the types of this enumeration list.
dir | the direction |
Definition at line 216 of file StdExpansion.h.
References ASSERTL1, and m_base.
Referenced by Nektar::LocalRegions::QuadExp::v_ComputeEdgeNormal(), Nektar::StdRegions::StdTriExp::v_DetEdgeBasisKey(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_GetEdgePhysVals(), Nektar::LocalRegions::QuadExp::v_GetEdgeQFactors(), Nektar::LocalRegions::SegExp::v_GetVertexPhysVals(), Nektar::StdRegions::StdTriExp::v_Integral(), Nektar::StdRegions::StdPyrExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdPrismExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdTetExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdTriExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdTriExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdPrismExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdQuadExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdTetExp::v_SVVLaplacianFilter(), and Nektar::StdRegions::StdHexExp::v_SVVLaplacianFilter().
|
inline |
Definition at line 767 of file StdExpansion.h.
References v_GetPorient().
|
inline |
Definition at line 481 of file StdExpansion.h.
References v_GetShapeDimension().
|
inline |
This function provides the connectivity of local simplices (triangles or tets) to connect the equispaced data points provided by PhysInterpToSimplexEquiSpaced.
This is a virtual call to the function v_GetSimplexEquiSpaceConnectivity
Definition at line 1381 of file StdExpansion.h.
References v_GetSimplexEquiSpacedConnectivity().
|
inline |
Definition at line 475 of file StdExpansion.h.
References v_GetStdExp().
|
inline |
Definition at line 700 of file StdExpansion.h.
References m_stdMatrixManager.
Referenced by BwdTrans_MatOp(), CreateGeneralMatrix(), Nektar::LocalRegions::PyrExp::CreateMatrix(), Nektar::LocalRegions::NodalTriExp::CreateMatrix(), Nektar::LocalRegions::TetExp::CreateMatrix(), Nektar::LocalRegions::PrismExp::CreateMatrix(), Nektar::LocalRegions::TriExp::CreateMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), Nektar::LocalRegions::SegExp::CreateMatrix(), Nektar::LocalRegions::HexExp::CreateMatrix(), CreateStdStaticCondMatrix(), EquiSpacedToCoeffs(), Nektar::LinearisedAdvection::GetFloquetBlockMatrix(), Nektar::AdjointAdvection::GetFloquetBlockMatrix(), Nektar::StdRegions::StdNodalPrismExp::ModalToNodal(), Nektar::StdRegions::StdNodalTetExp::ModalToNodal(), Nektar::StdRegions::StdNodalTriExp::ModalToNodal(), Nektar::StdRegions::StdNodalPrismExp::NodalToModal(), Nektar::StdRegions::StdNodalTetExp::NodalToModal(), Nektar::StdRegions::StdNodalTriExp::NodalToModal(), Nektar::StdRegions::StdNodalPrismExp::NodalToModalTranspose(), Nektar::StdRegions::StdNodalTetExp::NodalToModalTranspose(), Nektar::StdRegions::StdNodalTriExp::NodalToModalTranspose(), PhysInterpToSimplexEquiSpaced(), Nektar::StdRegions::StdPointExp::v_FwdTrans(), Nektar::StdRegions::StdNodalTetExp::v_FwdTrans(), Nektar::StdRegions::StdNodalPrismExp::v_FwdTrans(), Nektar::StdRegions::StdNodalTriExp::v_FwdTrans(), Nektar::StdRegions::StdTriExp::v_FwdTrans(), Nektar::StdRegions::StdSegExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans(), Nektar::StdRegions::StdPrismExp::v_FwdTrans(), Nektar::StdRegions::StdTetExp::v_FwdTrans(), Nektar::StdRegions::StdPyrExp::v_FwdTrans(), Nektar::StdRegions::StdPointExp::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GenMatrix(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_MatOp(), and Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_MatOp().
|
inline |
Definition at line 705 of file StdExpansion.h.
References m_stdStaticCondMatrixManager.
Referenced by Nektar::LocalRegions::PyrExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TetExp::CreateStaticCondMatrix(), Nektar::LocalRegions::PrismExp::CreateStaticCondMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::SegExp::CreateStaticCondMatrix(), and Nektar::LocalRegions::HexExp::CreateStaticCondMatrix().
|
inline |
Definition at line 1323 of file StdExpansion.h.
References v_GetSurfaceNormal().
|
inline |
Definition at line 293 of file StdExpansion.h.
References v_GetTotalEdgeIntNcoeffs().
|
inline |
Definition at line 364 of file StdExpansion.h.
References v_GetTotalFaceIntNcoeffs().
|
inline |
This function returns the total number of quadrature points used in the element.
Definition at line 141 of file StdExpansion.h.
References m_base.
Referenced by Nektar::LocalRegions::Expansion2D::AddHDGHelmholtzTraceTerms(), BwdTrans_MatOp(), Nektar::LocalRegions::Expansion::ComputeQuadratureMetric(), CreateGeneralMatrix(), Nektar::StdRegions::StdNodalPrismExp::GenNBasisTransMatrix(), Nektar::StdRegions::StdNodalTetExp::GenNBasisTransMatrix(), Nektar::StdRegions::StdNodalTriExp::GenNBasisTransMatrix(), Nektar::CFLtester::GetStdVelocity(), H1(), Nektar::LocalRegions::NodalTriExp::IProductWRTBase_MatOp(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_MatOp(), L2(), LaplacianMatrixOp_MatFree(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), Linf(), main(), MassMatrixOp_MatFree(), PhysInterpToSimplexEquiSpaced(), Nektar::StdRegions::StdExpansion0D::PhysTensorDeriv(), Nektar::StdRegions::StdExpansion1D::PhysTensorDeriv(), Nektar::Utilities::ProcessDisplacement::Process(), Nektar::Utilities::ProcessScalGrad::Process(), Nektar::StdRegions::StdMatrixKey::StdMatrixKey(), Nektar::FilterMovingBody::UpdateForce(), Nektar::LocalRegions::PyrExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TetExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::HexExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TriExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::QuadExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::StdRegions::StdExpansion3D::v_Integral(), Nektar::LocalRegions::TriExp::v_IProductWRTBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_MatOp(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdExpansion3D::v_LaplacianMatrixOp_MatFree(), Nektar::LocalRegions::Expansion::v_MultiplyByQuadratureMetric(), Nektar::LocalRegions::PrismExp::v_PhysDeriv(), Nektar::StdRegions::StdExpansion0D::v_PhysEvaluate(), Nektar::StdRegions::StdExpansion1D::v_PhysEvaluate(), Nektar::LocalRegions::TetExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::PrismExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::HexExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::TriExp::v_SVVLaplacianFilter(), Nektar::LocalRegions::QuadExp::v_SVVLaplacianFilter(), WeakDerivMatrixOp_MatFree(), and WeakDirectionalDerivMatrixOp_MatFree().
|
inline |
This function returns the number of expansion coefficients belonging to the i-th edge/face.
This function is a wrapper around the virtual function v_GetTraceNcoeffs()
i | specifies which edge/face |
Definition at line 379 of file StdExpansion.h.
References v_GetTraceNcoeffs().
|
inline |
Definition at line 886 of file StdExpansion.h.
References v_GetTracePhysVals().
|
inline |
Definition at line 826 of file StdExpansion.h.
References v_GetVertexMap().
Referenced by Nektar::CoupledLocalToGlobalC0ContMap::CoupledLocalToGlobalC0ContMap(), Nektar::LocalRegions::Expansion2D::v_BuildVertexMatrix(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), and Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained().
|
inline |
Definition at line 1318 of file StdExpansion.h.
References v_GetVertexNormal().
Referenced by Nektar::LocalRegions::PointExp::v_NormVectorIProductWRTBase().
|
inline |
Definition at line 891 of file StdExpansion.h.
References v_GetVertexPhysVals().
NekDouble Nektar::StdRegions::StdExpansion::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.
This function takes the physical value space array m_phys as approximate solution
sol | array of solution function at physical quadrature points |
Definition at line 158 of file StdExpansion.cpp.
References GetTotPoints(), Nektar::NullNekDouble1DArray, v_GetCoordim(), v_Integral(), v_PhysDeriv(), Vmath::Vcopy(), Vmath::Vmul(), Vmath::Vsub(), and Vmath::Vvtvp().
|
inline |
inarray | Input array . |
outarray | Output array . |
mkey |
Definition at line 1042 of file StdExpansion.h.
References v_HelmholtzMatrixOp().
Referenced by GeneralMatrixOp().
|
inlineprotected |
Definition at line 1531 of file StdExpansion.h.
References v_HelmholtzMatrixOp_MatFree().
Referenced by GeneralMatrixOp_MatFree(), Nektar::LocalRegions::TriExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::QuadExp::v_HelmholtzMatrixOp(), and v_HelmholtzMatrixOp().
|
protected |
Definition at line 936 of file StdExpansion.cpp.
References DetShapeType(), Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eMass, Nektar::StdRegions::StdMatrixKey::GetConstFactor(), LaplacianMatrixOp(), m_ncoeffs, and MassMatrixOp().
Referenced by Nektar::StdRegions::StdNodalTriExp::v_HelmholtzMatrixOp(), Nektar::StdRegions::StdExpansion2D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree(), and v_HelmholtzMatrixOp_MatFree().
|
inline |
This function integrates the specified function over the domain.
This function is a wrapper around the virtual function v_Integral()
Based on the values of the function evaluated at the quadrature points (which are stored in inarray), this function calculates the integral of this function over the domain. This is equivalent to the numerical evaluation of the operation
inarray | values of the function to be integrated evaluated at the quadrature points (i.e. inarray[m]= ) |
Inputs:\n
Outputs:
Definition at line 574 of file StdExpansion.h.
References v_Integral().
|
inline |
this function calculates the inner product of a given function f with the different modes of the expansion
This function is a wrapper around the virtual function v_IProductWRTBase()
This is equivalent to the numerical evaluation of
where
which can be implemented as
inarray | contains the values of the function f evaluated at the quadrature points |
outarray | contains the values of the inner product of f with the different modes, i.e. (output of the function) |
Definition at line 629 of file StdExpansion.h.
References v_IProductWRTBase().
Referenced by Nektar::LocalRegions::TetExp::v_FwdTrans(), Nektar::LocalRegions::TriExp::v_FwdTrans(), Nektar::LocalRegions::QuadExp::v_FwdTrans(), Nektar::LocalRegions::HexExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::LocalRegions::TriExp::v_NormVectorIProductWRTBase(), and Nektar::LocalRegions::QuadExp::v_NormVectorIProductWRTBase().
|
inline |
Definition at line 635 of file StdExpansion.h.
References v_IProductWRTBase().
|
inline |
Definition at line 1414 of file StdExpansion.h.
References v_IProductWRTBase_SumFac().
Referenced by CreateGeneralMatrix(), Nektar::LocalRegions::TriExp::v_IProductWRTBase(), and Nektar::LocalRegions::QuadExp::v_IProductWRTBase().
|
inline |
Definition at line 645 of file StdExpansion.h.
References v_IProductWRTDerivBase().
|
inlineprotected |
Definition at line 1467 of file StdExpansion.h.
References v_IProductWRTDerivBase_SumFac().
Referenced by CreateGeneralMatrix(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase(), and Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase().
|
inline |
Definition at line 486 of file StdExpansion.h.
References v_IsBoundaryInteriorExpansion().
Referenced by Nektar::LocalRegions::Expansion2D::v_AddRobinEdgeContribution(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), and Nektar::LocalRegions::Expansion2D::v_GenMatrix().
|
inline |
Definition at line 492 of file StdExpansion.h.
References v_IsNodalNonTensorialExp().
NekDouble Nektar::StdRegions::StdExpansion::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.
This function takes the physical value space array m_phys as approximate solution
sol | array of solution function at physical quadrature points |
Definition at line 128 of file StdExpansion.cpp.
References GetTotPoints(), Nektar::NekConstants::kNekSqrtTol, v_Integral(), Vmath::Vmul(), and Vmath::Vsub().
|
inline |
Definition at line 978 of file StdExpansion.h.
References v_LaplacianMatrixOp().
Referenced by GeneralMatrixOp(), HelmholtzMatrixOp_MatFree_GenericImpl(), LaplacianMatrixOp_MatFree_GenericImpl(), and LinearAdvectionDiffusionReactionMatrixOp_MatFree().
|
inline |
Definition at line 998 of file StdExpansion.h.
References v_LaplacianMatrixOp().
|
inlineprotected |
Definition at line 1489 of file StdExpansion.h.
References v_LaplacianMatrixOp_MatFree().
Referenced by GeneralMatrixOp_MatFree(), Nektar::LocalRegions::PrismExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdNodalTriExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdQuadExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdTriExp::v_LaplacianMatrixOp(), Nektar::LocalRegions::TriExp::v_LaplacianMatrixOp(), Nektar::LocalRegions::QuadExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdHexExp::v_LaplacianMatrixOp(), and v_LaplacianMatrixOp().
|
protected |
Definition at line 685 of file StdExpansion.cpp.
References ASSERTL1, Nektar::StdRegions::StdMatrixKey::ConstFactorExists(), Nektar::StdRegions::eFactorSVVDiffCoeff, Nektar::StdRegions::eVarCoeffD00, Nektar::StdRegions::eVarCoeffD01, Nektar::StdRegions::eVarCoeffD02, Nektar::StdRegions::eVarCoeffD11, Nektar::StdRegions::eVarCoeffD12, Nektar::StdRegions::eVarCoeffD22, GetCoordim(), GetNcoeffs(), Nektar::StdRegions::StdMatrixKey::GetNVarCoeff(), GetTotPoints(), Nektar::StdRegions::StdMatrixKey::GetVarCoeff(), Nektar::StdRegions::StdMatrixKey::HasVarCoeff(), SVVLaplacianFilter(), v_BwdTrans(), v_IProductWRTDerivBase(), v_PhysDeriv(), Vmath::Vadd(), Vmath::Vcopy(), Vmath::Vmul(), and Vmath::Zero().
|
protected |
Definition at line 743 of file StdExpansion.cpp.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::StdRegions::StdMatrixKey::ConstFactorExists(), Nektar::StdRegions::eFactorSVVDiffCoeff, Nektar::StdRegions::eLaplacian00, Nektar::StdRegions::eLaplacian01, Nektar::StdRegions::eLaplacian02, Nektar::StdRegions::eLaplacian11, Nektar::StdRegions::eLaplacian12, Nektar::StdRegions::eLaplacian22, GetCoordim(), Nektar::StdRegions::StdMatrixKey::GetNVarCoeff(), LaplacianMatrixOp(), m_ncoeffs, Vmath::Vadd(), and Vmath::Vcopy().
Referenced by Nektar::StdRegions::StdNodalTriExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdExpansion2D::v_LaplacianMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_LaplacianMatrixOp_MatFree(), and v_LaplacianMatrixOp_MatFree().
|
inlineprotected |
Definition at line 1496 of file StdExpansion.h.
References v_LaplacianMatrixOp_MatFree_Kernel().
Referenced by Nektar::StdRegions::StdExpansion2D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion2D::v_LaplacianMatrixOp_MatFree(), and Nektar::StdRegions::StdExpansion3D::v_LaplacianMatrixOp_MatFree().
|
inline |
Definition at line 1028 of file StdExpansion.h.
References v_LinearAdvectionDiffusionReactionMatrixOp().
Referenced by GeneralMatrixOp().
|
protected |
Definition at line 880 of file StdExpansion.cpp.
References ASSERTL0, ASSERTL1, DetShapeType(), Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eLaplacian, Nektar::StdRegions::eVarCoeffVelX, Nektar::StdRegions::eVarCoeffVelY, Nektar::StdRegions::StdMatrixKey::GetConstFactor(), GetCoordim(), Nektar::StdRegions::StdMatrixKey::GetNVarCoeff(), GetTotPoints(), Nektar::StdRegions::StdMatrixKey::GetVarCoeff(), LaplacianMatrixOp(), m_ncoeffs, Vmath::Svtvp(), v_BwdTrans(), v_IProductWRTBase(), v_PhysDeriv(), Vmath::Vadd(), Vmath::Vvtvp(), and Vmath::Zero().
Referenced by GeneralMatrixOp_MatFree(), and v_LinearAdvectionDiffusionReactionMatrixOp().
NekDouble Nektar::StdRegions::StdExpansion::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.
This function takes the physical value space array m_phys as approximate solution
sol | array of solution function at physical quadrature points |
Definition at line 106 of file StdExpansion.cpp.
References GetTotPoints(), Nektar::NullNekDouble1DArray, Vmath::Vabs(), Vmath::Vamax(), and Vmath::Vsub().
|
inline |
Convert local cartesian coordinate xi into local collapsed coordinates eta.
Definition at line 1173 of file StdExpansion.h.
References v_LocCoordToLocCollapsed().
Referenced by Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdTriExp::v_GenMatrix(), Nektar::StdRegions::StdPrismExp::v_GenMatrix(), Nektar::StdRegions::StdTetExp::v_GenMatrix(), Nektar::StdRegions::StdExpansion2D::v_PhysEvaluate(), and Nektar::StdRegions::StdExpansion3D::v_PhysEvaluate().
|
inline |
Definition at line 1021 of file StdExpansion.h.
References v_MassLevelCurvatureMatrixOp().
Referenced by GeneralMatrixOp().
|
protected |
Definition at line 829 of file StdExpansion.cpp.
Referenced by GeneralMatrixOp_MatFree(), and v_MassLevelCurvatureMatrixOp().
|
inline |
Definition at line 971 of file StdExpansion.h.
References v_MassMatrixOp().
Referenced by GeneralMatrixOp(), HelmholtzMatrixOp_MatFree_GenericImpl(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdTriExp::v_FwdTrans_BndConstrained(), and Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained().
|
protected |
Definition at line 668 of file StdExpansion.cpp.
References Nektar::StdRegions::eVarCoeffMass, GetTotPoints(), Nektar::StdRegions::StdMatrixKey::GetVarCoeff(), Nektar::StdRegions::StdMatrixKey::HasVarCoeff(), v_BwdTrans(), v_IProductWRTBase(), and Vmath::Vmul().
Referenced by GeneralMatrixOp_MatFree(), Nektar::StdRegions::StdNodalTriExp::v_MassMatrixOp(), Nektar::StdRegions::StdQuadExp::v_MassMatrixOp(), Nektar::StdRegions::StdTriExp::v_MassMatrixOp(), Nektar::StdRegions::StdHexExp::v_MassMatrixOp(), and v_MassMatrixOp().
|
inline |
Definition at line 942 of file StdExpansion.h.
References v_MultiplyByQuadratureMetric().
Referenced by Nektar::LocalRegions::NodalTriExp::IProductWRTBase_SumFac(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::PyrExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TetExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::HexExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TriExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::QuadExp::v_ComputeLaplacianMetric(), Nektar::StdRegions::StdExpansion2D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase(), Nektar::LocalRegions::TetExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::PrismExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::HexExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::TetExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::PrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_SumFac(), and Nektar::LocalRegions::PrismExp::v_LaplacianMatrixOp_MatFree_Kernel().
|
inline |
Definition at line 949 of file StdExpansion.h.
References v_MultiplyByStdQuadratureMetric().
Referenced by Nektar::LocalRegions::Expansion::ComputeQuadratureMetric(), Nektar::StdRegions::StdExpansion3D::v_Integral(), Nektar::StdRegions::StdPyrExp::v_IProductWRTBase(), and Nektar::StdRegions::StdPyrExp::v_IProductWRTDerivBase_SumFac().
|
inline |
Definition at line 1283 of file StdExpansion.h.
References v_NegateEdgeNormal().
|
inline |
Definition at line 1298 of file StdExpansion.h.
References v_NegateFaceNormal().
|
inline |
Definition at line 727 of file StdExpansion.h.
References v_NormVectorIProductWRTBase().
Referenced by Nektar::MultiRegions::DisContField3DHomogeneous1D::NormVectorIProductWRTBase(), Nektar::LocalRegions::SegExp::v_NormVectorIProductWRTBase(), Nektar::LocalRegions::TriExp::v_NormVectorIProductWRTBase(), and Nektar::LocalRegions::QuadExp::v_NormVectorIProductWRTBase().
|
inline |
Definition at line 732 of file StdExpansion.h.
References v_NormVectorIProductWRTBase().
|
inline |
Definition at line 737 of file StdExpansion.h.
References v_NormVectorIProductWRTBase().
|
inline |
Definition at line 742 of file StdExpansion.h.
References v_NormVectorIProductWRTBase().
|
inline |
Definition at line 390 of file StdExpansion.h.
References v_NumBndryCoeffs().
Referenced by Nektar::CoupledLocalToGlobalC0ContMap::CoupledLocalToGlobalC0ContMap(), Nektar::LocalRegions::PyrExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TetExp::CreateStaticCondMatrix(), Nektar::LocalRegions::PrismExp::CreateStaticCondMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::SegExp::CreateStaticCondMatrix(), Nektar::LocalRegions::HexExp::CreateStaticCondMatrix(), CreateStdStaticCondMatrix(), Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdNodalTetExp::v_GetBoundaryMap(), Nektar::StdRegions::StdNodalPrismExp::v_GetBoundaryMap(), Nektar::StdRegions::StdNodalTriExp::v_GetBoundaryMap(), Nektar::StdRegions::StdSegExp::v_GetBoundaryMap(), Nektar::StdRegions::StdQuadExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTriExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPrismExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTetExp::v_GetBoundaryMap(), Nektar::StdRegions::StdHexExp::v_GetBoundaryMap(), Nektar::LocalRegions::Expansion2D::v_GetEdgeInverseBoundaryMap(), Nektar::StdRegions::StdNodalTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdNodalPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdNodalTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdSegExp::v_GetInteriorMap(), Nektar::StdRegions::StdQuadExp::v_GetInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetInteriorMap(), and Nektar::StdRegions::StdPyrExp::v_GetInteriorMap().
|
inline |
Definition at line 395 of file StdExpansion.h.
References v_NumDGBndryCoeffs().
Referenced by Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix(), and Nektar::LocalRegions::Expansion2D::v_GenMatrix().
|
inline |
Definition at line 1054 of file StdExpansion.h.
References v_PhysDeriv().
Referenced by Nektar::LocalRegions::SegExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::SegExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdHexExp::v_PhysDeriv(), Nektar::LocalRegions::SegExp::v_PhysDeriv(), Nektar::LocalRegions::TriExp::v_PhysDeriv(), and Nektar::LocalRegions::HexExp::v_PhysDeriv().
|
inline |
Definition at line 1062 of file StdExpansion.h.
References v_PhysDeriv().
|
inline |
Definition at line 1075 of file StdExpansion.h.
References v_PhysDeriv_n().
|
inline |
Definition at line 1069 of file StdExpansion.h.
References v_PhysDeriv_s().
|
inline |
Definition at line 1081 of file StdExpansion.h.
References v_PhysDirectionalDeriv().
|
inline |
This function evaluates the expansion at a single (arbitrary) point of the domain.
This function is a wrapper around the virtual function v_PhysEvaluate()
Based on the value of the expansion at the quadrature points provided in physvals, this function calculates the value of the expansion at an arbitrary single points (with coordinates given by the pointer coords). This operation, equivalent to
is evaluated using Lagrangian interpolants through the quadrature points:
coords | the coordinates of the single point |
physvals | the interpolated field at the quadrature points |
Definition at line 1135 of file StdExpansion.h.
References v_PhysEvaluate().
|
inline |
This function evaluates the expansion at a single (arbitrary) point of the domain.
This function is a wrapper around the virtual function v_PhysEvaluate()
Based on the value of the expansion at the quadrature points provided in physvals, this function calculates the value of the expansion at an arbitrary single points associated with the interpolation matrices provided in .
I | an Array of lagrange interpolantes evaluated at the coordinate and going through the local physical quadrature |
physvals | the interpolated field at the quadrature points |
Definition at line 1162 of file StdExpansion.h.
References v_PhysEvaluate().
void Nektar::StdRegions::StdExpansion::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.
This is primarily used for output purposes to get a better distribution of points more suitable for most postprocessing
Definition at line 1761 of file StdExpansion.cpp.
References DetShapeType(), Nektar::StdRegions::eFactorConst, Nektar::StdRegions::ePhysInterpToEquiSpaced, Nektar::eWrapper, Nektar::LibUtilities::GetNumberOfCoefficients(), GetStdMatrix(), GetTotPoints(), and m_base.
Referenced by CreateGeneralMatrix().
|
inline |
Definition at line 985 of file StdExpansion.h.
References v_ReduceOrderCoeffs().
|
inline |
Definition at line 777 of file StdExpansion.h.
References v_SetCoeffsToOrientation().
|
inline |
Definition at line 784 of file StdExpansion.h.
References v_SetCoeffsToOrientation().
|
inline |
Set the element id of this expansion when used in a list by returning value of m_elmt_id.
Definition at line 662 of file StdExpansion.h.
References m_elmt_id.
|
inline |
Definition at line 720 of file StdExpansion.h.
References v_SetPhysNormals().
|
virtual |
Definition at line 963 of file StdExpansion.cpp.
References v_SetUpPhysNormals().
|
inline |
Definition at line 1088 of file StdExpansion.h.
References v_StdPhysDeriv().
|
inline |
Definition at line 1096 of file StdExpansion.h.
References v_StdPhysDeriv().
NekDouble Nektar::StdRegions::StdExpansion::StdPhysEvaluate | ( | const Array< OneD, const NekDouble > & | Lcoord, |
const Array< OneD, const NekDouble > & | physvals | ||
) |
Definition at line 968 of file StdExpansion.cpp.
References v_StdPhysEvaluate().
|
inline |
Definition at line 992 of file StdExpansion.h.
References v_SVVLaplacianFilter().
Referenced by LaplacianMatrixOp_MatFree().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D, and Nektar::LocalRegions::Expansion1D.
Definition at line 1278 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by AddRobinEdgeContribution().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D, Nektar::LocalRegions::Expansion3D, and Nektar::LocalRegions::Expansion1D.
Definition at line 1272 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by AddRobinMassMatrix().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion3D.
Definition at line 1754 of file StdExpansion.cpp.
References ErrorUtil::efatal, NEKERROR, and Nektar::NullDNekMatSharedPtr.
Referenced by BuildInverseTransformationMatrix().
|
privatepure virtual |
Implemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, and Nektar::StdRegions::StdPointExp.
Referenced by BwdTrans(), LaplacianMatrixOp_MatFree(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), MassMatrixOp_MatFree(), WeakDerivMatrixOp_MatFree(), and WeakDirectionalDerivMatrixOp_MatFree().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1533 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by BwdTrans_SumFac().
|
virtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdTriExp.
Definition at line 996 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CalcNumberOfCoefficients().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::QuadExp.
Definition at line 1678 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by ComputeEdgeNormal().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::HexExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1694 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by ComputeFaceNormal().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1710 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by ComputeVertexNormal().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdTetExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::QuadExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTetExp, Nektar::LocalRegions::PyrExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1380 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CreateStdMatrix().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1142 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by DetCartesianDirOfEdge().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1148 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::NullBasisKey().
Referenced by DetEdgeBasisKey().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1154 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::NullBasisKey().
Referenced by DetFaceBasisKey().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::TetExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1211 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::eNoShapeType.
Referenced by DetShapeType().
|
virtual |
Reimplemented in Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1040 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by DropLocStaticCondMatrix().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D.
Definition at line 1688 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by EdgeNormalNegated().
|
virtual |
Unpack data from input file assuming it comes from the same expansion type.
Reimplemented in Nektar::LocalRegions::SegExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::TetExp.
Definition at line 1002 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by ExtractDataToCoeffs().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D.
Definition at line 1704 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by FaceNormalNegated().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, and Nektar::StdRegions::StdNodalTetExp.
Definition at line 1366 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by FillMode().
|
privatepure virtual |
Transform a given function from physical quadrature space to coefficient space.
Implemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdNodalTetExp, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::StdRegions::StdPointExp.
Referenced by FwdTrans().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1253 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by FwdTrans_BndConstrained().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::TetExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTetExp, Nektar::LocalRegions::Expansion2D, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::Expansion3D, Nektar::StdRegions::StdPointExp, and Nektar::LocalRegions::Expansion1D.
Definition at line 1372 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GenMatrix().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalPrismExp, and Nektar::StdRegions::StdNodalTetExp.
Definition at line 1407 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetBoundaryMap().
|
virtual |
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::TriExp.
Definition at line 1065 of file StdExpansion.cpp.
References ErrorUtil::efatal, Nektar::StdRegions::eForwards, and NEKERROR.
Referenced by GetCartesianEorient().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1395 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetCoord().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, Nektar::StdRegions::StdExpansion2D, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PyrExp, Nektar::StdRegions::StdExpansion1D, and Nektar::StdRegions::StdExpansion0D.
Definition at line 1401 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetCoordim(), and H1().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::Expansion, Nektar::LocalRegions::PointExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::PyrExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1388 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetCoords().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1197 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::eNoBasisType.
Referenced by GetEdgeBasisType().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdNodalTriExp.
Definition at line 1424 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CreateIndexMap(), and GetEdgeInteriorMap().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::QuadExp.
Definition at line 1476 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetEdgeInterpVals().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D, and Nektar::LocalRegions::Expansion3D.
Definition at line 1737 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetEdgeInverseBoundaryMap().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1124 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetEdgeNcoeffs().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D.
Definition at line 1671 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetEdgeNormal().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1136 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetEdgeNumPoints().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::TriExp.
Definition at line 1498 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetEdgePhysMap().
|
privatevirtual |
Extract the physical values along edge edge from inarray into outarray following the local edge orientation and point distribution defined by defined in EdgeExp.
Reimplemented in Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::QuadExp.
Definition at line 1456 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetEdgePhysVals().
|
privatevirtual |
Definition at line 1461 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::QuadExp.
Definition at line 1481 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetEdgeQFactors().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdNodalTriExp.
Definition at line 1438 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CreateIndexMap(), and GetEdgeToElementMap().
|
virtual |
Get the element id of this expansion when used in a list by returning value of m_elmt_id.
Definition at line 974 of file StdExpansion.cpp.
References m_elmt_id.
|
virtual |
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::TriExp.
Definition at line 1052 of file StdExpansion.cpp.
References ErrorUtil::efatal, Nektar::StdRegions::eForwards, and NEKERROR.
Referenced by Nektar::LocalRegions::Expansion2D::AddEdgeBoundaryInt(), GetEorient(), Nektar::LocalRegions::Expansion2D::v_AddRobinEdgeContribution(), and Nektar::LocalRegions::Expansion2D::v_AddRobinMassMatrix().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTetExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1431 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CreateIndexMap(), and GetFaceInteriorMap().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, and Nektar::StdRegions::StdHexExp.
Definition at line 1172 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetFaceIntNcoeffs().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion3D.
Definition at line 1745 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetFaceInverseBoundaryMap().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1166 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetFaceNcoeffs().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D.
Definition at line 1715 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetFaceNormal().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1160 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetFaceNumPoints().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::HexExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1506 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetFacePhysMap().
|
privatevirtual |
Definition at line 1489 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetFacePhysVals().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1191 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::NullPointsKey().
Referenced by GetFacePointsKey().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1448 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by CreateIndexMap(), and GetFaceToElementMap().
|
virtual |
Reimplemented in Nektar::LocalRegions::Expansion3D.
Definition at line 1045 of file StdExpansion.cpp.
References Nektar::StdRegions::eDir1FwdDir1_Dir2FwdDir2, ErrorUtil::efatal, and NEKERROR.
Referenced by GetForient().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalPrismExp, and Nektar::StdRegions::StdNodalTetExp.
Definition at line 1412 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetInteriorMap().
|
virtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1034 of file StdExpansion.cpp.
References ErrorUtil::efatal, NEKERROR, and Nektar::NullDNekScalBlkMatSharedPtr.
Referenced by GetLocStaticCondMatrix().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::Expansion.
Definition at line 1526 of file StdExpansion.cpp.
References ErrorUtil::efatal, NEKERROR, and Nektar::SpatialDomains::NullGeomFactorsSharedPtr.
Referenced by GetMetricInfo().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdExpansion1D, and Nektar::StdRegions::StdExpansion0D.
Definition at line 1100 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetNedges().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdExpansion2D, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdExpansion1D, and Nektar::StdRegions::StdExpansion0D.
Definition at line 1106 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetNfaces().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalPrismExp, and Nektar::StdRegions::StdNodalTetExp.
Definition at line 1204 of file StdExpansion.cpp.
References ASSERTL0, and Nektar::LibUtilities::NullPointsKey().
Referenced by GetNodalPointsKey().
|
privatepure virtual |
|
virtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 979 of file StdExpansion.cpp.
References ErrorUtil::efatal, NEKERROR, and Nektar::NullNekDouble1DArray.
Referenced by GetPhysNormals().
|
virtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1058 of file StdExpansion.cpp.
References ErrorUtil::efatal, Nektar::StdRegions::eFwd, and NEKERROR.
Referenced by GetPorient().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, Nektar::StdRegions::StdExpansion2D, Nektar::StdRegions::StdExpansion1D, and Nektar::StdRegions::StdExpansion0D.
Definition at line 1225 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetShapeDimension().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTetExp, and Nektar::LocalRegions::PrismExp.
Definition at line 1799 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetSimplexEquiSpacedConnectivity().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1218 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetStdExp().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, Nektar::LocalRegions::Expansion2D, and Nektar::StdRegions::StdExpansion1D.
Definition at line 1729 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetSurfaceNormal().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdPrismExp.
Definition at line 1130 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetTotalEdgeIntNcoeffs().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, and Nektar::StdRegions::StdHexExp.
Definition at line 1178 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetTotalFaceIntNcoeffs().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, and Nektar::StdRegions::StdExpansion2D.
Definition at line 1184 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetTraceNcoeffs().
|
privatevirtual |
Definition at line 1466 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetTracePhysVals().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTetExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1417 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetVertexMap().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion1D.
Definition at line 1722 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by GetVertexNormal().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1471 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by GetVertexPhysVals().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::PrismExp, Nektar::StdRegions::StdSegExp, and Nektar::LocalRegions::TetExp.
Definition at line 1636 of file StdExpansion.cpp.
References HelmholtzMatrixOp_MatFree().
Referenced by HelmholtzMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, and Nektar::StdRegions::StdExpansion2D.
Definition at line 1662 of file StdExpansion.cpp.
References HelmholtzMatrixOp_MatFree_GenericImpl().
Referenced by HelmholtzMatrixOp_MatFree().
|
privatevirtual |
Integrates the specified function over the domain.
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdExpansion3D, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1264 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by H1(), Integral(), and L2().
|
privatepure virtual |
Calculates the inner product of a given function f with the different modes of the expansion.
Implemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::StdRegions::StdPointExp.
Referenced by IProductWRTBase(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), MassMatrixOp_MatFree(), WeakDerivMatrixOp_MatFree(), and WeakDirectionalDerivMatrixOp_MatFree().
|
inlineprivatevirtual |
Reimplemented in Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::SegExp, and Nektar::StdRegions::StdPointExp.
Definition at line 1625 of file StdExpansion.h.
References ASSERTL0.
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, Nektar::StdRegions::StdPointExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::TetExp.
Definition at line 1539 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by IProductWRTBase_SumFac().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::QuadExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdPointExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::TetExp.
Definition at line 1243 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by IProductWRTDerivBase(), and LaplacianMatrixOp_MatFree().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, Nektar::StdRegions::StdNodalTetExp, and Nektar::LocalRegions::PrismExp.
Definition at line 1546 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by IProductWRTDerivBase_SumFac().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdQuadExp.
Definition at line 1231 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by IsBoundaryInteriorExpansion().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdNodalPrismExp, Nektar::StdRegions::StdNodalTriExp, and Nektar::StdRegions::StdNodalTetExp.
Definition at line 1238 of file StdExpansion.cpp.
Referenced by IsNodalNonTensorialExp().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::PrismExp, Nektar::StdRegions::StdSegExp, and Nektar::LocalRegions::TetExp.
Definition at line 1562 of file StdExpansion.cpp.
References LaplacianMatrixOp_MatFree().
Referenced by LaplacianMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdNodalTriExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::TetExp.
Definition at line 1585 of file StdExpansion.cpp.
References LaplacianMatrixOp_MatFree().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, and Nektar::StdRegions::StdExpansion2D.
Definition at line 1645 of file StdExpansion.cpp.
References LaplacianMatrixOp_MatFree_GenericImpl().
Referenced by LaplacianMatrixOp_MatFree().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::PyrExp.
Definition at line 1654 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by LaplacianMatrixOp_MatFree_Kernel().
|
privatevirtual |
Definition at line 1625 of file StdExpansion.cpp.
References LinearAdvectionDiffusionReactionMatrixOp_MatFree().
Referenced by LinearAdvectionDiffusionReactionMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1095 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by LocCoordToLocCollapsed().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::HexExp.
Definition at line 1616 of file StdExpansion.cpp.
References MassLevelCurvatureMatrixOp_MatFree().
Referenced by MassLevelCurvatureMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdNodalTriExp, and Nektar::LocalRegions::PrismExp.
Definition at line 1553 of file StdExpansion.cpp.
References MassMatrixOp_MatFree().
Referenced by MassMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion.
Definition at line 1512 of file StdExpansion.cpp.
References v_MultiplyByStdQuadratureMetric().
Referenced by MultiplyByQuadratureMetric().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdSegExp, and Nektar::StdRegions::StdPyrExp.
Definition at line 1519 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by MultiplyByStdQuadratureMetric(), and v_MultiplyByQuadratureMetric().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::Expansion2D.
Definition at line 1683 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by NegateEdgeNormal().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D.
Definition at line 1699 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by NegateFaceNormal().
|
virtual |
Reimplemented in Nektar::LocalRegions::PointExp.
Definition at line 1010 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by NormVectorIProductWRTBase().
|
virtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1015 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
virtual |
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::TriExp.
Definition at line 1020 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
virtual |
Reimplemented in Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::SegExp, and Nektar::LocalRegions::Expansion3D.
Definition at line 1028 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdTriExp, and Nektar::StdRegions::StdNodalTriExp.
Definition at line 1112 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by NumBndryCoeffs().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdHexExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1118 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by NumDGBndryCoeffs().
|
privatevirtual |
Calculate the derivative of the physical points.
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdTetExp, Nektar::LocalRegions::QuadExp, Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1288 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by H1(), LaplacianMatrixOp_MatFree(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), PhysDeriv(), and WeakDerivMatrixOp_MatFree().
|
privatevirtual |
Calculate the derivative of the physical points in a given direction.
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::LocalRegions::HexExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdSegExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::SegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1315 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1303 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by PhysDeriv_n().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1297 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by PhysDeriv_s().
|
privatevirtual |
Physical derivative along a direction vector.
Reimplemented in Nektar::LocalRegions::QuadExp, and Nektar::LocalRegions::TriExp.
Definition at line 1328 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by PhysDirectionalDeriv().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::LocalRegions::TriExp, Nektar::LocalRegions::QuadExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdExpansion3D, Nektar::StdRegions::StdExpansion2D, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::PyrExp, Nektar::LocalRegions::TetExp, Nektar::StdRegions::StdExpansion1D, and Nektar::StdRegions::StdExpansion0D.
Definition at line 1352 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by PhysEvaluate().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdExpansion3D, and Nektar::StdRegions::StdExpansion2D.
Definition at line 1359 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, and Nektar::LocalRegions::HexExp.
Definition at line 1578 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by ReduceOrderCoeffs().
|
protectedvirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1072 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by SetCoeffsToOrientation().
|
protectedvirtual |
Reimplemented in Nektar::LocalRegions::SegExp.
Definition at line 1079 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
virtual |
Definition at line 986 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by SetPhysNormals().
|
virtual |
Reimplemented in Nektar::LocalRegions::Expansion2D, and Nektar::StdRegions::StdExpansion1D.
Definition at line 991 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by SetUpPhysNormals().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1336 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by StdPhysDeriv().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdPyrExp, Nektar::StdRegions::StdSegExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdHexExp, and Nektar::StdRegions::StdTriExp.
Definition at line 1344 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
|
protectedvirtual |
Reimplemented in Nektar::LocalRegions::TriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::SegExp, Nektar::LocalRegions::PrismExp, Nektar::LocalRegions::TetExp, and Nektar::LocalRegions::QuadExp.
Definition at line 1087 of file StdExpansion.cpp.
References ErrorUtil::efatal, and NEKERROR.
Referenced by StdPhysEvaluate().
|
privatevirtual |
Reimplemented in Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTetExp, Nektar::StdRegions::StdQuadExp, Nektar::StdRegions::StdPrismExp, Nektar::StdRegions::StdTriExp, Nektar::LocalRegions::HexExp, Nektar::LocalRegions::PrismExp, and Nektar::LocalRegions::TetExp.
Definition at line 1572 of file StdExpansion.cpp.
References ASSERTL0.
Referenced by SVVLaplacianFilter().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::NodalTriExp, Nektar::StdRegions::StdHexExp, Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, Nektar::StdRegions::StdTriExp, Nektar::StdRegions::StdQuadExp, Nektar::LocalRegions::HexExp, and Nektar::StdRegions::StdNodalTriExp.
Definition at line 1595 of file StdExpansion.cpp.
References WeakDerivMatrixOp_MatFree().
Referenced by WeakDerivMatrixOp().
|
privatevirtual |
Reimplemented in Nektar::LocalRegions::QuadExp, Nektar::LocalRegions::TriExp, and Nektar::LocalRegions::HexExp.
Definition at line 1606 of file StdExpansion.cpp.
References WeakDirectionalDerivMatrixOp_MatFree().
Referenced by WeakDirectionalDerivMatrixOp().
|
inline |
Definition at line 1006 of file StdExpansion.h.
References v_WeakDerivMatrixOp().
Referenced by GeneralMatrixOp().
|
protected |
Definition at line 785 of file StdExpansion.cpp.
References Nektar::StdRegions::eVarCoeffD00, Nektar::StdRegions::eVarCoeffD11, Nektar::StdRegions::eVarCoeffD22, GetTotPoints(), Nektar::StdRegions::StdMatrixKey::GetVarCoeff(), Nektar::StdRegions::StdMatrixKey::HasVarCoeff(), v_BwdTrans(), v_IProductWRTBase(), v_PhysDeriv(), and Vmath::Vmul().
Referenced by GeneralMatrixOp_MatFree(), Nektar::StdRegions::StdNodalTriExp::v_WeakDerivMatrixOp(), Nektar::StdRegions::StdQuadExp::v_WeakDerivMatrixOp(), Nektar::StdRegions::StdTriExp::v_WeakDerivMatrixOp(), Nektar::StdRegions::StdHexExp::v_WeakDerivMatrixOp(), and v_WeakDerivMatrixOp().
|
inline |
Definition at line 1014 of file StdExpansion.h.
References v_WeakDirectionalDerivMatrixOp().
Referenced by GeneralMatrixOp().
|
protected |
Definition at line 805 of file StdExpansion.cpp.
References GetTotPoints(), v_BwdTrans(), and v_IProductWRTBase().
Referenced by GeneralMatrixOp_MatFree(), and v_WeakDirectionalDerivMatrixOp().
|
protected |
Bases needed for the expansion
Definition at line 1422 of file StdExpansion.h.
Referenced by CreateGeneralMatrix(), Nektar::LocalRegions::QuadExp::CreateMatrix(), Nektar::LocalRegions::SegExp::CreateMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStdMatrix(), EquiSpacedToCoeffs(), EvalBasisNumModesMax(), Nektar::LocalRegions::Expansion::Expansion(), GetBase(), GetBasis(), GetBasisNumModes(), GetBasisType(), Nektar::StdRegions::StdPrismExp::GetMode(), Nektar::StdRegions::StdTetExp::GetMode(), GetNtrace(), GetNumBases(), GetNumPoints(), GetPoints(), GetPointsKeys(), GetPointsType(), Nektar::StdRegions::StdPyrExp::GetTetMode(), GetTotPoints(), Nektar::LocalRegions::NodalTriExp::Integral(), Nektar::StdRegions::StdExpansion2D::Integral(), Nektar::LocalRegions::NodalTriExp::IProductWRTBase_SumFac(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::PhysDeriv(), PhysInterpToSimplexEquiSpaced(), Nektar::StdRegions::StdExpansion0D::PhysTensorDeriv(), Nektar::StdRegions::StdExpansion1D::PhysTensorDeriv(), Nektar::StdRegions::StdExpansion2D::PhysTensorDeriv(), Nektar::StdRegions::StdExpansion3D::PhysTensorDeriv(), StdExpansion(), Nektar::StdRegions::StdNodalTriExp::StdNodalTriExp(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::StdRegions::StdPointExp::v_BwdTrans(), Nektar::StdRegions::StdHexExp::v_BwdTrans(), Nektar::StdRegions::StdQuadExp::v_BwdTrans(), Nektar::StdRegions::StdPrismExp::v_BwdTrans(), Nektar::StdRegions::StdTetExp::v_BwdTrans(), Nektar::StdRegions::StdSegExp::v_BwdTrans(), Nektar::StdRegions::StdPyrExp::v_BwdTrans(), Nektar::StdRegions::StdHexExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdTriExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdPrismExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdQuadExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdTetExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdPyrExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdTriExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdHexExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdPrismExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdQuadExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdTetExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdPyrExp::v_BwdTrans_SumFacKernel(), Nektar::LocalRegions::QuadExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::TriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::NodalTriExp::v_ComputeEdgeNormal(), Nektar::LocalRegions::HexExp::v_ComputeFaceNormal(), Nektar::LocalRegions::PyrExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TetExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::TriExp::v_ComputeLaplacianMetric(), Nektar::LocalRegions::PyrExp::v_CreateStdMatrix(), Nektar::LocalRegions::TetExp::v_CreateStdMatrix(), Nektar::LocalRegions::PrismExp::v_CreateStdMatrix(), Nektar::LocalRegions::TriExp::v_CreateStdMatrix(), Nektar::LocalRegions::QuadExp::v_CreateStdMatrix(), Nektar::LocalRegions::SegExp::v_CreateStdMatrix(), Nektar::LocalRegions::HexExp::v_CreateStdMatrix(), Nektar::StdRegions::StdTriExp::v_DetEdgeBasisKey(), Nektar::StdRegions::StdPrismExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdHexExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdTetExp::v_DetFaceBasisKey(), Nektar::StdRegions::StdPyrExp::v_DetFaceBasisKey(), Nektar::LocalRegions::TetExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::PrismExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::HexExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::TriExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::QuadExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::SegExp::v_ExtractDataToCoeffs(), Nektar::StdRegions::StdTriExp::v_FillMode(), Nektar::StdRegions::StdQuadExp::v_FillMode(), Nektar::StdRegions::StdHexExp::v_FillMode(), Nektar::StdRegions::StdSegExp::v_FillMode(), Nektar::StdRegions::StdPointExp::v_FwdTrans(), Nektar::LocalRegions::TetExp::v_FwdTrans(), Nektar::LocalRegions::PrismExp::v_FwdTrans(), Nektar::LocalRegions::PyrExp::v_FwdTrans(), Nektar::LocalRegions::SegExp::v_FwdTrans(), Nektar::LocalRegions::QuadExp::v_FwdTrans(), Nektar::LocalRegions::HexExp::v_FwdTrans(), Nektar::StdRegions::StdSegExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdTriExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdTriExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GenMatrix(), Nektar::StdRegions::StdPrismExp::v_GenMatrix(), Nektar::StdRegions::StdTetExp::v_GenMatrix(), Nektar::LocalRegions::TriExp::v_GetBasis(), Nektar::LocalRegions::QuadExp::v_GetBasis(), Nektar::StdRegions::StdSegExp::v_GetBoundaryMap(), Nektar::StdRegions::StdQuadExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTriExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPrismExp::v_GetBoundaryMap(), Nektar::StdRegions::StdTetExp::v_GetBoundaryMap(), Nektar::StdRegions::StdHexExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPointExp::v_GetCoords(), Nektar::LocalRegions::Expansion::v_GetCoords(), Nektar::StdRegions::StdPrismExp::v_GetCoords(), Nektar::StdRegions::StdTetExp::v_GetCoords(), Nektar::StdRegions::StdSegExp::v_GetCoords(), Nektar::StdRegions::StdTriExp::v_GetCoords(), Nektar::StdRegions::StdQuadExp::v_GetCoords(), Nektar::StdRegions::StdPyrExp::v_GetCoords(), Nektar::StdRegions::StdHexExp::v_GetCoords(), Nektar::StdRegions::StdQuadExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetEdgeInteriorMap(), Nektar::StdRegions::StdPyrExp::v_GetEdgeInteriorMap(), Nektar::LocalRegions::QuadExp::v_GetEdgeInterpVals(), Nektar::StdRegions::StdTetExp::v_GetEdgeNcoeffs(), Nektar::LocalRegions::TriExp::v_GetEdgePhysMap(), Nektar::LocalRegions::QuadExp::v_GetEdgePhysMap(), Nektar::LocalRegions::QuadExp::v_GetEdgePhysVals(), Nektar::LocalRegions::TriExp::v_GetEdgePhysVals(), Nektar::LocalRegions::QuadExp::v_GetEdgeQFactors(), Nektar::StdRegions::StdTriExp::v_GetEdgeToElementMap(), Nektar::StdRegions::StdQuadExp::v_GetEdgeToElementMap(), Nektar::StdRegions::StdPrismExp::v_GetFaceInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetFaceInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetFaceInteriorMap(), Nektar::StdRegions::StdPyrExp::v_GetFaceInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetFaceIntNcoeffs(), Nektar::StdRegions::StdPyrExp::v_GetFaceIntNcoeffs(), Nektar::StdRegions::StdPrismExp::v_GetFaceNumPoints(), Nektar::StdRegions::StdHexExp::v_GetFaceNumPoints(), Nektar::StdRegions::StdTetExp::v_GetFaceNumPoints(), Nektar::StdRegions::StdPyrExp::v_GetFaceNumPoints(), Nektar::LocalRegions::PyrExp::v_GetFacePhysMap(), Nektar::LocalRegions::TetExp::v_GetFacePhysMap(), Nektar::LocalRegions::PrismExp::v_GetFacePhysMap(), Nektar::LocalRegions::HexExp::v_GetFacePhysMap(), Nektar::StdRegions::StdPrismExp::v_GetFacePointsKey(), Nektar::StdRegions::StdHexExp::v_GetFacePointsKey(), Nektar::StdRegions::StdTetExp::v_GetFacePointsKey(), Nektar::StdRegions::StdPrismExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdHexExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdTetExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdPyrExp::v_GetFaceToElementMap(), Nektar::StdRegions::StdQuadExp::v_GetInteriorMap(), Nektar::StdRegions::StdTriExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetInteriorMap(), Nektar::LocalRegions::PrismExp::v_GetSimplexEquiSpacedConnectivity(), Nektar::StdRegions::StdTetExp::v_GetSimplexEquiSpacedConnectivity(), Nektar::StdRegions::StdQuadExp::v_GetSimplexEquiSpacedConnectivity(), Nektar::StdRegions::StdTriExp::v_GetSimplexEquiSpacedConnectivity(), Nektar::LocalRegions::PyrExp::v_GetStdExp(), Nektar::LocalRegions::TetExp::v_GetStdExp(), Nektar::LocalRegions::PrismExp::v_GetStdExp(), Nektar::LocalRegions::TriExp::v_GetStdExp(), Nektar::LocalRegions::QuadExp::v_GetStdExp(), Nektar::LocalRegions::HexExp::v_GetStdExp(), Nektar::LocalRegions::SegExp::v_GetStdExp(), Nektar::LocalRegions::NodalTriExp::v_GetStdExp(), Nektar::StdRegions::StdTetExp::v_GetTotalEdgeIntNcoeffs(), Nektar::StdRegions::StdTetExp::v_GetTotalFaceIntNcoeffs(), Nektar::StdRegions::StdSegExp::v_GetVertexMap(), Nektar::StdRegions::StdQuadExp::v_GetVertexMap(), Nektar::StdRegions::StdTriExp::v_GetVertexMap(), Nektar::StdRegions::StdHexExp::v_GetVertexMap(), Nektar::LocalRegions::SegExp::v_GetVertexPhysVals(), Nektar::StdRegions::StdSegExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::SegExp::v_HelmholtzMatrixOp(), Nektar::StdRegions::StdExpansion2D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdTriExp::v_Integral(), Nektar::StdRegions::StdQuadExp::v_Integral(), Nektar::LocalRegions::SegExp::v_Integral(), Nektar::LocalRegions::PrismExp::v_Integral(), Nektar::LocalRegions::TetExp::v_Integral(), Nektar::LocalRegions::PyrExp::v_Integral(), Nektar::LocalRegions::TriExp::v_Integral(), Nektar::LocalRegions::QuadExp::v_Integral(), Nektar::StdRegions::StdSegExp::v_Integral(), Nektar::LocalRegions::HexExp::v_Integral(), Nektar::StdRegions::StdPointExp::v_IProductWRTBase(), Nektar::LocalRegions::PyrExp::v_IProductWRTBase(), Nektar::LocalRegions::SegExp::v_IProductWRTBase(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase(), Nektar::StdRegions::StdPyrExp::v_IProductWRTBase(), Nektar::LocalRegions::TetExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::PrismExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdPointExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::HexExp::v_IProductWRTBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdPyrExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdPyrExp::v_IProductWRTBase_SumFacKernel(), Nektar::LocalRegions::TetExp::v_IProductWRTDerivBase(), Nektar::StdRegions::StdPointExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::SegExp::v_IProductWRTDerivBase(), Nektar::StdRegions::StdSegExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::PrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdPyrExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdTriExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdPrismExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdHexExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdSegExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdTetExp::v_IsBoundaryInteriorExpansion(), Nektar::StdRegions::StdSegExp::v_LaplacianMatrixOp(), Nektar::LocalRegions::SegExp::v_LaplacianMatrixOp(), Nektar::StdRegions::StdExpansion2D::v_LaplacianMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_LaplacianMatrixOp_MatFree(), Nektar::LocalRegions::PyrExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::PrismExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::TetExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::HexExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::TriExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::QuadExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::StdRegions::StdPyrExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdSegExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdPrismExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdTetExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdQuadExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdTriExp::v_MultiplyByStdQuadratureMetric(), Nektar::StdRegions::StdHexExp::v_MultiplyByStdQuadratureMetric(), Nektar::LocalRegions::SegExp::v_NormVectorIProductWRTBase(), Nektar::LocalRegions::PointExp::v_NormVectorIProductWRTBase(), Nektar::LocalRegions::TriExp::v_NormVectorIProductWRTBase(), Nektar::LocalRegions::QuadExp::v_NormVectorIProductWRTBase(), Nektar::StdRegions::StdPrismExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdHexExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdTetExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdPyrExp::v_NumBndryCoeffs(), Nektar::StdRegions::StdPrismExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdHexExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdTetExp::v_NumDGBndryCoeffs(), Nektar::StdRegions::StdTriExp::v_PhysDeriv(), Nektar::StdRegions::StdPrismExp::v_PhysDeriv(), Nektar::LocalRegions::SegExp::v_PhysDeriv(), Nektar::LocalRegions::TetExp::v_PhysDeriv(), Nektar::LocalRegions::PyrExp::v_PhysDeriv(), Nektar::LocalRegions::TriExp::v_PhysDeriv(), Nektar::LocalRegions::QuadExp::v_PhysDeriv(), Nektar::StdRegions::StdTetExp::v_PhysDeriv(), Nektar::LocalRegions::HexExp::v_PhysDeriv(), Nektar::StdRegions::StdPyrExp::v_PhysDeriv(), Nektar::LocalRegions::SegExp::v_PhysDeriv_n(), Nektar::LocalRegions::SegExp::v_PhysDeriv_s(), Nektar::LocalRegions::TriExp::v_PhysDirectionalDeriv(), Nektar::LocalRegions::QuadExp::v_PhysDirectionalDeriv(), Nektar::StdRegions::StdExpansion0D::v_PhysEvaluate(), Nektar::StdRegions::StdExpansion1D::v_PhysEvaluate(), Nektar::StdRegions::StdExpansion2D::v_PhysEvaluate(), Nektar::StdRegions::StdExpansion3D::v_PhysEvaluate(), Nektar::LocalRegions::HexExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTriExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdPrismExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdQuadExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTetExp::v_ReduceOrderCoeffs(), Nektar::LocalRegions::TriExp::v_ReduceOrderCoeffs(), Nektar::LocalRegions::QuadExp::v_ReduceOrderCoeffs(), Nektar::StdRegions::StdTriExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdPrismExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdQuadExp::v_SVVLaplacianFilter(), Nektar::StdRegions::StdTetExp::v_SVVLaplacianFilter(), and Nektar::StdRegions::StdHexExp::v_SVVLaplacianFilter().
|
protected |
Definition at line 1423 of file StdExpansion.h.
Referenced by GetElmtId(), SetElmtId(), and v_GetElmtId().
|
protected |
Definition at line 1427 of file StdExpansion.h.
Referenced by GetIndexMap().
|
protected |
Total number of coefficients used in the expansion
Definition at line 1424 of file StdExpansion.h.
Referenced by BwdTrans_MatOp(), CreateGeneralMatrix(), Nektar::LocalRegions::PyrExp::CreateStaticCondMatrix(), Nektar::LocalRegions::NodalTriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TetExp::CreateStaticCondMatrix(), Nektar::LocalRegions::PrismExp::CreateStaticCondMatrix(), Nektar::LocalRegions::QuadExp::CreateStaticCondMatrix(), Nektar::LocalRegions::TriExp::CreateStaticCondMatrix(), Nektar::LocalRegions::SegExp::CreateStaticCondMatrix(), Nektar::LocalRegions::HexExp::CreateStaticCondMatrix(), CreateStdStaticCondMatrix(), EquiSpacedToCoeffs(), Nektar::LocalRegions::NodalTriExp::FwdTrans(), Nektar::LocalRegions::NodalTriExp::GeneralMatrixOp_MatOp(), Nektar::LocalRegions::TetExp::GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdNodalPrismExp::GenNBasisTransMatrix(), Nektar::StdRegions::StdNodalTetExp::GenNBasisTransMatrix(), Nektar::StdRegions::StdNodalTriExp::GenNBasisTransMatrix(), GetNcoeffs(), HelmholtzMatrixOp_MatFree_GenericImpl(), Nektar::LocalRegions::NodalTriExp::IProductWRTBase_MatOp(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::HexExp::IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::NodalTriExp::IProductWRTDerivBase_SumFac(), LaplacianMatrixOp_MatFree_GenericImpl(), LinearAdvectionDiffusionReactionMatrixOp_MatFree(), Nektar::StdRegions::StdNodalTetExp::ModalToNodal(), Nektar::StdRegions::StdNodalPrismExp::ModalToNodal(), Nektar::StdRegions::StdNodalTriExp::ModalToNodal(), Nektar::LocalRegions::SegExp::MultiplyByElmtInvMass(), Nektar::StdRegions::StdNodalTetExp::NodalToModal(), Nektar::StdRegions::StdNodalPrismExp::NodalToModal(), Nektar::StdRegions::StdNodalTriExp::NodalToModal(), Nektar::StdRegions::StdNodalTetExp::NodalToModalTranspose(), Nektar::StdRegions::StdNodalPrismExp::NodalToModalTranspose(), Nektar::StdRegions::StdNodalTriExp::NodalToModalTranspose(), Nektar::LocalRegions::PointExp::PointExp(), Nektar::LocalRegions::SegExp::ReverseCoeffsAndSign(), Nektar::StdRegions::StdPyrExp::StdPyrExp(), Nektar::StdRegions::StdPointExp::v_BwdTrans(), Nektar::StdRegions::StdSegExp::v_BwdTrans(), Nektar::StdRegions::StdNodalTetExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdNodalPrismExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdNodalTriExp::v_BwdTrans_SumFac(), Nektar::StdRegions::StdHexExp::v_BwdTrans_SumFacKernel(), Nektar::StdRegions::StdQuadExp::v_BwdTrans_SumFacKernel(), Nektar::LocalRegions::TetExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::PrismExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::HexExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::TriExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::QuadExp::v_ExtractDataToCoeffs(), Nektar::LocalRegions::SegExp::v_ExtractDataToCoeffs(), Nektar::StdRegions::StdNodalTetExp::v_FillMode(), Nektar::StdRegions::StdNodalPrismExp::v_FillMode(), Nektar::StdRegions::StdNodalTriExp::v_FillMode(), Nektar::StdRegions::StdTriExp::v_FillMode(), Nektar::StdRegions::StdQuadExp::v_FillMode(), Nektar::StdRegions::StdPrismExp::v_FillMode(), Nektar::StdRegions::StdHexExp::v_FillMode(), Nektar::StdRegions::StdSegExp::v_FillMode(), Nektar::StdRegions::StdTetExp::v_FillMode(), Nektar::StdRegions::StdPyrExp::v_FillMode(), Nektar::StdRegions::StdPointExp::v_FwdTrans(), Nektar::LocalRegions::TetExp::v_FwdTrans(), Nektar::LocalRegions::PrismExp::v_FwdTrans(), Nektar::LocalRegions::PyrExp::v_FwdTrans(), Nektar::StdRegions::StdNodalTetExp::v_FwdTrans(), Nektar::LocalRegions::SegExp::v_FwdTrans(), Nektar::StdRegions::StdNodalTriExp::v_FwdTrans(), Nektar::StdRegions::StdNodalPrismExp::v_FwdTrans(), Nektar::LocalRegions::TriExp::v_FwdTrans(), Nektar::LocalRegions::QuadExp::v_FwdTrans(), Nektar::LocalRegions::HexExp::v_FwdTrans(), Nektar::StdRegions::StdTriExp::v_FwdTrans(), Nektar::StdRegions::StdSegExp::v_FwdTrans(), Nektar::StdRegions::StdHexExp::v_FwdTrans(), Nektar::StdRegions::StdPrismExp::v_FwdTrans(), Nektar::StdRegions::StdQuadExp::v_FwdTrans(), Nektar::StdRegions::StdTetExp::v_FwdTrans(), Nektar::StdRegions::StdPyrExp::v_FwdTrans(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::SegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::TriExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::QuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdTriExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained(), Nektar::LocalRegions::PrismExp::v_GeneralMatrixOp_MatOp(), Nektar::LocalRegions::HexExp::v_GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdQuadExp::v_GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdTriExp::v_GeneralMatrixOp_MatOp(), Nektar::LocalRegions::TriExp::v_GeneralMatrixOp_MatOp(), Nektar::LocalRegions::QuadExp::v_GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdHexExp::v_GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdPointExp::v_GenMatrix(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::StdRegions::StdQuadExp::v_GenMatrix(), Nektar::StdRegions::StdSegExp::v_GenMatrix(), Nektar::StdRegions::StdNodalPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdNodalTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdTetExp::v_GetInteriorMap(), Nektar::StdRegions::StdHexExp::v_GetInteriorMap(), Nektar::StdRegions::StdPyrExp::v_GetInteriorMap(), Nektar::LocalRegions::SegExp::v_GetNcoeffs(), Nektar::StdRegions::StdSegExp::v_HelmholtzMatrixOp(), Nektar::LocalRegions::SegExp::v_HelmholtzMatrixOp(), Nektar::StdRegions::StdExpansion2D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdExpansion3D::v_HelmholtzMatrixOp_MatFree(), Nektar::StdRegions::StdPointExp::v_IProductWRTBase(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase(), Nektar::LocalRegions::TriExp::v_IProductWRTBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdTetExp::v_IProductWRTBase_MatOp(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase_SumFac(), Nektar::StdRegions::StdQuadExp::v_IProductWRTBase_SumFacKernel(), Nektar::StdRegions::StdHexExp::v_IProductWRTBase_SumFacKernel(), Nektar::LocalRegions::TetExp::v_IProductWRTDerivBase(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdQuadExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdHexExp::v_IProductWRTDerivBase_MatOp(), Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_MatOp(), Nektar::LocalRegions::PrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::TriExp::v_IProductWRTDerivBase_SumFac(), Nektar::LocalRegions::QuadExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTriExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdPrismExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdTetExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdPyrExp::v_IProductWRTDerivBase_SumFac(), Nektar::StdRegions::StdExpansion2D::v_LaplacianMatrixOp_MatFree(), Nektar::LocalRegions::PyrExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::PrismExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::TetExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::HexExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::TriExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::LocalRegions::QuadExp::v_LaplacianMatrixOp_MatFree_Kernel(), Nektar::StdRegions::StdPrismExp::v_ReduceOrderCoeffs(), and Nektar::StdRegions::StdTetExp::v_ReduceOrderCoeffs().
|
protected |
Definition at line 1425 of file StdExpansion.h.
Referenced by GetStdMatrix(), Nektar::LocalRegions::Expansion2D::v_AddEdgeNormBoundaryInt(), Nektar::StdRegions::StdQuadExp::v_GeneralMatrixOp_MatOp(), Nektar::StdRegions::StdTriExp::v_GeneralMatrixOp_MatOp(), and Nektar::StdRegions::StdHexExp::v_GeneralMatrixOp_MatOp().
|
protected |
Definition at line 1426 of file StdExpansion.h.
Referenced by GetStdStaticCondMatrix(), Nektar::StdRegions::StdPointExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdQuadExp::v_FwdTrans_BndConstrained(), Nektar::StdRegions::StdTriExp::v_FwdTrans_BndConstrained(), and Nektar::StdRegions::StdSegExp::v_FwdTrans_BndConstrained().