|
| | TetExp (const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc, const SpatialDomains::TetGeomSharedPtr &geom) |
| | Constructor using BasisKey class for quadrature points and order definition. More...
|
| |
| | TetExp (const TetExp &T) |
| | Copy Constructor. More...
|
| |
| | ~TetExp () |
| | Destructor. More...
|
| |
| | StdTetExp () |
| |
| | StdTetExp (const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc) |
| |
| | StdTetExp (const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc, NekDouble *coeffs, NekDouble *phys) |
| |
| | StdTetExp (const StdTetExp &T) |
| |
| | ~StdTetExp () |
| |
| LibUtilities::ShapeType | DetShapeType () const |
| |
| NekDouble | PhysEvaluate3D (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &physvals) |
| | Single Point Evaluation. More...
|
| |
| | StdExpansion3D () |
| |
| | StdExpansion3D (int numcoeffs, const LibUtilities::BasisKey &Ba, const LibUtilities::BasisKey &Bb, const LibUtilities::BasisKey &Bc) |
| |
| | StdExpansion3D (const StdExpansion3D &T) |
| |
| virtual | ~StdExpansion3D () |
| |
| void | PhysTensorDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray_d1, Array< OneD, NekDouble > &outarray_d2, Array< OneD, NekDouble > &outarray_d3) |
| | Calculate the 3D derivative in the local tensor/collapsed coordinate at the physical points. More...
|
| |
| void | BwdTrans_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) |
| |
| void | IProductWRTBase_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) |
| |
| int | GetNedges () const |
| | return the number of edges in 3D expansion More...
|
| |
| int | GetEdgeNcoeffs (const int i) const |
| | This function returns the number of expansion coefficients belonging to the i-th edge. More...
|
| |
| void | GetEdgeInteriorToElementMap (const int tid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, Orientation traceOrient=eForwards) |
| |
| | 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 | GetTraceNcoeffs (const int i) const |
| | This function returns the number of expansion coefficients belonging to the i-th trace. More...
|
| |
| int | GetTraceIntNcoeffs (const int i) const |
| |
| int | GetTraceNumPoints (const int i) const |
| | This function returns the number of quadrature points belonging to the i-th trace. More...
|
| |
| const LibUtilities::BasisKey | GetTraceBasisKey (const int i, int k=-1) const |
| | This function returns the basis key belonging to the i-th trace. More...
|
| |
| LibUtilities::PointsKey | GetTracePointsKey (const int i, int k=-1) const |
| | This function returns the basis key belonging to the i-th trace. More...
|
| |
| int | NumBndryCoeffs (void) const |
| |
| int | NumDGBndryCoeffs (void) const |
| |
| const LibUtilities::PointsKey | GetNodalPointsKey () const |
| | This function returns the type of expansion Nodal point type if defined. More...
|
| |
| int | GetNtraces () 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...
|
| |
| std::shared_ptr< StdExpansion > | GetStdExp (void) const |
| |
| std::shared_ptr< StdExpansion > | GetLinStdExp (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) |
| |
| void | IProductWRTDirectionalDerivBase (const Array< OneD, const NekDouble > &direction, 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) |
| |
| 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) |
| |
| int | CalcNumberOfCoefficients (const std::vector< unsigned int > &nummodes, int &modes_offset) |
| |
| 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 | GetTraceToElementMap (const int tid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, Orientation traceOrient=eForwards, int P=-1, int Q=-1) |
| |
| void | GetTraceInteriorToElementMap (const int tid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, const Orientation traceOrient=eForwards) |
| |
| void | GetTraceNumModes (const int tid, int &numModes0, int &numModes1, const Orientation traceOrient=eDir1FwdDir1_Dir2FwdDir2) |
| |
| void | MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | MultiplyByStdQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| DNekMatSharedPtr | CreateGeneralMatrix (const StdMatrixKey &mkey) |
| | this function generates the mass matrix \(\mathbf{M}[i][j] = \int \phi_i(\mathbf{x}) \phi_j(\mathbf{x}) d\mathbf{x}\) 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 | ExponentialFilter (Array< OneD, NekDouble > &array, const NekDouble alpha, const NekDouble exponent, const NekDouble cutoff) |
| |
| 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) |
| |
| 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...
|
| |
| NekDouble | PhysEvaluateBasis (const Array< OneD, const NekDouble > &coords, int mode) |
| | This function evaluates the basis function mode mode at a point coords 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...
|
| |
| void | LocCollapsedToLocCoord (const Array< OneD, const NekDouble > &eta, Array< OneD, NekDouble > &xi) |
| | Convert local collapsed coordinates eta into local cartesian coordinate xi. 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) |
| |
| NekDouble | Linf (const Array< OneD, const NekDouble > &phys, const Array< OneD, const NekDouble > &sol=NullNekDouble1DArray) |
| | Function to evaluate the discrete \( L_\infty\) error \( |\epsilon|_\infty = \max |u - u_{exact}|\) where \( u_{exact}\) 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 \( L_2\) error, \( | \epsilon |_{2} = \left [ \int^1_{-1} [u - u_{exact}]^2 dx \right]^{1/2} d\xi_1 \) where \( u_{exact}\) 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 \( H^1\) error, \( | \epsilon |^1_{2} = \left [ \int^1_{-1} [u - u_{exact}]^2 + \nabla(u - u_{exact})\cdot\nabla(u - u_{exact})\cdot dx \right]^{1/2} d\xi_1 \) where \( u_{exact}\) is given by the array sol. More...
|
| |
| const LibUtilities::PointsKeyVector | GetPointsKeys () const |
| |
| 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 > |
| std::shared_ptr< T > | as () |
| |
| void | IProductWRTBase_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool multiplybyweights=true) |
| |
| void | GenStdMatBwdDeriv (const int dir, DNekMatSharedPtr &mat) |
| |
| | Expansion3D (SpatialDomains::Geometry3DSharedPtr pGeom) |
| |
| virtual | ~Expansion3D () |
| |
| void | SetTraceToGeomOrientation (Array< OneD, NekDouble > &inout) |
| | Align trace orientation with the geometry orientation. More...
|
| |
| void | SetFaceToGeomOrientation (const int face, Array< OneD, NekDouble > &inout) |
| | Align face orientation with the geometry orientation. More...
|
| |
| void | AddHDGHelmholtzFaceTerms (const NekDouble tau, const int edge, Array< OneD, NekDouble > &facePhys, const StdRegions::VarCoeffMap &dirForcing, Array< OneD, NekDouble > &outarray) |
| |
| void | AddNormTraceInt (const int dir, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, Array< OneD, NekDouble > > &faceCoeffs, Array< OneD, NekDouble > &outarray) |
| |
| void | AddNormTraceInt (const int dir, Array< OneD, const NekDouble > &inarray, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, NekDouble > &outarray, const StdRegions::VarCoeffMap &varcoeffs) |
| |
| void | AddFaceBoundaryInt (const int face, ExpansionSharedPtr &FaceExp, Array< OneD, NekDouble > &facePhys, Array< OneD, NekDouble > &outarray, const StdRegions::VarCoeffMap &varcoeffs=StdRegions::NullVarCoeffMap) |
| |
| SpatialDomains::Geometry3DSharedPtr | GetGeom3D () const |
| |
| void | v_ReOrientTracePhysMap (const StdRegions::Orientation orient, Array< OneD, int > &idmap, const int nq0, const int nq1) |
| |
| void | v_NormVectorIProductWRTBase (const Array< OneD, const Array< OneD, NekDouble > > &Fvec, Array< OneD, NekDouble > &outarray) |
| |
| Array< OneD, unsigned int > | GetEdgeInverseBoundaryMap (int eid) |
| |
| Array< OneD, unsigned int > | GetTraceInverseBoundaryMap (int fid, StdRegions::Orientation faceOrient=StdRegions::eNoOrientation, int P1=-1, int P2=-1) |
| |
| void | GetInverseBoundaryMaps (Array< OneD, unsigned int > &vmap, Array< OneD, Array< OneD, unsigned int > > &emap, Array< OneD, Array< OneD, unsigned int > > &fmap) |
| |
| | Expansion (SpatialDomains::GeometrySharedPtr pGeom) |
| |
| | Expansion (const Expansion &pSrc) |
| |
| virtual | ~Expansion () |
| |
| void | SetTraceExp (const int traceid, ExpansionSharedPtr &f) |
| |
| ExpansionSharedPtr | GetTraceExp (const int traceid) |
| |
| DNekScalMatSharedPtr | GetLocMatrix (const LocalRegions::MatrixKey &mkey) |
| |
| DNekScalMatSharedPtr | GetLocMatrix (const StdRegions::MatrixType mtype, const StdRegions::ConstFactorMap &factors=StdRegions::NullConstFactorMap, const StdRegions::VarCoeffMap &varcoeffs=StdRegions::NullVarCoeffMap) |
| |
| SpatialDomains::GeometrySharedPtr | GetGeom () const |
| |
| void | Reset () |
| |
| IndexMapValuesSharedPtr | CreateIndexMap (const IndexMapKey &ikey) |
| |
| const SpatialDomains::GeomFactorsSharedPtr & | GetMetricInfo () const |
| |
| DNekMatSharedPtr | BuildTransformationMatrix (const DNekScalMatSharedPtr &r_bnd, const StdRegions::MatrixType matrixType) |
| |
| DNekMatSharedPtr | BuildVertexMatrix (const DNekScalMatSharedPtr &r_bnd) |
| |
| void | ExtractDataToCoeffs (const NekDouble *data, const std::vector< unsigned int > &nummodes, const int nmodes_offset, NekDouble *coeffs, std::vector< LibUtilities::BasisType > &fromType) |
| |
| void | AddEdgeNormBoundaryInt (const int edge, const std::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray) |
| |
| void | AddEdgeNormBoundaryInt (const int edge, const std::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) |
| |
| void | AddFaceNormBoundaryInt (const int face, const std::shared_ptr< Expansion > &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) |
| |
| void | DGDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, ExpansionSharedPtr > &EdgeExp, Array< OneD, Array< OneD, NekDouble > > &coeffs, Array< OneD, NekDouble > &outarray) |
| |
| NekDouble | VectorFlux (const Array< OneD, Array< OneD, NekDouble > > &vec) |
| |
| IndexMapValuesSharedPtr | GetIndexMap (const IndexMapKey &ikey) |
| |
| void | AlignVectorToCollapsedDir (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray) |
| |
| ExpansionSharedPtr | GetLeftAdjacentElementExp () const |
| |
| ExpansionSharedPtr | GetRightAdjacentElementExp () const |
| |
| int | GetLeftAdjacentElementTrace () const |
| |
| int | GetRightAdjacentElementTrace () const |
| |
| void | SetAdjacentElementExp (int traceid, ExpansionSharedPtr &e) |
| |
| StdRegions::Orientation | GetTraceOrient (int trace) |
| |
| void | SetCoeffsToOrientation (StdRegions::Orientation dir, Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | DivideByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| | Divided by the metric jacobi and quadrature weights. More...
|
| |
| void | GetTraceQFactors (const int trace, 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 | GetTracePhysVals (const int trace, const StdRegions::StdExpansionSharedPtr &TraceExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, StdRegions::Orientation orient=StdRegions::eNoOrientation) |
| |
| void | GetTracePhysMap (const int edge, Array< OneD, int > &outarray) |
| |
| void | ReOrientTracePhysMap (const StdRegions::Orientation orient, Array< OneD, int > &idmap, const int nq0, const int nq1) |
| |
| const NormalVector & | GetTraceNormal (const int id) const |
| |
| void | ComputeTraceNormal (const int id) |
| |
| const Array< OneD, const NekDouble > & | GetPhysNormals (void) |
| |
| void | SetPhysNormals (Array< OneD, const NekDouble > &normal) |
| |
| void | SetUpPhysNormals (const int trace) |
| |
| void | AddRobinMassMatrix (const int traceid, const Array< OneD, const NekDouble > &primCoeffs, DNekMatSharedPtr &inoutmat) |
| |
| virtual void | AddRobinTraceContribution (const int traceid, const Array< OneD, const NekDouble > &primCoeffs, const Array< OneD, NekDouble > &incoeffs, Array< OneD, NekDouble > &coeffs) |
| |
| const Array< OneD, const NekDouble > & | GetElmtBndNormDirElmtLen (const int nbnd) const |
| |
| virtual NekDouble | v_Integral (const Array< OneD, const NekDouble > &inarray) |
| | Integrate the physical point list inarray over region. More...
|
| |
| virtual void | v_PhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2) |
| | Differentiate inarray in the three coordinate directions. More...
|
| |
| virtual void | v_FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| | Forward transform from physical quadrature space stored in inarray and evaluate the expansion coefficients and store in (this)->_coeffs. More...
|
| |
| virtual void | v_IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| | Calculate the inner product of inarray with respect to the basis B=m_base0*m_base1*m_base2 and put into outarray: More...
|
| |
| virtual void | v_IProductWRTBase_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool multiplybyweights=true) |
| |
| virtual void | v_IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| | Calculates the inner product \( I_{pqr} = (u, \partial_{x_i} \phi_{pqr}) \). More...
|
| |
| virtual void | v_AlignVectorToCollapsedDir (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray) |
| |
| virtual NekDouble | v_StdPhysEvaluate (const Array< OneD, const NekDouble > &Lcoord, const Array< OneD, const NekDouble > &physvals) |
| |
| virtual NekDouble | v_PhysEvaluate (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &physvals) |
| |
| virtual void | v_GetCoord (const Array< OneD, const NekDouble > &Lcoords, Array< OneD, NekDouble > &coords) |
| | Get the coordinates "coords" at the local coordinates "Lcoords". More...
|
| |
| virtual void | v_GetCoords (Array< OneD, NekDouble > &coords_1, Array< OneD, NekDouble > &coords_2, Array< OneD, NekDouble > &coords_3) |
| |
| virtual LibUtilities::ShapeType | v_DetShapeType () const |
| | Return Shape of region, using ShapeType enum list. More...
|
| |
| virtual StdRegions::StdExpansionSharedPtr | v_GetStdExp (void) const |
| |
| virtual StdRegions::StdExpansionSharedPtr | v_GetLinStdExp (void) const |
| |
| virtual int | v_GetCoordim () |
| |
| virtual void | v_ExtractDataToCoeffs (const NekDouble *data, const std::vector< unsigned int > &nummodes, const int mode_offset, NekDouble *coeffs, std::vector< LibUtilities::BasisType > &fromType) |
| |
| virtual void | v_GetTracePhysMap (const int face, Array< OneD, int > &outarray) |
| | Returns the physical values at the quadrature points of a face. More...
|
| |
| void | v_ComputeTraceNormal (const int face) |
| | Compute the normal of a triangular face. More...
|
| |
| virtual void | v_HelmholtzMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual void | v_LaplacianMatrixOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual void | v_LaplacianMatrixOp (const int k1, const int k2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual void | v_SVVLaplacianFilter (Array< OneD, NekDouble > &array, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual DNekMatSharedPtr | v_GenMatrix (const StdRegions::StdMatrixKey &mkey) |
| |
| DNekScalMatSharedPtr | CreateMatrix (const MatrixKey &mkey) |
| |
| DNekScalBlkMatSharedPtr | CreateStaticCondMatrix (const MatrixKey &mkey) |
| |
| virtual DNekMatSharedPtr | v_CreateStdMatrix (const StdRegions::StdMatrixKey &mkey) |
| |
| virtual DNekScalMatSharedPtr | v_GetLocMatrix (const MatrixKey &mkey) |
| |
| virtual DNekScalBlkMatSharedPtr | v_GetLocStaticCondMatrix (const MatrixKey &mkey) |
| |
| void | v_DropLocStaticCondMatrix (const MatrixKey &mkey) |
| |
| void | SetUpInverseTransformationMatrix (const DNekMatSharedPtr &m_transformationmatrix, DNekMatSharedPtr m_inversetransformationmatrix, DNekMatSharedPtr m_inversetransposedtransformationmatrix) |
| |
| void | v_ComputeConditionNumberOfMatrix (const DNekScalMatSharedPtr &mat) |
| |
| virtual void | v_ComputeLaplacianMetric () |
| |
| virtual void | v_PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_StdPhysDeriv (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d0, Array< OneD, NekDouble > &out_d1, Array< OneD, NekDouble > &out_d2) |
| |
| virtual void | v_StdPhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_BwdTrans_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_BwdTrans_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) |
| |
| virtual void | v_IProductWRTBase_MatOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_IProductWRTBase_SumFacKernel (const Array< OneD, const NekDouble > &base0, const Array< OneD, const NekDouble > &base1, const Array< OneD, const NekDouble > &base2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp, bool doCheckCollDir0, bool doCheckCollDir1, bool doCheckCollDir2) |
| |
| virtual void | v_IProductWRTDerivBase_MatOp (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_IProductWRTDerivBase_SumFac (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_LocCoordToLocCollapsed (const Array< OneD, const NekDouble > &xi, Array< OneD, NekDouble > &eta) |
| |
| virtual void | v_LocCollapsedToLocCoord (const Array< OneD, const NekDouble > &eta, Array< OneD, NekDouble > &xi) |
| |
| virtual void | v_FillMode (const int mode, Array< OneD, NekDouble > &outarray) |
| |
| NekDouble | v_PhysEvaluateBasis (const Array< OneD, const NekDouble > &coords, int mode) final |
| |
| virtual void | v_GetTraceNumModes (const int fid, int &numModes0, int &numModes1, Orientation traceOrient=eDir1FwdDir1_Dir2FwdDir2) |
| |
| virtual int | v_GetNverts () const |
| |
| virtual int | v_GetNedges () const |
| |
| virtual int | v_GetNtraces () const |
| |
| virtual int | v_NumBndryCoeffs () const |
| |
| virtual int | v_NumDGBndryCoeffs () const |
| |
| virtual int | v_GetTraceNcoeffs (const int i) const |
| |
| virtual int | v_GetTotalTraceIntNcoeffs () const |
| |
| virtual int | v_GetTraceIntNcoeffs (const int i) const |
| |
| virtual int | v_GetTraceNumPoints (const int i) const |
| |
| virtual int | v_GetEdgeNcoeffs (const int i) const |
| |
| virtual LibUtilities::PointsKey | v_GetTracePointsKey (const int i, const int j) const |
| |
| virtual int | v_CalcNumberOfCoefficients (const std::vector< unsigned int > &nummodes, int &modes_offset) |
| |
| virtual const LibUtilities::BasisKey | v_GetTraceBasisKey (const int i, const int k) const |
| |
| virtual bool | v_IsBoundaryInteriorExpansion () |
| |
| virtual int | v_GetVertexMap (int localVertexId, bool useCoeffPacking=false) |
| |
| virtual void | v_GetInteriorMap (Array< OneD, unsigned int > &outarray) |
| |
| virtual void | v_GetBoundaryMap (Array< OneD, unsigned int > &outarray) |
| |
| virtual void | v_GetTraceToElementMap (const int fid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, Orientation faceOrient, int P, int Q) |
| |
| virtual void | v_GetEdgeInteriorToElementMap (const int tid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, const Orientation traceOrient=eDir1FwdDir1_Dir2FwdDir2) |
| |
| virtual void | v_GetTraceInteriorToElementMap (const int tid, Array< OneD, unsigned int > &maparray, Array< OneD, int > &signarray, const Orientation traceOrient=eDir1FwdDir1_Dir2FwdDir2) |
| |
| virtual void | v_MultiplyByStdQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_ReduceOrderCoeffs (int numMin, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_GetSimplexEquiSpacedConnectivity (Array< OneD, int > &conn, bool standard=true) |
| |
| virtual NekDouble | v_PhysEvaluate (const Array< OneD, DNekMatSharedPtr > &I, const Array< OneD, const NekDouble > &physvals) |
| |
| virtual void | v_LaplacianMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual void | v_HelmholtzMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::StdMatrixKey &mkey) |
| |
| virtual void | v_GenStdMatBwdDeriv (const int dir, DNekMatSharedPtr &mat) |
| |
| DNekMatSharedPtr | CreateStdMatrix (const StdMatrixKey &mkey) |
| |
| DNekBlkMatSharedPtr | CreateStdStaticCondMatrix (const StdMatrixKey &mkey) |
| | Create the static condensation of a matrix when using a boundary interior decomposition. More...
|
| |
| void | BwdTrans_MatOp (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | BwdTrans_SumFac (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | IProductWRTDerivBase_SumFac (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | IProductWRTDirectionalDerivBase_SumFac (const Array< OneD, const NekDouble > &direction, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| void | GeneralMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | MassMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | LaplacianMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | LaplacianMatrixOp_MatFree_Kernel (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, Array< OneD, NekDouble > &wsp) |
| |
| void | LaplacianMatrixOp_MatFree_GenericImpl (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | LaplacianMatrixOp_MatFree (const int k1, const int k2, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | WeakDerivMatrixOp_MatFree (const int i, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | WeakDirectionalDerivMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | MassLevelCurvatureMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | LinearAdvectionDiffusionReactionMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey, bool addDiffusionTerm=true) |
| |
| void | HelmholtzMatrixOp_MatFree (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| void | HelmholtzMatrixOp_MatFree_GenericImpl (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdMatrixKey &mkey) |
| |
| virtual void | v_SetCoeffsToOrientation (Array< OneD, NekDouble > &coeffs, StdRegions::Orientation dir) |
| |
| template<int DIR> |
| NekDouble | BaryEvaluate (const NekDouble &coord, const NekDouble *physvals) |
| | This function performs the barycentric interpolation of the polynomial stored in coord at a point physvals using barycentric interpolation weights in direction. More...
|
| |
| template<int DIR> |
| NekDouble | BaryEvaluateBasis (const NekDouble &coord, const int &mode) |
| |
| virtual void | v_DGDeriv (const int dir, const Array< OneD, const NekDouble > &incoeffs, Array< OneD, ExpansionSharedPtr > &FaceExp, Array< OneD, Array< OneD, NekDouble > > &faceCoeffs, Array< OneD, NekDouble > &out_d) |
| | Evaluate coefficients of weak deriviative in the direction dir given the input coefficicents incoeffs and the imposed boundary values in EdgeExp (which will have its phys space updated). More...
|
| |
| virtual void | v_AddFaceNormBoundaryInt (const int face, const ExpansionSharedPtr &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_AddRobinMassMatrix (const int face, const Array< OneD, const NekDouble > &primCoeffs, DNekMatSharedPtr &inoutmat) |
| |
| virtual StdRegions::Orientation | v_GetTraceOrient (int face) |
| |
| virtual void | v_GetTracePhysVals (const int face, const StdRegions::StdExpansionSharedPtr &FaceExp, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, StdRegions::Orientation orient) |
| | Extract the physical values along face face from inarray into outarray following the local face orientation and point distribution defined by defined in FaceExp. More...
|
| |
| void | GetPhysFaceVarCoeffsFromElement (const int face, ExpansionSharedPtr &FaceExp, const Array< OneD, const NekDouble > &varcoeff, Array< OneD, NekDouble > &outarray) |
| |
| virtual Array< OneD, NekDouble > | v_GetnFacecdotMF (const int dir, const int face, ExpansionSharedPtr &FaceExp_f, const Array< OneD, const Array< OneD, NekDouble > > &normals, const StdRegions::VarCoeffMap &varcoeffs) |
| |
| virtual DNekMatSharedPtr | v_BuildTransformationMatrix (const DNekScalMatSharedPtr &r_bnd, const StdRegions::MatrixType matrixType) |
| |
| virtual DNekMatSharedPtr | v_BuildInverseTransformationMatrix (const DNekScalMatSharedPtr &transformationmatrix) |
| | Build inverse and inverse transposed transformation matrix: \(\mathbf{R^{-1}}\) and \(\mathbf{R^{-T}}\). More...
|
| |
| virtual DNekMatSharedPtr | v_BuildVertexMatrix (const DNekScalMatSharedPtr &r_bnd) |
| |
| virtual const NormalVector & | v_GetTraceNormal (const int face) const |
| |
| void | ComputeLaplacianMetric () |
| |
| void | ComputeQuadratureMetric () |
| |
| void | ComputeGmatcdotMF (const Array< TwoD, const NekDouble > &df, const Array< OneD, const NekDouble > &direction, Array< OneD, Array< OneD, NekDouble > > &dfdir) |
| |
| virtual void | v_MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_DivideByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| Array< OneD, NekDouble > | v_GetMF (const int dir, const int shapedim, const StdRegions::VarCoeffMap &varcoeffs) |
| |
| Array< OneD, NekDouble > | v_GetMFDiv (const int dir, const StdRegions::VarCoeffMap &varcoeffs) |
| |
| Array< OneD, NekDouble > | v_GetMFMag (const int dir, const StdRegions::VarCoeffMap &varcoeffs) |
| |
| virtual void | v_AddEdgeNormBoundaryInt (const int edge, const std::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_AddEdgeNormBoundaryInt (const int edge, const std::shared_ptr< Expansion > &EdgeExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_AddFaceNormBoundaryInt (const int face, const std::shared_ptr< Expansion > &FaceExp, const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) |
| |
| virtual NekDouble | v_VectorFlux (const Array< OneD, Array< OneD, NekDouble > > &vec) |
| |
| virtual void | v_SetCoeffsToOrientation (StdRegions::Orientation dir, Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) |
| |
| virtual void | v_GetTraceQFactors (const int trace, Array< OneD, NekDouble > &outarray) |
| |
| virtual const Array< OneD, const NekDouble > & | v_GetPhysNormals (void) |
| |
| virtual void | v_SetPhysNormals (Array< OneD, const NekDouble > &normal) |
| |
| virtual void | v_SetUpPhysNormals (const int id) |
| |
| virtual void | v_AddRobinTraceContribution (const int traceid, const Array< OneD, const NekDouble > &primCoeffs, const Array< OneD, NekDouble > &incoeffs, Array< OneD, NekDouble > &coeffs) |
| |
| Array< OneD, LibUtilities::BasisSharedPtr > | m_base |
| |
| int | m_elmt_id |
| |
| int | m_ncoeffs |
| |
| LibUtilities::NekManager< StdMatrixKey, DNekMat, StdMatrixKey::opLess > | m_stdMatrixManager |
| |
| LibUtilities::NekManager< StdMatrixKey, DNekBlkMat, StdMatrixKey::opLess > | m_stdStaticCondMatrixManager |
| |
| std::map< int, NormalVector > | m_faceNormals |
| |
| LibUtilities::NekManager< IndexMapKey, IndexMapValues, IndexMapKey::opLess > | m_indexMapManager |
| |
| std::vector< ExpansionWeakPtr > | m_traceExp |
| |
| SpatialDomains::GeometrySharedPtr | m_geom |
| |
| SpatialDomains::GeomFactorsSharedPtr | m_metricinfo |
| |
| MetricMap | m_metrics |
| |
| ExpansionWeakPtr | m_elementLeft |
| |
| ExpansionWeakPtr | m_elementRight |
| |
| int | m_elementTraceLeft = -1 |
| |
| int | m_elementTraceRight = -1 |
| |
| std::map< int, Array< OneD, NekDouble > > | m_elmtBndNormDirElmtLen |
| | the element length in each element boundary(Vertex, edge or face) normal direction calculated based on the local m_metricinfo times the standard element length (which is 2.0) More...
|
| |