Nektar++
Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
Nektar::MultiRegions::ContField Class Reference

This class is the abstraction of a global continuous two- dimensional spectral/hp element expansion which approximates the solution of a set of partial differential equations. More...

#include <ContField.h>

Inheritance diagram for Nektar::MultiRegions::ContField:
[legend]

Public Member Functions

 ContField ()
 The default constructor. More...
 
 ContField (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::MeshGraphSharedPtr &graph2D, const std::string &variable="DefaultVar", const bool DeclareCoeffPhysArrays=true, const bool CheckIfSingularSystem=false, const Collections::ImplementationType ImpType=Collections::eNoImpType)
 This constructor sets up global continuous field based on an input mesh and boundary conditions. More...
 
 ContField (const ContField &In, const SpatialDomains::MeshGraphSharedPtr &graph2D, const std::string &variable, const bool DeclareCoeffPhysArrays=true, const bool CheckIfSingularSystem=false)
 Construct a global continuous field with solution type based on another field but using a separate input mesh and boundary conditions. More...
 
 ContField (const ContField &In, bool DeclareCoeffPhysArrays=true)
 The copy constructor. More...
 
 ContField (const LibUtilities::SessionReaderSharedPtr &pSession, const ExpList &In)
 Copy constructor. More...
 
virtual ~ContField ()
 The default destructor. More...
 
void Assemble ()
 Assembles the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
void Assemble (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) const
 Assembles the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
const AssemblyMapCGSharedPtrGetLocalToGlobalMap () const
 Returns the map from local to global level. More...
 
void FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 Performs the global forward transformation of a function \(f(\boldsymbol{x})\), subject to the boundary conditions specified. More...
 
void MultiplyByInvMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 Multiply a solution by the inverse mass matrix. More...
 
void LaplaceSolve (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray, const Array< OneD, Array< OneD, NekDouble >> &variablecoeffs=NullNekDoubleArrayOfArray, NekDouble time=0.0)
 Solves the two-dimensional Laplace equation, subject to the boundary conditions specified. More...
 
void LinearAdvectionEigs (const NekDouble ax, const NekDouble ay, Array< OneD, NekDouble > &Real, Array< OneD, NekDouble > &Imag, Array< OneD, NekDouble > &Evecs=NullNekDouble1DArray)
 Compute the eigenvalues of the linear advection operator. More...
 
const Array< OneD, const MultiRegions::ExpListSharedPtr > & GetBndCondExpansions ()
 Returns the boundary conditions expansion. More...
 
const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & GetBndConditions ()
 Returns the boundary conditions. More...
 
int GetGlobalMatrixNnz (const GlobalMatrixKey &gkey)
 
void GlobalSolve (const GlobalLinSysKey &key, const Array< OneD, const NekDouble > &rhs, Array< OneD, NekDouble > &inout, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray)
 Solves the linear system specified by the key key. More...
 
const GJPStabilisationSharedPtr GetGJPForcing ()
 
void SetGJPForcing (const GJPStabilisationSharedPtr &GJPData)
 
- Public Member Functions inherited from Nektar::MultiRegions::DisContField
 DisContField ()
 Default constructor. More...
 
 DisContField (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::MeshGraphSharedPtr &graph, const std::string &variable, const bool SetUpJustDG=true, const bool DeclareCoeffPhysArrays=true, const Collections::ImplementationType ImpType=Collections::eNoImpType, const std::string bcvariable="NotSet")
 Constructs a 1D discontinuous field based on a mesh and boundary conditions. More...
 
 DisContField (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::MeshGraphSharedPtr &graph1D, const SpatialDomains::CompositeMap &domain, const SpatialDomains::BoundaryConditions &Allbcs, const std::string &variable, const LibUtilities::CommSharedPtr &comm, bool SetToOneSpaceDimensions=false, const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Constructor for a DisContField from a List of subdomains New Constructor for arterial network. More...
 
 DisContField (const DisContField &In, const bool DeclareCoeffPhysArrays=true)
 Constructs a 1D discontinuous field based on an existing field. More...
 
 DisContField (const DisContField &In, const SpatialDomains::MeshGraphSharedPtr &graph, const std::string &variable, const bool SetUpJustDG=false, const bool DeclareCoeffPhysArrays=true)
 
 DisContField (const ExpList &In)
 Constructs a 1D discontinuous field based on an existing field. (needed in order to use ContField( const ExpList &In) constructor. More...
 
virtual ~DisContField ()
 Destructor. More...
 
GlobalLinSysSharedPtr GetGlobalBndLinSys (const GlobalLinSysKey &mkey)
 For a given key, returns the associated global linear system. More...
 
bool SameTypeOfBoundaryConditions (const DisContField &In)
 Check to see if expansion has the same BCs as In. More...
 
std::vector< bool > & GetNegatedFluxNormal (void)
 
NekDouble L2_DGDeriv (const int dir, const Array< OneD, const NekDouble > &coeffs, const Array< OneD, const NekDouble > &soln)
 Calculate the \( L^2 \) error of the \( Q_{\rm dir} \) derivative using the consistent DG evaluation of \( Q_{\rm dir} \). More...
 
void EvaluateHDGPostProcessing (const Array< OneD, const NekDouble > &coeffs, Array< OneD, NekDouble > &outarray)
 Evaluate HDG post-processing to increase polynomial order of solution. More...
 
void GetLocTraceToTraceMap (LocTraceToTraceMapSharedPtr &LocTraceToTraceMap)
 
- Public Member Functions inherited from Nektar::MultiRegions::ExpList
 ExpList (const ExpansionType Type=eNoType)
 The default constructor using a type. More...
 
 ExpList (const ExpList &in, const bool DeclareCoeffPhysArrays=true)
 The copy constructor. More...
 
 ExpList (const ExpList &in, const std::vector< unsigned int > &eIDs, const bool DeclareCoeffPhysArrays=true, const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Constructor copying only elements defined in eIds. More...
 
 ExpList (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::MeshGraphSharedPtr &graph, const bool DeclareCoeffPhysArrays=true, const std::string &var="DefaultVar", const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Generate an ExpList from a meshgraph graph and session file. More...
 
 ExpList (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::ExpansionInfoMap &expansions, const bool DeclareCoeffPhysArrays=true, const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Sets up a list of local expansions based on an expansion Map. More...
 
 ExpList (const SpatialDomains::PointGeomSharedPtr &geom)
 Specialised constructors for 0D Expansions Wrapper around LocalRegion::PointExp - used in PrePacing.cpp. More...
 
 ExpList (const LibUtilities::SessionReaderSharedPtr &pSession, const Array< OneD, const ExpListSharedPtr > &bndConstraint, const Array< OneD, const SpatialDomains ::BoundaryConditionShPtr > &bndCond, const LocalRegions::ExpansionVector &locexp, const SpatialDomains::MeshGraphSharedPtr &graph, const LibUtilities::CommSharedPtr &comm, const bool DeclareCoeffPhysArrays=true, const std::string variable="DefaultVar", const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Generate expansions for the trace space expansions used in DisContField. More...
 
 ExpList (const LibUtilities::SessionReaderSharedPtr &pSession, const LocalRegions::ExpansionVector &locexp, const SpatialDomains::MeshGraphSharedPtr &graph, const bool DeclareCoeffPhysArrays, const std::string variable, const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Generate an trace ExpList from a meshgraph graph and session file. More...
 
 ExpList (const LibUtilities::SessionReaderSharedPtr &pSession, const SpatialDomains::CompositeMap &domain, const SpatialDomains::MeshGraphSharedPtr &graph, const bool DeclareCoeffPhysArrays=true, const std::string variable="DefaultVar", bool SetToOneSpaceDimension=false, const LibUtilities::CommSharedPtr comm=LibUtilities::CommSharedPtr(), const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Constructor based on domain information only for 1D & 2D boundary conditions. More...
 
virtual ~ExpList ()
 The default destructor. More...
 
int GetNcoeffs (void) const
 Returns the total number of local degrees of freedom \(N_{\mathrm{eof}}=\sum_{e=1}^{{N_{\mathrm{el}}}}N^{e}_m\). More...
 
int GetNcoeffs (const int eid) const
 Returns the total number of local degrees of freedom for element eid. More...
 
ExpansionType GetExpType (void)
 Returns the type of the expansion. More...
 
void SetExpType (ExpansionType Type)
 Returns the type of the expansion. More...
 
int EvalBasisNumModesMax (void) const
 Evaulates the maximum number of modes in the elemental basis order over all elements. More...
 
const Array< OneD, int > EvalBasisNumModesMaxPerExp (void) const
 Returns the vector of the number of modes in the elemental basis order over all elements. More...
 
int GetTotPoints (void) const
 Returns the total number of quadrature points m_npoints \(=Q_{\mathrm{tot}}\). More...
 
int GetTotPoints (const int eid) const
 Returns the total number of quadrature points for eid's element \(=Q_{\mathrm{tot}}\). More...
 
int GetNpoints (void) const
 Returns the total number of quadrature points m_npoints \(=Q_{\mathrm{tot}}\). More...
 
int Get1DScaledTotPoints (const NekDouble scale) const
 Returns the total number of qudature points scaled by the factor scale on each 1D direction. More...
 
void SetWaveSpace (const bool wavespace)
 Sets the wave space to the one of the possible configuration true or false. More...
 
void SetModifiedBasis (const bool modbasis)
 Set Modified Basis for the stability analysis. More...
 
bool GetWaveSpace (void) const
 This function returns the third direction expansion condition, which can be in wave space (coefficient) or not It is stored in the variable m_WaveSpace. More...
 
void SetPhys (int i, NekDouble val)
 Set the i th value of m_phys to value val. More...
 
void SetPhys (const Array< OneD, const NekDouble > &inarray)
 Fills the array m_phys. More...
 
void SetPhysArray (Array< OneD, NekDouble > &inarray)
 Sets the array m_phys. More...
 
void SetPhysState (const bool physState)
 This function manually sets whether the array of physical values \(\boldsymbol{u}_l\) (implemented as m_phys) is filled or not. More...
 
bool GetPhysState (void) const
 This function indicates whether the array of physical values \(\boldsymbol{u}_l\) (implemented as m_phys) is filled or not. More...
 
void MultiplyByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 multiply the metric jacobi and quadrature weights More...
 
void DivideByQuadratureMetric (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 Divided by the metric jacobi and quadrature weights. More...
 
void IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function calculates the inner product of a function \(f(\boldsymbol{x})\) with respect to all local expansion modes \(\phi_n^e(\boldsymbol{x})\). More...
 
void IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function calculates the inner product of a function \(f(\boldsymbol{x})\) with respect to the derivative (in direction. More...
 
void IProductWRTDirectionalDerivBase (const Array< OneD, const NekDouble > &direction, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 Directional derivative along a given direction. More...
 
void IProductWRTDerivBase (const Array< OneD, const Array< OneD, NekDouble >> &inarray, Array< OneD, NekDouble > &outarray)
 This function calculates the inner product of a function \(f(\boldsymbol{x})\) with respect to the derivative of all local expansion modes \(\phi_n^e(\boldsymbol{x})\). More...
 
void FwdTransLocalElmt (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function elementally evaluates the forward transformation of a function \(u(\boldsymbol{x})\) onto the global spectral/hp expansion. More...
 
void FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
void ExponentialFilter (Array< OneD, NekDouble > &array, const NekDouble alpha, const NekDouble exponent, const NekDouble cutoff)
 
void MultiplyByElmtInvMass (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function elementally mulplies the coefficient space of Sin my the elemental inverse of the mass matrix. More...
 
void MultiplyByInvMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
void MultiplyByMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
void SmoothField (Array< OneD, NekDouble > &field)
 Smooth a field across elements. More...
 
GlobalLinSysKey HelmSolve (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::ConstFactorMap &factors, const StdRegions::VarCoeffMap &varcoeff=StdRegions::NullVarCoeffMap, const MultiRegions::VarFactorsMap &varfactors=MultiRegions::NullVarFactorsMap, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray, const bool PhysSpaceForcing=true)
 Solve helmholtz problem. More...
 
GlobalLinSysKey LinearAdvectionDiffusionReactionSolve (const Array< OneD, Array< OneD, NekDouble >> &velocity, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const NekDouble lambda, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray)
 Solve Advection Diffusion Reaction. More...
 
void LinearAdvectionReactionSolve (const Array< OneD, Array< OneD, NekDouble >> &velocity, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const NekDouble lambda, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray)
 Solve Advection Diffusion Reaction. More...
 
void FwdTransBndConstrained (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
void BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function elementally evaluates the backward transformation of the global spectral/hp element expansion. More...
 
void GetCoords (Array< OneD, NekDouble > &coord_0, Array< OneD, NekDouble > &coord_1=NullNekDouble1DArray, Array< OneD, NekDouble > &coord_2=NullNekDouble1DArray)
 This function calculates the coordinates of all the elemental quadrature points \(\boldsymbol{x}_i\). More...
 
void GetCoords (const int eid, Array< OneD, NekDouble > &coord_0, Array< OneD, NekDouble > &coord_1=NullNekDouble1DArray, Array< OneD, NekDouble > &coord_2=NullNekDouble1DArray)
 
void HomogeneousFwdTrans (const int npts, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool Shuff=true, bool UnShuff=true)
 
void HomogeneousBwdTrans (const int npts, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool Shuff=true, bool UnShuff=true)
 
void DealiasedProd (const int num_dofs, const Array< OneD, NekDouble > &inarray1, const Array< OneD, NekDouble > &inarray2, Array< OneD, NekDouble > &outarray)
 
void DealiasedDotProd (const int num_dofs, const Array< OneD, Array< OneD, NekDouble >> &inarray1, const Array< OneD, Array< OneD, NekDouble >> &inarray2, Array< OneD, Array< OneD, NekDouble >> &outarray)
 
void GetBCValues (Array< OneD, NekDouble > &BndVals, const Array< OneD, NekDouble > &TotField, int BndID)
 
void NormVectorIProductWRTBase (Array< OneD, const NekDouble > &V1, Array< OneD, const NekDouble > &V2, Array< OneD, NekDouble > &outarray, int BndID)
 
void NormVectorIProductWRTBase (Array< OneD, Array< OneD, NekDouble >> &V, Array< OneD, NekDouble > &outarray)
 
void ApplyGeomInfo ()
 Apply geometry information to each expansion. More...
 
void Reset ()
 Reset geometry information and reset matrices. More...
 
void WriteTecplotHeader (std::ostream &outfile, std::string var="")
 
void WriteTecplotZone (std::ostream &outfile, int expansion=-1)
 
void WriteTecplotField (std::ostream &outfile, int expansion=-1)
 
void WriteTecplotConnectivity (std::ostream &outfile, int expansion=-1)
 
void WriteVtkHeader (std::ostream &outfile)
 
void WriteVtkFooter (std::ostream &outfile)
 
void WriteVtkPieceHeader (std::ostream &outfile, int expansion, int istrip=0)
 
void WriteVtkPieceFooter (std::ostream &outfile, int expansion)
 
void WriteVtkPieceData (std::ostream &outfile, int expansion, std::string var="v")
 
int GetCoordim (int eid)
 This function returns the dimension of the coordinates of the element eid. More...
 
void SetCoeff (int i, NekDouble val)
 Set the i th coefficiient in m_coeffs to value val. More...
 
void SetCoeffs (int i, NekDouble val)
 Set the i th coefficiient in m_coeffs to value val. More...
 
void SetCoeffsArray (Array< OneD, NekDouble > &inarray)
 Set the m_coeffs array to inarray. More...
 
int GetShapeDimension ()
 This function returns the dimension of the shape of the element eid. More...
 
const Array< OneD, const NekDouble > & GetCoeffs () const
 This function returns (a reference to) the array \(\boldsymbol{\hat{u}}_l\) (implemented as m_coeffs) containing all local expansion coefficients. More...
 
void ImposeDirichletConditions (Array< OneD, NekDouble > &outarray)
 Impose Dirichlet Boundary Conditions onto Array. More...
 
void FillBndCondFromField (const Array< OneD, NekDouble > coeffs)
 Fill Bnd Condition expansion from the values stored in expansion. More...
 
void FillBndCondFromField (const int nreg, const Array< OneD, NekDouble > coeffs)
 Fill Bnd Condition expansion in nreg from the values stored in expansion. More...
 
void LocalToGlobal (bool useComm=true)
 Gathers the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
void LocalToGlobal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool useComm=true)
 
void GlobalToLocal (void)
 Scatters from the global coefficients \(\boldsymbol{\hat{u}}_g\) to the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
void GlobalToLocal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
NekDouble GetCoeff (int i)
 Get the i th value (coefficient) of m_coeffs. More...
 
NekDouble GetCoeffs (int i)
 Get the i th value (coefficient) of m_coeffs. More...
 
const Array< OneD, const NekDouble > & GetPhys () const
 This function returns (a reference to) the array \(\boldsymbol{u}_l\) (implemented as m_phys) containing the function \(u^{\delta}(\boldsymbol{x})\) evaluated at the quadrature points. More...
 
NekDouble Linf (const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &soln=NullNekDouble1DArray)
 This function calculates the \(L_\infty\) error of the global spectral/hp element approximation. More...
 
NekDouble L2 (const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &soln=NullNekDouble1DArray)
 This function calculates the \(L_\infty\) error of the global This function calculates the \(L_2\) error with respect to soln of the global spectral/hp element approximation. More...
 
NekDouble H1 (const Array< OneD, const NekDouble > &inarray, const Array< OneD, const NekDouble > &soln=NullNekDouble1DArray)
 Calculates the \(H^1\) error of the global spectral/hp element approximation. More...
 
NekDouble Integral ()
 Calculates the \(H^1\) error of the global spectral/hp element approximation. More...
 
NekDouble Integral (const Array< OneD, const NekDouble > &inarray)
 
NekDouble VectorFlux (const Array< OneD, Array< OneD, NekDouble >> &inarray)
 
Array< OneD, const NekDoubleHomogeneousEnergy (void)
 This function calculates the energy associated with each one of the modesof a 3D homogeneous nD expansion. More...
 
void SetHomo1DSpecVanVisc (Array< OneD, NekDouble > visc)
 This function sets the Spectral Vanishing Viscosity in homogeneous1D expansion. More...
 
Array< OneD, const unsigned int > GetZIDs (void)
 This function returns a vector containing the wave numbers in z-direction associated with the 3D homogenous expansion. Required if a parellelisation is applied in the Fourier direction. More...
 
LibUtilities::TranspositionSharedPtr GetTransposition (void)
 This function returns the transposition class associated with the homogeneous expansion. More...
 
NekDouble GetHomoLen (void)
 This function returns the Width of homogeneous direction associated with the homogeneous expansion. More...
 
void SetHomoLen (const NekDouble lhom)
 This function sets the Width of homogeneous direction associated with the homogeneous expansion. More...
 
Array< OneD, const unsigned int > GetYIDs (void)
 This function returns a vector containing the wave numbers in y-direction associated with the 3D homogenous expansion. Required if a parellelisation is applied in the Fourier direction. More...
 
void PhysInterp1DScaled (const NekDouble scale, const Array< OneD, NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function interpolates the physical space points in inarray to outarray using the same points defined in the expansion but where the number of points are rescaled by 1DScale. More...
 
void PhysGalerkinProjection1DScaled (const NekDouble scale, const Array< OneD, NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function Galerkin projects the physical space points in inarray to outarray where inarray is assumed to be defined in the expansion but where the number of points are rescaled by 1DScale. More...
 
int GetExpSize (void)
 This function returns the number of elements in the expansion. More...
 
size_t GetNumElmts (void)
 This function returns the number of elements in the expansion which may be different for a homogeoenous extended expansionp. More...
 
const std::shared_ptr< LocalRegions::ExpansionVectorGetExp () const
 This function returns the vector of elements in the expansion. More...
 
LocalRegions::ExpansionSharedPtrGetExp (int n) const
 This function returns (a shared pointer to) the local elemental expansion of the \(n^{\mathrm{th}}\) element. More...
 
LocalRegions::ExpansionSharedPtrGetExpFromGeomId (int n)
 This function returns (a shared pointer to) the local elemental expansion of the \(n^{\mathrm{th}}\) element given a global geometry ID. More...
 
LocalRegions::ExpansionSharedPtrGetExp (const Array< OneD, const NekDouble > &gloCoord)
 This function returns (a shared pointer to) the local elemental expansion containing the arbitrary point given by gloCoord. More...
 
int GetExpIndex (const Array< OneD, const NekDouble > &gloCoord, NekDouble tol=0.0, bool returnNearestElmt=false, int cachedId=-1, NekDouble maxDistance=1e6)
 This function returns the index of the local elemental expansion containing the arbitrary point given by gloCoord, within a distance tolerance of tol. More...
 
int GetExpIndex (const Array< OneD, const NekDouble > &gloCoords, Array< OneD, NekDouble > &locCoords, NekDouble tol=0.0, bool returnNearestElmt=false, int cachedId=-1, NekDouble maxDistance=1e6)
 
NekDouble PhysEvaluate (const Array< OneD, const NekDouble > &coords, const Array< OneD, const NekDouble > &phys)
 
int GetCoeff_Offset (int n) const
 Get the start offset position for a local contiguous list of coeffs correspoinding to element n. More...
 
int GetPhys_Offset (int n) const
 Get the start offset position for a local contiguous list of quadrature points in a full array correspoinding to element n. More...
 
Array< OneD, NekDouble > & UpdateCoeffs ()
 This function returns (a reference to) the array \(\boldsymbol{\hat{u}}_l\) (implemented as m_coeffs) containing all local expansion coefficients. More...
 
Array< OneD, NekDouble > & UpdatePhys ()
 This function returns (a reference to) the array \(\boldsymbol{u}_l\) (implemented as m_phys) containing the function \(u^{\delta}(\boldsymbol{x})\) evaluated at the quadrature points. More...
 
void PhysDeriv (Direction edir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d)
 
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)
 This function discretely evaluates the derivative of a function \(f(\boldsymbol{x})\) on the domain consisting of all elements of the expansion. More...
 
void PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d)
 
void CurlCurl (Array< OneD, Array< OneD, NekDouble >> &Vel, Array< OneD, Array< OneD, NekDouble >> &Q)
 
void PhysDirectionalDeriv (const Array< OneD, const NekDouble > &direction, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
void GetMovingFrames (const SpatialDomains::GeomMMF MMFdir, const Array< OneD, const NekDouble > &CircCentre, Array< OneD, Array< OneD, NekDouble >> &outarray)
 
const Array< OneD, const std::shared_ptr< ExpList > > & GetBndCondExpansions ()
 
const Array< OneD, const NekDouble > & GetBndCondBwdWeight ()
 Get the weight value for boundary conditions. More...
 
void SetBndCondBwdWeight (const int index, const NekDouble value)
 Set the weight value for boundary conditions. More...
 
std::shared_ptr< ExpList > & UpdateBndCondExpansion (int i)
 
void Upwind (const Array< OneD, const NekDouble > &Vn, const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &Upwind)
 
void Upwind (const Array< OneD, const Array< OneD, NekDouble >> &Vec, const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &Upwind)
 
std::shared_ptr< ExpList > & GetTrace ()
 
std::shared_ptr< AssemblyMapDG > & GetTraceMap (void)
 
const Array< OneD, const int > & GetTraceBndMap (void)
 
void GetNormals (Array< OneD, Array< OneD, NekDouble >> &normals)
 
void GetElmtNormalLength (Array< OneD, NekDouble > &lengthsFwd, Array< OneD, NekDouble > &lengthsBwd)
 Get the length of elements in boundary normal direction. More...
 
void GetBwdWeight (Array< OneD, NekDouble > &weightAver, Array< OneD, NekDouble > &weightJump)
 Get the weight value for boundary conditions for boundary average and jump calculations. More...
 
void AddTraceIntegral (const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray)
 
void AddTraceIntegral (const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray)
 
void AddFwdBwdTraceIntegral (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &outarray)
 
void GetFwdBwdTracePhys (Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd)
 
void GetFwdBwdTracePhys (const Array< OneD, const NekDouble > &field, Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool FillBnd=true, bool PutFwdInBwdOnBCs=false, bool DoExchange=true)
 
void FillBwdWithBoundCond (const Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool PutFwdInBwdOnBCs=false)
 
void AddTraceQuadPhysToField (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field)
 Add Fwd and Bwd value to field, a reverse procedure of GetFwdBwdTracePhys. More...
 
void AddTraceQuadPhysToOffDiag (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field)
 
void GetLocTraceFromTracePts (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &locTraceFwd, Array< OneD, NekDouble > &locTraceBwd)
 
void FillBwdWithBwdWeight (Array< OneD, NekDouble > &weightave, Array< OneD, NekDouble > &weightjmp)
 Fill Bwd with boundary conditions. More...
 
void PeriodicBwdCopy (const Array< OneD, const NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd)
 Copy and fill the Periodic boundaries. More...
 
const std::vector< bool > & GetLeftAdjacentFaces (void) const
 
void ExtractTracePhys (Array< OneD, NekDouble > &outarray)
 
void ExtractTracePhys (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & GetBndConditions ()
 
Array< OneD, SpatialDomains::BoundaryConditionShPtr > & UpdateBndConditions ()
 
void EvaluateBoundaryConditions (const NekDouble time=0.0, const std::string varName="", const NekDouble=NekConstants::kNekUnsetDouble, const NekDouble=NekConstants::kNekUnsetDouble)
 
void GeneralMatrixOp (const GlobalMatrixKey &gkey, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 This function calculates the result of the multiplication of a matrix of type specified by mkey with a vector given by inarray. More...
 
void SetUpPhysNormals ()
 
void GetBoundaryToElmtMap (Array< OneD, int > &ElmtID, Array< OneD, int > &EdgeID)
 
virtual void GetBndElmtExpansion (int i, std::shared_ptr< ExpList > &result, const bool DeclareCoeffPhysArrays=true)
 
void ExtractElmtToBndPhys (int i, const Array< OneD, NekDouble > &elmt, Array< OneD, NekDouble > &boundary)
 
void ExtractPhysToBndElmt (int i, const Array< OneD, const NekDouble > &phys, Array< OneD, NekDouble > &bndElmt)
 
void ExtractPhysToBnd (int i, const Array< OneD, const NekDouble > &phys, Array< OneD, NekDouble > &bnd)
 
void GetBoundaryNormals (int i, Array< OneD, Array< OneD, NekDouble >> &normals)
 
void GeneralGetFieldDefinitions (std::vector< LibUtilities::FieldDefinitionsSharedPtr > &fielddef, int NumHomoDir=0, Array< OneD, LibUtilities::BasisSharedPtr > &HomoBasis=LibUtilities::NullBasisSharedPtr1DArray, std::vector< NekDouble > &HomoLen=LibUtilities::NullNekDoubleVector, bool homoStrips=false, std::vector< unsigned int > &HomoSIDs=LibUtilities::NullUnsignedIntVector, std::vector< unsigned int > &HomoZIDs=LibUtilities::NullUnsignedIntVector, std::vector< unsigned int > &HomoYIDs=LibUtilities::NullUnsignedIntVector)
 
std::map< int, RobinBCInfoSharedPtrGetRobinBCInfo ()
 
void GetPeriodicEntities (PeriodicMap &periodicVerts, PeriodicMap &periodicEdges, PeriodicMap &periodicFaces=NullPeriodicMap)
 
std::vector< LibUtilities::FieldDefinitionsSharedPtrGetFieldDefinitions ()
 
void GetFieldDefinitions (std::vector< LibUtilities::FieldDefinitionsSharedPtr > &fielddef)
 
void AppendFieldData (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata)
 Append the element data listed in elements fielddef->m_ElementIDs onto fielddata. More...
 
void AppendFieldData (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata, Array< OneD, NekDouble > &coeffs)
 Append the data in coeffs listed in elements fielddef->m_ElementIDs onto fielddata. More...
 
void ExtractElmtDataToCoeffs (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata, std::string &field, Array< OneD, NekDouble > &coeffs)
 Extract the data in fielddata into the coeffs using the basic ExpList Elemental expansions rather than planes in homogeneous case. More...
 
void ExtractCoeffsToCoeffs (const std::shared_ptr< ExpList > &fromExpList, const Array< OneD, const NekDouble > &fromCoeffs, Array< OneD, NekDouble > &toCoeffs)
 Extract the data from fromField using fromExpList the coeffs using the basic ExpList Elemental expansions rather than planes in homogeneous case. More...
 
void ExtractDataToCoeffs (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata, std::string &field, Array< OneD, NekDouble > &coeffs, std::unordered_map< int, int > zIdToPlane=std::unordered_map< int, int >())
 Extract the data in fielddata into the coeffs. More...
 
void ExtractCoeffsFromFile (const std::string &fileName, LibUtilities::CommSharedPtr comm, const std::string &varName, Array< OneD, NekDouble > &coeffs)
 
void GenerateElementVector (const int ElementID, const NekDouble scalar1, const NekDouble scalar2, Array< OneD, NekDouble > &outarray)
 Generate vector v such that v[i] = scalar1 if i is in the element < ElementID. Otherwise, v[i] = scalar2. More...
 
std::shared_ptr< ExpListGetSharedThisPtr ()
 Returns a shared pointer to the current object. More...
 
std::shared_ptr< LibUtilities::SessionReaderGetSession () const
 Returns the session object. More...
 
std::shared_ptr< LibUtilities::CommGetComm () const
 Returns the comm object. More...
 
SpatialDomains::MeshGraphSharedPtr GetGraph ()
 
LibUtilities::BasisSharedPtr GetHomogeneousBasis (void)
 
std::shared_ptr< ExpList > & GetPlane (int n)
 
void CreateCollections (Collections::ImplementationType ImpType=Collections::eNoImpType)
 Construct collections of elements containing a single element type and polynomial order from the list of expansions. More...
 
void ClearGlobalLinSysManager (void)
 
int GetPoolCount (std::string)
 
void UnsetGlobalLinSys (GlobalLinSysKey, bool)
 
LibUtilities::NekManager< GlobalLinSysKey, GlobalLinSys > & GetGlobalLinSysManager (void)
 
const Array< OneD, const std::pair< int, int > > & GetCoeffsToElmt () const
 Get m_coeffs to elemental value map. More...
 
void AddTraceJacToElmtJac (const Array< OneD, const DNekMatSharedPtr > &FwdMat, const Array< OneD, const DNekMatSharedPtr > &BwdMat, Array< OneD, DNekMatSharedPtr > &fieldMat)
 inverse process of v_GetFwdBwdTracePhys. Given Trace integration of Fwd and Bwd Jacobian, with dimension NtotalTrace*TraceCoef*TracePhys. return Elemental Jacobian matrix with dimension NtotalElement*ElementCoef*ElementPhys. More...
 
void GetMatIpwrtDeriveBase (const Array< OneD, const Array< OneD, NekDouble >> &inarray, const int nDirctn, Array< OneD, DNekMatSharedPtr > &mtxPerVar)
 
void GetMatIpwrtDeriveBase (const TensorOfArray3D< NekDouble > &inarray, Array< OneD, DNekMatSharedPtr > &mtxPerVar)
 
void GetDiagMatIpwrtBase (const Array< OneD, const Array< OneD, NekDouble >> &inarray, Array< OneD, DNekMatSharedPtr > &mtxPerVar)
 
void AddTraceIntegralToOffDiag (const Array< OneD, const NekDouble > &FwdFlux, const Array< OneD, const NekDouble > &BwdFlux, Array< OneD, NekDouble > &outarray)
 
void AddRightIPTPhysDerivBase (const int dir, const Array< OneD, const DNekMatSharedPtr > ElmtJacQuad, Array< OneD, DNekMatSharedPtr > ElmtJacCoef)
 
void AddRightIPTBaseMatrix (const Array< OneD, const DNekMatSharedPtr > ElmtJacQuad, Array< OneD, DNekMatSharedPtr > ElmtJacCoef)
 
const LocTraceToTraceMapSharedPtrGetLocTraceToTraceMap () const
 
std::vector< bool > & GetLeftAdjacentTraces (void)
 
const std::unordered_map< int, int > & GetElmtToExpId (void)
 This function returns the map of index inside m_exp to geom id. More...
 
int GetElmtToExpId (int elmtId)
 This function returns the index inside m_exp for a given geom id. More...
 

Protected Member Functions

GlobalMatrixSharedPtr GetGlobalMatrix (const GlobalMatrixKey &mkey)
 Returns the global matrix specified by mkey. More...
 
GlobalLinSysSharedPtr GetGlobalLinSys (const GlobalLinSysKey &mkey)
 Returns the linear system specified by the key mkey. More...
 
GlobalLinSysSharedPtr GenGlobalLinSys (const GlobalLinSysKey &mkey)
 
virtual void v_ImposeDirichletConditions (Array< OneD, NekDouble > &outarray) override
 Impose the Dirichlet Boundary Conditions on outarray. More...
 
virtual void v_FillBndCondFromField (const Array< OneD, NekDouble > coeffs) override
 
virtual void v_FillBndCondFromField (const int nreg, const Array< OneD, NekDouble > coeffs) override
 
virtual void v_LocalToGlobal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool useComm) override
 Gathers the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
virtual void v_LocalToGlobal (bool useComm) override
 
virtual void v_GlobalToLocal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 Scatters from the global coefficients \(\boldsymbol{\hat{u}}_g\) to the local coefficients \(\boldsymbol{\hat{u}}_l\). More...
 
virtual void v_GlobalToLocal (void) override
 
virtual void v_FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 Template method virtual forwarder for FwdTrans(). More...
 
virtual void v_SmoothField (Array< OneD, NekDouble > &field) override
 Template method virtual forwarded for SmoothField(). More...
 
virtual void v_MultiplyByInvMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 Template method virtual forwarder for MultiplyByInvMassMatrix(). More...
 
virtual GlobalLinSysKey v_HelmSolve (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const StdRegions::ConstFactorMap &factors, const StdRegions::VarCoeffMap &varcoeff, const MultiRegions::VarFactorsMap &varfactors, const Array< OneD, const NekDouble > &dirForcing, const bool PhysSpaceForcing) override
 Solves the two-dimensional Helmholtz equation, subject to the boundary conditions specified. More...
 
virtual GlobalLinSysKey v_LinearAdvectionDiffusionReactionSolve (const Array< OneD, Array< OneD, NekDouble >> &velocity, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const NekDouble lambda, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray) override
 
virtual void v_LinearAdvectionReactionSolve (const Array< OneD, Array< OneD, NekDouble >> &velocity, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, const NekDouble lambda, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray) override
 
virtual const Array< OneD, const SpatialDomains ::BoundaryConditionShPtr > & v_GetBndConditions () override
 Template method virtual forwarder for GetBndConditions(). More...
 
virtual void v_ClearGlobalLinSysManager (void) override
 
int v_GetPoolCount (std::string) override
 
void v_UnsetGlobalLinSys (GlobalLinSysKey, bool) override
 
- Protected Member Functions inherited from Nektar::MultiRegions::DisContField
void GenerateBoundaryConditionExpansion (const SpatialDomains::MeshGraphSharedPtr &graph1D, const SpatialDomains::BoundaryConditions &bcs, const std::string variable, const bool DeclareCoeffPhysArrays=true)
 Discretises the boundary conditions. More...
 
void FindPeriodicTraces (const SpatialDomains::BoundaryConditions &bcs, const std::string variable)
 Generate a associative map of periodic vertices in a mesh. More...
 
void SetUpDG (const std::string="DefaultVar", const Collections::ImplementationType ImpType=Collections::eNoImpType)
 Set up all DG member variables and maps. More...
 
bool IsLeftAdjacentTrace (const int n, const int e)
 This routine determines if an element is to the "left" of the adjacent trace, which arises from the idea there is a local normal direction between two elements (i.e. on the trace) and one elements would then be the left. More...
 
virtual ExpListSharedPtrv_GetTrace () override
 
virtual AssemblyMapDGSharedPtrv_GetTraceMap (void) override
 
virtual const LocTraceToTraceMapSharedPtrv_GetLocTraceToTraceMap (void) const override
 
virtual std::vector< bool > & v_GetLeftAdjacentTraces (void) override
 
virtual void v_AddTraceIntegral (const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) override
 Add trace contributions into elemental coefficient spaces. More...
 
virtual void v_AddFwdBwdTraceIntegral (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &outarray) override
 Add trace contributions into elemental coefficient spaces. More...
 
virtual void v_AddTraceQuadPhysToField (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field) override
 
virtual void v_ExtractTracePhys (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 This method extracts the trace (verts in 1D) from the field inarray and puts the values in outarray. More...
 
virtual void v_ExtractTracePhys (Array< OneD, NekDouble > &outarray) override
 
virtual void v_GetLocTraceFromTracePts (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &locTraceFwd, Array< OneD, NekDouble > &locTraceBwd) override
 
void GenerateFieldBnd1D (SpatialDomains::BoundaryConditions &bcs, const std::string variable)
 
virtual std::map< int, RobinBCInfoSharedPtrv_GetRobinBCInfo () override
 
virtual const Array< OneD, const MultiRegions::ExpListSharedPtr > & v_GetBndCondExpansions () override
 
virtual MultiRegions::ExpListSharedPtrv_UpdateBndCondExpansion (int i) override
 
virtual Array< OneD, SpatialDomains::BoundaryConditionShPtr > & v_UpdateBndConditions () override
 
virtual void v_GetBoundaryToElmtMap (Array< OneD, int > &ElmtID, Array< OneD, int > &TraceID) override
 
virtual void v_GetBndElmtExpansion (int i, std::shared_ptr< ExpList > &result, const bool DeclareCoeffPhysArrays) override
 
virtual void v_Reset () override
 Reset this field, so that geometry information can be updated. More...
 
virtual void v_EvaluateBoundaryConditions (const NekDouble time=0.0, const std::string varName="", const NekDouble x2_in=NekConstants::kNekUnsetDouble, const NekDouble x3_in=NekConstants::kNekUnsetDouble) override
 Evaluate all boundary conditions at a given time.. More...
 
virtual void v_PeriodicBwdCopy (const Array< OneD, const NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd) override
 
virtual void v_FillBwdWithBwdWeight (Array< OneD, NekDouble > &weightave, Array< OneD, NekDouble > &weightjmp) override
 Fill the weight with m_bndCondBndWeight. More...
 
virtual void v_GetFwdBwdTracePhys (Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd) override
 
virtual void v_GetFwdBwdTracePhys (const Array< OneD, const NekDouble > &field, Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool FillBnd=true, bool PutFwdInBwdOnBCs=false, bool DoExchange=true) override
 This method extracts the "forward" and "backward" trace data from the array field and puts the data into output vectors Fwd and Bwd. More...
 
virtual void v_FillBwdWithBoundCond (const Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool PutFwdInBwdOnBCs) override
 
virtual const Array< OneD, const NekDouble > & v_GetBndCondBwdWeight () override
 
virtual void v_SetBndCondBwdWeight (const int index, const NekDouble value) override
 
virtual void v_GetPeriodicEntities (PeriodicMap &periodicVerts, PeriodicMap &periodicEdges, PeriodicMap &periodicFaces) override
 Obtain a copy of the periodic edges and vertices for this field. More...
 
virtual void v_AddTraceIntegralToOffDiag (const Array< OneD, const NekDouble > &FwdFlux, const Array< OneD, const NekDouble > &BwdFlux, Array< OneD, NekDouble > &outarray) override
 
- Protected Member Functions inherited from Nektar::MultiRegions::ExpList
std::shared_ptr< DNekMatGenGlobalMatrixFull (const GlobalLinSysKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
 
const DNekScalBlkMatSharedPtr GenBlockMatrix (const GlobalMatrixKey &gkey)
 This function assembles the block diagonal matrix of local matrices of the type mtype. More...
 
const DNekScalBlkMatSharedPtrGetBlockMatrix (const GlobalMatrixKey &gkey)
 
void MultiplyByBlockMatrix (const GlobalMatrixKey &gkey, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
std::shared_ptr< GlobalMatrixGenGlobalMatrix (const GlobalMatrixKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
 Generates a global matrix from the given key and map. More...
 
void GlobalEigenSystem (const std::shared_ptr< DNekMat > &Gmat, Array< OneD, NekDouble > &EigValsReal, Array< OneD, NekDouble > &EigValsImag, Array< OneD, NekDouble > &EigVecs=NullNekDouble1DArray)
 
std::shared_ptr< GlobalLinSysGenGlobalLinSys (const GlobalLinSysKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
 This operation constructs the global linear system of type mkey. More...
 
std::shared_ptr< GlobalLinSysGenGlobalBndLinSys (const GlobalLinSysKey &mkey, const AssemblyMapSharedPtr &locToGloMap)
 Generate a GlobalLinSys from information provided by the key "mkey" and the mapping provided in LocToGloBaseMap. More...
 
virtual size_t v_GetNumElmts (void)
 
virtual void v_Upwind (const Array< OneD, const Array< OneD, NekDouble >> &Vec, const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &Upwind)
 
virtual void v_Upwind (const Array< OneD, const NekDouble > &Vn, const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &Upwind)
 
virtual const Array< OneD, const int > & v_GetTraceBndMap ()
 
virtual void v_GetNormals (Array< OneD, Array< OneD, NekDouble >> &normals)
 Populate normals with the normals of all expansions. More...
 
virtual void v_AddTraceIntegral (const Array< OneD, const NekDouble > &Fx, const Array< OneD, const NekDouble > &Fy, Array< OneD, NekDouble > &outarray)
 
virtual void v_AddTraceQuadPhysToOffDiag (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field)
 
virtual const std::vector< bool > & v_GetLeftAdjacentFaces (void) const
 
virtual void v_BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_FwdTransLocalElmt (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_FwdTransBndConstrained (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_GetCoords (Array< OneD, NekDouble > &coord_0, Array< OneD, NekDouble > &coord_1=NullNekDouble1DArray, Array< OneD, NekDouble > &coord_2=NullNekDouble1DArray)
 
virtual void v_GetCoords (const int eid, Array< OneD, NekDouble > &xc0, Array< OneD, NekDouble > &xc1, Array< OneD, NekDouble > &xc2)
 
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)
 
virtual void v_PhysDeriv (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d)
 
virtual void v_PhysDeriv (Direction edir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &out_d)
 
virtual void v_CurlCurl (Array< OneD, Array< OneD, NekDouble >> &Vel, Array< OneD, Array< OneD, NekDouble >> &Q)
 
virtual void v_PhysDirectionalDeriv (const Array< OneD, const NekDouble > &direction, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_GetMovingFrames (const SpatialDomains::GeomMMF MMFdir, const Array< OneD, const NekDouble > &CircCentre, Array< OneD, Array< OneD, NekDouble >> &outarray)
 
virtual void v_HomogeneousFwdTrans (const int npts, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool Shuff=true, bool UnShuff=true)
 
virtual void v_HomogeneousBwdTrans (const int npts, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool Shuff=true, bool UnShuff=true)
 
virtual void v_DealiasedProd (const int num_dofs, const Array< OneD, NekDouble > &inarray1, const Array< OneD, NekDouble > &inarray2, Array< OneD, NekDouble > &outarray)
 
virtual void v_DealiasedDotProd (const int num_dofs, const Array< OneD, Array< OneD, NekDouble >> &inarray1, const Array< OneD, Array< OneD, NekDouble >> &inarray2, Array< OneD, Array< OneD, NekDouble >> &outarray)
 
virtual void v_GetBCValues (Array< OneD, NekDouble > &BndVals, const Array< OneD, NekDouble > &TotField, int BndID)
 
virtual void v_NormVectorIProductWRTBase (Array< OneD, const NekDouble > &V1, Array< OneD, const NekDouble > &V2, Array< OneD, NekDouble > &outarray, int BndID)
 
virtual void v_NormVectorIProductWRTBase (Array< OneD, Array< OneD, NekDouble >> &V, Array< OneD, NekDouble > &outarray)
 
virtual void v_SetUpPhysNormals ()
 : Set up a normal along the trace elements between two elements at elemental level More...
 
virtual void v_ExtractElmtToBndPhys (const int i, const Array< OneD, NekDouble > &elmt, Array< OneD, NekDouble > &boundary)
 
virtual void v_ExtractPhysToBndElmt (const int i, const Array< OneD, const NekDouble > &phys, Array< OneD, NekDouble > &bndElmt)
 
virtual void v_ExtractPhysToBnd (const int i, const Array< OneD, const NekDouble > &phys, Array< OneD, NekDouble > &bnd)
 
virtual void v_GetBoundaryNormals (int i, Array< OneD, Array< OneD, NekDouble >> &normals)
 
virtual std::vector< LibUtilities::FieldDefinitionsSharedPtrv_GetFieldDefinitions (void)
 
virtual void v_GetFieldDefinitions (std::vector< LibUtilities::FieldDefinitionsSharedPtr > &fielddef)
 
virtual void v_AppendFieldData (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata)
 
virtual void v_AppendFieldData (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata, Array< OneD, NekDouble > &coeffs)
 
virtual void v_ExtractDataToCoeffs (LibUtilities::FieldDefinitionsSharedPtr &fielddef, std::vector< NekDouble > &fielddata, std::string &field, Array< OneD, NekDouble > &coeffs, std::unordered_map< int, int > zIdToPlane)
 Extract data from raw field data into expansion list. More...
 
virtual void v_ExtractCoeffsToCoeffs (const std::shared_ptr< ExpList > &fromExpList, const Array< OneD, const NekDouble > &fromCoeffs, Array< OneD, NekDouble > &toCoeffs)
 
virtual void v_WriteTecplotHeader (std::ostream &outfile, std::string var="")
 
virtual void v_WriteTecplotZone (std::ostream &outfile, int expansion)
 
virtual void v_WriteTecplotField (std::ostream &outfile, int expansion)
 
virtual void v_WriteTecplotConnectivity (std::ostream &outfile, int expansion)
 
virtual void v_WriteVtkPieceData (std::ostream &outfile, int expansion, std::string var)
 
virtual void v_WriteVtkPieceHeader (std::ostream &outfile, int expansion, int istrip)
 
virtual NekDouble v_L2 (const Array< OneD, const NekDouble > &phys, const Array< OneD, const NekDouble > &soln=NullNekDouble1DArray)
 
virtual NekDouble v_Integral (const Array< OneD, const NekDouble > &inarray)
 
virtual NekDouble v_VectorFlux (const Array< OneD, Array< OneD, NekDouble >> &inarray)
 
virtual Array< OneD, const NekDoublev_HomogeneousEnergy (void)
 
virtual LibUtilities::TranspositionSharedPtr v_GetTransposition (void)
 
virtual NekDouble v_GetHomoLen (void)
 
virtual void v_SetHomoLen (const NekDouble lhom)
 
virtual Array< OneD, const unsigned int > v_GetZIDs (void)
 
virtual Array< OneD, const unsigned int > v_GetYIDs (void)
 
virtual void v_PhysInterp1DScaled (const NekDouble scale, const Array< OneD, NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_PhysGalerkinProjection1DScaled (const NekDouble scale, const Array< OneD, NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual LibUtilities::NekManager< GlobalLinSysKey, GlobalLinSys > & v_GetGlobalLinSysManager (void)
 
void ExtractFileBCs (const std::string &fileName, LibUtilities::CommSharedPtr comm, const std::string &varName, const std::shared_ptr< ExpList > locExpList)
 
virtual LibUtilities::BasisSharedPtr v_GetHomogeneousBasis (void)
 
virtual void v_SetHomo1DSpecVanVisc (Array< OneD, NekDouble > visc)
 
virtual std::shared_ptr< ExpList > & v_GetPlane (int n)
 

Protected Attributes

AssemblyMapCGSharedPtr m_locToGloMap
 (A shared pointer to) the object which contains all the required information for the transformation from local to global degrees of freedom. More...
 
GlobalMatrixMapShPtr m_globalMat
 (A shared pointer to) a list which collects all the global matrices being assembled, such that they should be constructed only once. More...
 
LibUtilities::NekManager< GlobalLinSysKey, GlobalLinSysm_globalLinSysManager
 A manager which collects all the global linear systems being assembled, such that they should be constructed only once. More...
 
GJPStabilisationSharedPtr m_GJPData
 Data for Gradient Jump Penalisation (GJP) stabilisaiton. More...
 
- Protected Attributes inherited from Nektar::MultiRegions::DisContField
size_t m_numDirBndCondExpansions
 The number of boundary segments on which Dirichlet boundary conditions are imposed. More...
 
Array< OneD, SpatialDomains::BoundaryConditionShPtrm_bndConditions
 An array which contains the information about the boundary condition structure definition on the different boundary regions. More...
 
Array< OneD, MultiRegions::ExpListSharedPtrm_bndCondExpansions
 An object which contains the discretised boundary conditions. More...
 
Array< OneD, NekDoublem_bndCondBndWeight
 
InterfaceMapDGSharedPtr m_interfaceMap
 Interfaces mapping for trace space. More...
 
GlobalLinSysMapShPtr m_globalBndMat
 Global boundary matrix. More...
 
ExpListSharedPtr m_trace
 Trace space storage for points between elements. More...
 
AssemblyMapDGSharedPtr m_traceMap
 Local to global DG mapping for trace space. More...
 
std::set< int > m_boundaryTraces
 A set storing the global IDs of any boundary Verts. More...
 
PeriodicMap m_periodicVerts
 A map which identifies groups of periodic vertices. More...
 
PeriodicMap m_periodicEdges
 A map which identifies pairs of periodic edges. More...
 
PeriodicMap m_periodicFaces
 A map which identifies pairs of periodic faces. More...
 
std::vector< int > m_periodicFwdCopy
 A vector indicating degress of freedom which need to be copied from forwards to backwards space in case of a periodic boundary condition. More...
 
std::vector< int > m_periodicBwdCopy
 
std::vector< bool > m_leftAdjacentTraces
 
LocTraceToTraceMapSharedPtr m_locTraceToTraceMap
 
- Protected Attributes inherited from Nektar::MultiRegions::ExpList
ExpansionType m_expType
 Exapnsion type. More...
 
LibUtilities::CommSharedPtr m_comm
 Communicator. More...
 
LibUtilities::SessionReaderSharedPtr m_session
 Session. More...
 
SpatialDomains::MeshGraphSharedPtr m_graph
 Mesh associated with this expansion list. More...
 
int m_ncoeffs
 The total number of local degrees of freedom. m_ncoeffs \(=N_{\mathrm{eof}}=\sum_{e=1}^{{N_{\mathrm{el}}}}N^{e}_l\). More...
 
int m_npoints
 
Array< OneD, NekDoublem_coeffs
 Concatenation of all local expansion coefficients. More...
 
Array< OneD, NekDoublem_phys
 The global expansion evaluated at the quadrature points. More...
 
bool m_physState
 The state of the array m_phys. More...
 
std::shared_ptr< LocalRegions::ExpansionVectorm_exp
 The list of local expansions. More...
 
Collections::CollectionVector m_collections
 
std::vector< bool > m_collectionsDoInit
 Vector of bools to act as an initialise on first call flag. More...
 
std::vector< int > m_coll_coeff_offset
 Offset of elemental data into the array m_coeffs. More...
 
std::vector< int > m_coll_phys_offset
 Offset of elemental data into the array m_phys. More...
 
Array< OneD, int > m_coeff_offset
 Offset of elemental data into the array m_coeffs. More...
 
Array< OneD, int > m_phys_offset
 Offset of elemental data into the array m_phys. More...
 
Array< OneD, std::pair< int, int > > m_coeffsToElmt
 m_coeffs to elemental value map More...
 
BlockMatrixMapShPtr m_blockMat
 
bool m_WaveSpace
 
std::unordered_map< int, int > m_elmtToExpId
 Mapping from geometry ID of element to index inside m_exp. More...
 

Additional Inherited Members

- Public Attributes inherited from Nektar::MultiRegions::DisContField
Array< OneD, int > m_BCtoElmMap
 
Array< OneD, int > m_BCtoTraceMap
 
- Static Protected Member Functions inherited from Nektar::MultiRegions::ExpList
static SpatialDomains::BoundaryConditionShPtr GetBoundaryCondition (const SpatialDomains::BoundaryConditionCollection &collection, unsigned int index, const std::string &variable)
 

Detailed Description

This class is the abstraction of a global continuous two- dimensional spectral/hp element expansion which approximates the solution of a set of partial differential equations.

The class ContField is able to incorporate the boundary conditions imposed to the problem to be solved. Therefore, the class is equipped with three additional data members:

The first data structure, m_bndCondExpansions, contains the one-dimensional spectral/hp expansion on the boundary, #m_bndTypes stores information about the type of boundary condition on the different parts of the boundary while #m_bndCondEquations holds the equation of the imposed boundary conditions.

Furthermore, in case of Dirichlet boundary conditions, this class is capable of lifting a known solution satisfying these boundary conditions. If we denote the unknown solution by \(u^{\mathcal{H}}(\boldsymbol{x})\) and the known Dirichlet boundary conditions by \(u^{\mathcal{D}}(\boldsymbol{x})\), the expansion then can be decomposed as

\[ u^{\delta}(\boldsymbol{x}_i)=u^{\mathcal{D}}(\boldsymbol{x}_i)+ u^{\mathcal{H}}(\boldsymbol{x}_i)=\sum_{n=0}^{N^{\mathcal{D}}-1} \hat{u}_n^{\mathcal{D}}\Phi_n(\boldsymbol{x}_i)+ \sum_{n={N^{\mathcal{D}}}}^{N_{\mathrm{dof}}-1} \hat{u}_n^{\mathcal{H}} \Phi_n(\boldsymbol{x}_i).\]

This lifting is accomplished by ordering the known global degrees of freedom, prescribed by the Dirichlet boundary conditions, first in the global array \(\boldsymbol{\hat{u}}\), that is,

\[\boldsymbol{\hat{u}}=\left[ \begin{array}{c} \boldsymbol{\hat{u}}^{\mathcal{D}}\\ \boldsymbol{\hat{u}}^{\mathcal{H}} \end{array} \right].\]

Such kind of expansions are also referred to as continuous fields. This class should be used when solving 2D problems using a standard Galerkin approach.

Definition at line 56 of file ContField.h.

Constructor & Destructor Documentation

◆ ContField() [1/5]

Nektar::MultiRegions::ContField::ContField ( )

The default constructor.

Definition at line 89 of file ContField.cpp.

92  std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
93  std::string("GlobalLinSys"))
94 {
95 }
LibUtilities::NekManager< GlobalLinSysKey, GlobalLinSys > m_globalLinSysManager
A manager which collects all the global linear systems being assembled, such that they should be cons...
Definition: ContField.h:183
GlobalLinSysSharedPtr GenGlobalLinSys(const GlobalLinSysKey &mkey)
Definition: ContField.cpp:551
AssemblyMapCGSharedPtr m_locToGloMap
(A shared pointer to) the object which contains all the required information for the transformation f...
Definition: ContField.h:172
GlobalMatrixMapShPtr m_globalMat
(A shared pointer to) a list which collects all the global matrices being assembled,...
Definition: ContField.h:177
DisContField()
Default constructor.

◆ ContField() [2/5]

Nektar::MultiRegions::ContField::ContField ( const LibUtilities::SessionReaderSharedPtr pSession,
const SpatialDomains::MeshGraphSharedPtr graph,
const std::string &  variable = "DefaultVar",
const bool  DeclareCoeffPhysArrays = true,
const bool  CheckIfSingularSystem = false,
const Collections::ImplementationType  ImpType = Collections::eNoImpType 
)

This constructor sets up global continuous field based on an input mesh and boundary conditions.

Given a mesh graph, containing information about the domain and the spectral/hp element expansion, this constructor fills the list of local expansions m_exp with the proper expansions, calculates the total number of quadrature points \(\boldsymbol{x}_i\) and local expansion coefficients \(\hat{u}^e_n\) and allocates memory for the arrays m_coeffs and m_phys. Furthermore, it constructs the mapping array (contained in m_locToGloMap) for the transformation between local elemental level and global level, it calculates the total number global expansion coefficients \(\hat{u}_n\) and allocates memory for the array #m_contCoeffs. The constructor also discretises the boundary conditions, specified by the argument bcs, by expressing them in terms of the coefficient of the expansion on the boundary.

Parameters
graphA mesh, containing information about the domain and the spectral/hp element expansion.
bcsThe boundary conditions.
variableAn optional parameter to indicate for which variable the field should be constructed.

Definition at line 118 of file ContField.cpp.

124  : DisContField(pSession, graph, variable, false, DeclareCoeffPhysArrays,
125  ImpType),
128  std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
129  std::string("GlobalLinSys"))
130 {
133  CheckIfSingularSystem, variable, m_periodicVerts, m_periodicEdges,
135 
136  if (m_session->DefinesCmdLineArgument("verbose"))
137  {
138  m_locToGloMap->PrintStats(std::cout, variable);
139  }
140 }
static std::shared_ptr< DataType > AllocateSharedPtr(const Args &...args)
Allocate a shared pointer from the memory pool.
PeriodicMap m_periodicEdges
A map which identifies pairs of periodic edges.
Definition: DisContField.h:179
PeriodicMap m_periodicFaces
A map which identifies pairs of periodic faces.
Definition: DisContField.h:184
Array< OneD, SpatialDomains::BoundaryConditionShPtr > m_bndConditions
An array which contains the information about the boundary condition structure definition on the diff...
Definition: DisContField.h:137
PeriodicMap m_periodicVerts
A map which identifies groups of periodic vertices.
Definition: DisContField.h:174
Array< OneD, MultiRegions::ExpListSharedPtr > m_bndCondExpansions
An object which contains the discretised boundary conditions.
Definition: DisContField.h:150
int m_ncoeffs
The total number of local degrees of freedom. m_ncoeffs .
Definition: ExpList.h:1056
LibUtilities::SessionReaderSharedPtr m_session
Session.
Definition: ExpList.h:1051

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, m_locToGloMap, Nektar::MultiRegions::ExpList::m_ncoeffs, Nektar::MultiRegions::DisContField::m_periodicEdges, Nektar::MultiRegions::DisContField::m_periodicFaces, Nektar::MultiRegions::DisContField::m_periodicVerts, and Nektar::MultiRegions::ExpList::m_session.

◆ ContField() [3/5]

Nektar::MultiRegions::ContField::ContField ( const ContField In,
const SpatialDomains::MeshGraphSharedPtr graph,
const std::string &  variable,
const bool  DeclareCoeffPhysArrays = true,
const bool  CheckIfSingularSystem = false 
)

Construct a global continuous field with solution type based on another field but using a separate input mesh and boundary conditions.

Given a mesh graph, containing information about the domain and the spectral/hp element expansion, this constructor fills the list of local expansions m_exp with the proper expansions, calculates the total number of quadrature points \(\boldsymbol{x}_i\) and local expansion coefficients \(\hat{u}^e_n\) and allocates memory for the arrays m_coeffs and m_phys. Furthermore, it constructs the mapping array (contained in m_locToGloMap) for the transformation between local elemental level and global level, it calculates the total number global expansion coefficients \(\hat{u}_n\) and allocates memory for the array m_coeffs. The constructor also discretises the boundary conditions, specified by the argument bcs, by expressing them in terms of the coefficient of the expansion on the boundary.

Parameters
InExisting ContField object used to provide the local to global mapping information and global solution type.
graphA mesh, containing information about the domain and the spectral/hp element expansion.
bcsThe boundary conditions.
bc_loc

Definition at line 165 of file ContField.cpp.

169  : DisContField(In, graph, variable, false, DeclareCoeffPhysArrays),
172  std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
173  std::string("GlobalLinSys")),
174  m_GJPData(In.m_GJPData)
175 {
176  if (!SameTypeOfBoundaryConditions(In) || CheckIfSingularSystem)
177  {
180  CheckIfSingularSystem, variable, m_periodicVerts, m_periodicEdges,
182 
183  if (m_session->DefinesCmdLineArgument("verbose"))
184  {
185  m_locToGloMap->PrintStats(std::cout, variable);
186  }
187  }
188  else
189  {
190  m_locToGloMap = In.m_locToGloMap;
191  }
192 }
GJPStabilisationSharedPtr m_GJPData
Data for Gradient Jump Penalisation (GJP) stabilisaiton.
Definition: ContField.h:186
bool SameTypeOfBoundaryConditions(const DisContField &In)
Check to see if expansion has the same BCs as In.

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, m_locToGloMap, Nektar::MultiRegions::ExpList::m_ncoeffs, Nektar::MultiRegions::DisContField::m_periodicEdges, Nektar::MultiRegions::DisContField::m_periodicFaces, Nektar::MultiRegions::DisContField::m_periodicVerts, Nektar::MultiRegions::ExpList::m_session, and Nektar::MultiRegions::DisContField::SameTypeOfBoundaryConditions().

◆ ContField() [4/5]

Nektar::MultiRegions::ContField::ContField ( const ContField In,
bool  DeclareCoeffPhysArrays = true 
)

The copy constructor.

Initialises the object as a copy of an existing ContField object.

Parameters
InExisting ContField object.
DeclareCoeffPhysArraysbool to declare if m_phys and m_coeffs should be declared. Default is true

Definition at line 200 of file ContField.cpp.

201  : DisContField(In, DeclareCoeffPhysArrays), m_locToGloMap(In.m_locToGloMap),
202  m_globalMat(In.m_globalMat),
203  m_globalLinSysManager(In.m_globalLinSysManager), m_GJPData(In.m_GJPData)
204 {
205 }

◆ ContField() [5/5]

Nektar::MultiRegions::ContField::ContField ( const LibUtilities::SessionReaderSharedPtr pSession,
const ExpList In 
)

Copy constructor.

Constructs a continuous field as a copy of an existing explist field and adding all the boundary conditions.

Parameters
InExisting explist1D field .

Definition at line 213 of file ContField.cpp.

215  : DisContField(In), m_locToGloMap(),
217  std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
218  std::string("GlobalLinSys"))
219 {
221  pSession, m_ncoeffs, In);
222 }

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), m_locToGloMap, and Nektar::MultiRegions::ExpList::m_ncoeffs.

◆ ~ContField()

Nektar::MultiRegions::ContField::~ContField ( )
virtual

The default destructor.

Definition at line 227 of file ContField.cpp.

228 {
229 }

Member Function Documentation

◆ Assemble() [1/2]

void Nektar::MultiRegions::ContField::Assemble ( )
inline

Assembles the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\).

This operation is evaluated as:

\begin{tabbing} \hspace{1cm} \= Do \= $e=$ $1, N_{\mathrm{el}}$ \\ \> \> Do \= $i=$ $0,N_m^e-1$ \\ \> \> \> $\boldsymbol{\hat{u}}_g[\mbox{map}[e][i]] = \boldsymbol{\hat{u}}_g[\mbox{map}[e][i]]+\mbox{sign}[e][i] \cdot \boldsymbol{\hat{u}}^{e}[i]$\\ \> \> continue\\ \> continue \end{tabbing}

where map \([e][i]\) is the mapping array and sign \([e][i]\) is an array of similar dimensions ensuring the correct modal connectivity between the different elements (both these arrays are contained in the data member m_locToGloMap). This operation is equivalent to the gather operation \(\boldsymbol{\hat{u}}_g=\mathcal{A}^{T}\boldsymbol{\hat{u}}_l\), where \(\mathcal{A}\) is the \(N_{\mathrm{eof}}\times N_{\mathrm{dof}}\) permutation matrix.

Note
The array m_coeffs should be filled with the local coefficients \(\boldsymbol{\hat{u}}_l\) and that the resulting global coefficients \(\boldsymbol{\hat{u}}_g\) will be stored in m_coeffs.

Definition at line 316 of file ContField.h.

317 {
318  m_locToGloMap->Assemble(m_coeffs, m_coeffs);
319 }
Array< OneD, NekDouble > m_coeffs
Concatenation of all local expansion coefficients.
Definition: ExpList.h:1076

References Nektar::MultiRegions::ExpList::m_coeffs, and m_locToGloMap.

◆ Assemble() [2/2]

void Nektar::MultiRegions::ContField::Assemble ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
) const
inline

Assembles the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\).

This operation is evaluated as:

\begin{tabbing} \hspace{1cm} \= Do \= $e=$ $1, N_{\mathrm{el}}$ \\ \> \> Do \= $i=$ $0,N_m^e-1$ \\ \> \> \> $\boldsymbol{\hat{u}}_g[\mbox{map}[e][i]] = \boldsymbol{\hat{u}}_g[\mbox{map}[e][i]]+\mbox{sign}[e][i] \cdot \boldsymbol{\hat{u}}^{e}[i]$\\ \> \> continue\\ \> continue \end{tabbing}

where map \([e][i]\) is the mapping array and sign \([e][i]\) is an array of similar dimensions ensuring the correct modal connectivity between the different elements (both these arrays are contained in the data member m_locToGloMap). This operation is equivalent to the gather operation \(\boldsymbol{\hat{u}}_g=\mathcal{A}^{T}\boldsymbol{\hat{u}}_l\), where \(\mathcal{A}\) is the \(N_{\mathrm{eof}}\times N_{\mathrm{dof}}\) permutation matrix.

Parameters
inarrayAn array of size \(N_\mathrm{eof}\) containing the local degrees of freedom \(\boldsymbol{x}_l\).
outarrayThe resulting global degrees of freedom \(\boldsymbol{x}_g\) will be stored in this array of size \(N_\mathrm{dof}\).

Definition at line 348 of file ContField.h.

350 {
351  m_locToGloMap->Assemble(inarray, outarray);
352 }

References m_locToGloMap.

◆ FwdTrans()

void Nektar::MultiRegions::ContField::FwdTrans ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
)

Performs the global forward transformation of a function \(f(\boldsymbol{x})\), subject to the boundary conditions specified.

Given a function \(f(\boldsymbol{x})\) defined at the quadrature points, this function determines the unknown global coefficients \(\boldsymbol{\hat{u}}^{\mathcal{H}}\) employing a discrete Galerkin projection from physical space to coefficient space. The operation is evaluated by the function GlobalSolve using the global mass matrix.

The values of the function \(f(\boldsymbol{x})\) evaluated at the quadrature points \(\boldsymbol{x}_i\) should be contained in the variable #inarray of the ExpList object Sin. The resulting global coefficients \(\hat{u}_g\) are stored in the array #outarray.

Definition at line 244 of file ContField.cpp.

247 {
248  // Inner product of forcing
249  Array<OneD, NekDouble> wsp(m_ncoeffs);
250  IProductWRTBase(inarray, wsp);
251 
252  // Solve the system
253  GlobalLinSysKey key(StdRegions::eMass, m_locToGloMap);
254 
255  GlobalSolve(key, wsp, outarray);
256 }
void GlobalSolve(const GlobalLinSysKey &key, const Array< OneD, const NekDouble > &rhs, Array< OneD, NekDouble > &inout, const Array< OneD, const NekDouble > &dirForcing=NullNekDouble1DArray)
Solves the linear system specified by the key key.
Definition: ContField.cpp:489
void IProductWRTBase(const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
This function calculates the inner product of a function with respect to all local expansion modes .
Definition: ExpList.h:1630

References Nektar::StdRegions::eMass, GlobalSolve(), Nektar::MultiRegions::ExpList::IProductWRTBase(), m_locToGloMap, and Nektar::MultiRegions::ExpList::m_ncoeffs.

Referenced by v_FwdTrans().

◆ GenGlobalLinSys()

GlobalLinSysSharedPtr Nektar::MultiRegions::ContField::GenGlobalLinSys ( const GlobalLinSysKey mkey)
protected

Definition at line 551 of file ContField.cpp.

552 {
553  ASSERTL1(mkey.LocToGloMapIsDefined(),
554  "To use method must have a AssemblyMap "
555  "attached to key");
557 }
#define ASSERTL1(condition, msg)
Assert Level 1 – Debugging which is used whether in FULLDEBUG or DEBUG compilation mode....
Definition: ErrorUtil.hpp:249
std::shared_ptr< GlobalLinSys > GenGlobalLinSys(const GlobalLinSysKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
This operation constructs the global linear system of type mkey.
Definition: ExpList.cpp:2416

References ASSERTL1, Nektar::MultiRegions::ExpList::GenGlobalLinSys(), Nektar::MultiRegions::GlobalMatrixKey::LocToGloMapIsDefined(), and m_locToGloMap.

◆ GetBndCondExpansions()

const Array< OneD, const MultiRegions::ExpListSharedPtr > & Nektar::MultiRegions::ContField::GetBndCondExpansions ( )
inline

Returns the boundary conditions expansion.

Definition at line 360 of file ContField.h.

361 {
362  return m_bndCondExpansions;
363 }

References Nektar::MultiRegions::DisContField::m_bndCondExpansions.

◆ GetBndConditions()

const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & Nektar::MultiRegions::ContField::GetBndConditions ( )
inline

Returns the boundary conditions.

Definition at line 366 of file ContField.h.

367 {
368  return m_bndConditions;
369 }

References Nektar::MultiRegions::DisContField::m_bndConditions.

Referenced by v_GetBndConditions().

◆ GetGJPForcing()

const GJPStabilisationSharedPtr Nektar::MultiRegions::ContField::GetGJPForcing ( )
inline

Definition at line 149 of file ContField.h.

150  {
151  // initialize if required
152  if (!m_GJPData)
153  {
155  GetSharedThisPtr());
156  }
157 
158  return m_GJPData;
159  }
std::shared_ptr< ExpList > GetSharedThisPtr()
Returns a shared pointer to the current object.
Definition: ExpList.h:950

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::MultiRegions::ExpList::GetSharedThisPtr(), and m_GJPData.

◆ GetGlobalLinSys()

GlobalLinSysSharedPtr Nektar::MultiRegions::ContField::GetGlobalLinSys ( const GlobalLinSysKey mkey)
protected

Returns the linear system specified by the key mkey.

The function searches the map #m_globalLinSys to see if the global matrix has been created before. If not, it calls the function GenGlobalLinSys to generate the requested global system.

Parameters
mkeyThis key uniquely defines the requested linear system.

Definition at line 546 of file ContField.cpp.

547 {
548  return m_globalLinSysManager[mkey];
549 }

References m_globalLinSysManager.

Referenced by GlobalSolve(), and v_UnsetGlobalLinSys().

◆ GetGlobalMatrix()

GlobalMatrixSharedPtr Nektar::MultiRegions::ContField::GetGlobalMatrix ( const GlobalMatrixKey mkey)
protected

Returns the global matrix specified by mkey.

Returns the global matrix associated with the given GlobalMatrixKey. If the global matrix has not yet been constructed on this field, it is first constructed using GenGlobalMatrix().

Parameters
mkeyGlobal matrix key.
Returns
Assocated global matrix.

Definition at line 516 of file ContField.cpp.

517 {
518  ASSERTL1(mkey.LocToGloMapIsDefined(),
519  "To use method must have a AssemblyMap "
520  "attached to key");
521 
522  GlobalMatrixSharedPtr glo_matrix;
523  auto matrixIter = m_globalMat->find(mkey);
524 
525  if (matrixIter == m_globalMat->end())
526  {
527  glo_matrix = GenGlobalMatrix(mkey, m_locToGloMap);
528  (*m_globalMat)[mkey] = glo_matrix;
529  }
530  else
531  {
532  glo_matrix = matrixIter->second;
533  }
534 
535  return glo_matrix;
536 }
std::shared_ptr< GlobalMatrix > GenGlobalMatrix(const GlobalMatrixKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
Generates a global matrix from the given key and map.
Definition: ExpList.cpp:2131
std::shared_ptr< GlobalMatrix > GlobalMatrixSharedPtr
Shared pointer to a GlobalMatrix object.
Definition: GlobalMatrix.h:86

References ASSERTL1, Nektar::MultiRegions::ExpList::GenGlobalMatrix(), Nektar::MultiRegions::GlobalMatrixKey::LocToGloMapIsDefined(), m_globalMat, and m_locToGloMap.

◆ GetGlobalMatrixNnz()

int Nektar::MultiRegions::ContField::GetGlobalMatrixNnz ( const GlobalMatrixKey gkey)
inline

Definition at line 371 of file ContField.h.

372 {
373  ASSERTL1(gkey.LocToGloMapIsDefined(),
374  "To use method must have a AssemblyMap "
375  "attached to key");
376 
377  auto matrixIter = m_globalMat->find(gkey);
378 
379  if (matrixIter == m_globalMat->end())
380  {
381  return 0;
382  }
383  else
384  {
385  return matrixIter->second->GetNumNonZeroEntries();
386  }
387 
388  return 0;
389 }

References ASSERTL1, Nektar::MultiRegions::GlobalMatrixKey::LocToGloMapIsDefined(), and m_globalMat.

◆ GetLocalToGlobalMap()

const AssemblyMapCGSharedPtr & Nektar::MultiRegions::ContField::GetLocalToGlobalMap ( ) const
inline

Returns the map from local to global level.

Definition at line 354 of file ContField.h.

355 {
356  return m_locToGloMap;
357 }

References m_locToGloMap.

◆ GlobalSolve()

void Nektar::MultiRegions::ContField::GlobalSolve ( const GlobalLinSysKey key,
const Array< OneD, const NekDouble > &  locrhs,
Array< OneD, NekDouble > &  inout,
const Array< OneD, const NekDouble > &  dirForcing = NullNekDouble1DArray 
)

Solves the linear system specified by the key key.

Given a linear system specified by the key key,

\[\boldsymbol{M}\boldsymbol{\hat{u}}_g=\boldsymbol{\hat{f}},\]

this function solves this linear system taking into account the boundary conditions specified in the data member m_bndCondExpansions. Therefore, it adds an array \(\boldsymbol{\hat{g}}\) which represents the non-zero surface integral resulting from the weak boundary conditions (e.g. Neumann boundary conditions) to the right hand side, that is,

\[\boldsymbol{M}\boldsymbol{\hat{u}}_g=\boldsymbol{\hat{f}}+ \boldsymbol{\hat{g}}.\]

Furthermore, it lifts the known degrees of freedom which are prescribed by the Dirichlet boundary conditions. As these known coefficients \(\boldsymbol{\hat{u}}^{\mathcal{D}}\) are numbered first in the global coefficient array \(\boldsymbol{\hat{u}}_g\), the linear system can be decomposed as,

\[\left[\begin{array}{cc} \boldsymbol{M}^{\mathcal{DD}}&\boldsymbol{M}^{\mathcal{DH}}\\ \boldsymbol{M}^{\mathcal{HD}}&\boldsymbol{M}^{\mathcal{HH}} \end{array}\right] \left[\begin{array}{c} \boldsymbol{\hat{u}}^{\mathcal{D}}\\ \boldsymbol{\hat{u}}^{\mathcal{H}} \end{array}\right]= \left[\begin{array}{c} \boldsymbol{\hat{f}}^{\mathcal{D}}\\ \boldsymbol{\hat{f}}^{\mathcal{H}} \end{array}\right]+ \left[\begin{array}{c} \boldsymbol{\hat{g}}^{\mathcal{D}}\\ \boldsymbol{\hat{g}}^{\mathcal{H}} \end{array}\right] \]

which will then be solved for the unknown coefficients \(\boldsymbol{\hat{u}}^{\mathcal{H}}\) as,

\[ \boldsymbol{M}^{\mathcal{HH}}\boldsymbol{\hat{u}}^{\mathcal{H}}= \boldsymbol{\hat{f}}^{\mathcal{H}}+ \boldsymbol{\hat{g}}^{\mathcal{H}}- \boldsymbol{M}^{\mathcal{HD}}\boldsymbol{\hat{u}}^{\mathcal{D}}\]

Parameters
mkeyThis key uniquely defines the linear system to be solved.
locrhscontains the forcing term in local coefficient space
Note
inout contains initial guess and final output in local coeffs.

Definition at line 489 of file ContField.cpp.

493 {
494  int NumDirBcs = m_locToGloMap->GetNumGlobalDirBndCoeffs();
495  int contNcoeffs = m_locToGloMap->GetNumGlobalCoeffs();
496 
497  // STEP 1: SET THE DIRICHLET DOFS TO THE RIGHT VALUE
498  // IN THE SOLUTION ARRAY
500 
501  // STEP 2: CALCULATE THE HOMOGENEOUS COEFFICIENTS
502  if (contNcoeffs - NumDirBcs > 0)
503  {
505  LinSys->Solve(locrhs, inout, m_locToGloMap, dirForcing);
506  }
507 }
GlobalLinSysSharedPtr GetGlobalLinSys(const GlobalLinSysKey &mkey)
Returns the linear system specified by the key mkey.
Definition: ContField.cpp:546
virtual void v_ImposeDirichletConditions(Array< OneD, NekDouble > &outarray) override
Impose the Dirichlet Boundary Conditions on outarray.
Definition: ContField.cpp:568
std::shared_ptr< GlobalLinSys > GlobalLinSysSharedPtr
Pointer to a GlobalLinSys object.
Definition: GlobalLinSys.h:50

References GetGlobalLinSys(), m_locToGloMap, and v_ImposeDirichletConditions().

Referenced by FwdTrans(), LaplaceSolve(), MultiplyByInvMassMatrix(), v_HelmSolve(), v_LinearAdvectionDiffusionReactionSolve(), and v_LinearAdvectionReactionSolve().

◆ LaplaceSolve()

void Nektar::MultiRegions::ContField::LaplaceSolve ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray,
const Array< OneD, const NekDouble > &  dirForcing = NullNekDouble1DArray,
const Array< OneD, Array< OneD, NekDouble >> &  variablecoeffs = NullNekDoubleArrayOfArray,
NekDouble  time = 0.0 
)

Solves the two-dimensional Laplace equation, subject to the boundary conditions specified.

Consider the two dimensional Laplace equation,

\[\nabla\cdot\left(\boldsymbol{\sigma}\nabla u(\boldsymbol{x})\right) = f(\boldsymbol{x}),\]

supplemented with appropriate boundary conditions (which are contained in the data member m_bndCondExpansions). In the equation above \(\boldsymbol{\sigma}\) is the (symmetric positive definite) diffusion tensor:

\[ \sigma = \left[ \begin{array}{cc} \sigma_{00}(\boldsymbol{x},t) & \sigma_{01}(\boldsymbol{x},t) \\ \sigma_{01}(\boldsymbol{x},t) & \sigma_{11}(\boldsymbol{x},t) \end{array} \right]. \]

Applying a \(C^0\) continuous Galerkin discretisation, this equation leads to the following linear system:

\[\boldsymbol{L} \boldsymbol{\hat{u}}_g=\boldsymbol{\hat{f}}\]

where \(\boldsymbol{L}\) is the Laplacian matrix. This function solves the system above for the global coefficients \(\boldsymbol{\hat{u}}\) by a call to the function GlobalSolve.

The values of the function \(f(\boldsymbol{x})\) evaluated at the quadrature points \(\boldsymbol{x}_i\) should be contained in the variable #inarray

Parameters
inarrayAn Array<OneD, NekDouble> containing the discrete evaluation of the forcing function \(f(\boldsymbol{x})\) at the quadrature points.
outarrayAn Array<OneD, NekDouble> containing the coefficients of the solution
variablecoeffsThe (optional) parameter containing the coefficients evaluated at the quadrature points. It is an Array of (three) arrays which stores the laplacian coefficients in the following way

\[\mathrm{variablecoeffs} = \left[ \begin{array}{c} \left[\sigma_{00}(\boldsymbol{x_i},t)\right]_i \\ \left[\sigma_{01}(\boldsymbol{x_i},t)\right]_i \\ \left[\sigma_{11}(\boldsymbol{x_i},t)\right]_i \end{array}\right] \]

If this argument is not passed to the function, the following equation will be solved:

\[\nabla^2u(\boldsymbol{x}) = f(\boldsymbol{x}),\]

timeThe time-level at which the coefficients are evaluated

Definition at line 339 of file ContField.cpp.

344 {
345  // Inner product of forcing
346  Array<OneD, NekDouble> wsp(m_ncoeffs);
347  IProductWRTBase(inarray, wsp);
348 
349  // Note -1.0 term necessary to invert forcing function to
350  // be consistent with matrix definition
351  Vmath::Neg(m_ncoeffs, wsp, 1);
352 
353  // Forcing function with weak boundary conditions
354  int i, j;
355  int bndcnt = 0;
356  Array<OneD, NekDouble> sign =
357  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
358  const Array<OneD, const int> map =
359  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
360 
361  // Add weak boundary conditions to forcing
362  for (i = 0; i < m_bndCondExpansions.size(); ++i)
363  {
364  if (m_bndConditions[i]->GetBoundaryConditionType() ==
366  m_bndConditions[i]->GetBoundaryConditionType() ==
368  {
369 
370  const Array<OneD, const NekDouble> bndcoeff =
372 
373  if (m_locToGloMap->GetSignChange())
374  {
375  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
376  {
377  wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
378  }
379  }
380  else
381  {
382  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
383  {
384  wsp[map[bndcnt + j]] += bndcoeff[bndcnt + j];
385  }
386  }
387  }
388 
389  bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
390  }
391 
392  StdRegions::VarCoeffMap varcoeffs;
393  varcoeffs[StdRegions::eVarCoeffD00] = variablecoeffs[0];
394  varcoeffs[StdRegions::eVarCoeffD01] = variablecoeffs[1];
395  varcoeffs[StdRegions::eVarCoeffD11] = variablecoeffs[3];
396  varcoeffs[StdRegions::eVarCoeffD22] = variablecoeffs[5];
398  factors[StdRegions::eFactorTime] = time;
399 
400  // Solve the system
401  GlobalLinSysKey key(StdRegions::eLaplacian, m_locToGloMap, factors,
402  varcoeffs);
403 
404  GlobalSolve(key, wsp, outarray, dirForcing);
405 }
#define sign(a, b)
return the sign(b)*a
Definition: Polylib.cpp:49
int GetNcoeffs(void) const
Returns the total number of local degrees of freedom .
Definition: ExpList.h:1492
const Array< OneD, const NekDouble > & GetCoeffs() const
This function returns (a reference to) the array (implemented as m_coeffs) containing all local expa...
Definition: ExpList.h:1902
std::map< ConstFactorType, NekDouble > ConstFactorMap
Definition: StdRegions.hpp:399
std::map< StdRegions::VarCoeffType, VarCoeffEntry > VarCoeffMap
Definition: StdRegions.hpp:343
void Neg(int n, T *x, const int incx)
Negate x = -x.
Definition: Vmath.cpp:518

References Nektar::StdRegions::eFactorTime, Nektar::StdRegions::eLaplacian, Nektar::SpatialDomains::eNeumann, Nektar::SpatialDomains::eRobin, Nektar::StdRegions::eVarCoeffD00, Nektar::StdRegions::eVarCoeffD01, Nektar::StdRegions::eVarCoeffD11, Nektar::StdRegions::eVarCoeffD22, Nektar::MultiRegions::ExpList::GetCoeffs(), Nektar::MultiRegions::ExpList::GetNcoeffs(), GlobalSolve(), Nektar::MultiRegions::ExpList::IProductWRTBase(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, m_locToGloMap, Nektar::MultiRegions::ExpList::m_ncoeffs, Vmath::Neg(), and sign.

◆ LinearAdvectionEigs()

void Nektar::MultiRegions::ContField::LinearAdvectionEigs ( const NekDouble  ax,
const NekDouble  ay,
Array< OneD, NekDouble > &  Real,
Array< OneD, NekDouble > &  Imag,
Array< OneD, NekDouble > &  Evecs = NullNekDouble1DArray 
)

Compute the eigenvalues of the linear advection operator.

Constructs the GlobalLinearSysKey for the linear advection operator with the supplied parameters, and computes the eigenvectors and eigenvalues of the associated matrix.

Parameters
axAdvection parameter, x.
ayAdvection parameter, y.
RealComputed eigenvalues, real component.
ImagComputed eigenvalues, imag component.
EvecsComputed eigenvectors.

Definition at line 417 of file ContField.cpp.

421 {
422  // Solve the system
423  Array<OneD, Array<OneD, NekDouble>> vel(2);
424  Array<OneD, NekDouble> vel_x(m_npoints, ax);
425  Array<OneD, NekDouble> vel_y(m_npoints, ay);
426  vel[0] = vel_x;
427  vel[1] = vel_y;
428 
429  StdRegions::VarCoeffMap varcoeffs;
430  varcoeffs[StdRegions::eVarCoeffVelX] =
431  Array<OneD, NekDouble>(m_npoints, ax);
432  varcoeffs[StdRegions::eVarCoeffVelY] =
433  Array<OneD, NekDouble>(m_npoints, ay);
435  factors[StdRegions::eFactorTime] = 0.0;
437  factors, varcoeffs);
438 
440  Gmat->EigenSolve(Real, Imag, Evecs);
441 }
std::shared_ptr< DNekMat > GenGlobalMatrixFull(const GlobalLinSysKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
Definition: ExpList.cpp:2264
std::shared_ptr< DNekMat > DNekMatSharedPtr
Definition: NekTypeDefs.hpp:75

References CG_Iterations::ax, Nektar::StdRegions::eFactorTime, Nektar::StdRegions::eLinearAdvectionReaction, Nektar::StdRegions::eVarCoeffVelX, Nektar::StdRegions::eVarCoeffVelY, Nektar::MultiRegions::ExpList::GenGlobalMatrixFull(), m_locToGloMap, and Nektar::MultiRegions::ExpList::m_npoints.

◆ MultiplyByInvMassMatrix()

void Nektar::MultiRegions::ContField::MultiplyByInvMassMatrix ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
)

Multiply a solution by the inverse mass matrix.

Computes the matrix vector product \( \mathbf{y} = \mathbf{M}^{-1}\mathbf{x} \).

Parameters
inarrayInput vector \(\mathbf{x}\).
outarrayOutput vector \(\mathbf{y}\).

Definition at line 279 of file ContField.cpp.

283 {
284 
285  GlobalLinSysKey key(StdRegions::eMass, m_locToGloMap);
286  GlobalSolve(key, inarray, outarray);
287 }

References Nektar::StdRegions::eMass, GlobalSolve(), and m_locToGloMap.

Referenced by v_MultiplyByInvMassMatrix(), and v_SmoothField().

◆ SetGJPForcing()

void Nektar::MultiRegions::ContField::SetGJPForcing ( const GJPStabilisationSharedPtr GJPData)
inline

Definition at line 161 of file ContField.h.

163  {
164  m_GJPData = GJPData;
165  }

References m_GJPData.

◆ v_ClearGlobalLinSysManager()

void Nektar::MultiRegions::ContField::v_ClearGlobalLinSysManager ( void  )
overrideprotectedvirtual

Reset the GlobalLinSys Manager

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 1019 of file ContField.cpp.

1020 {
1021  m_globalLinSysManager.ClearManager("GlobalLinSys");
1022 }

References m_globalLinSysManager.

◆ v_FillBndCondFromField() [1/2]

void Nektar::MultiRegions::ContField::v_FillBndCondFromField ( const Array< OneD, NekDouble coeffs)
overrideprotectedvirtual

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 628 of file ContField.cpp.

629 {
630  int bndcnt = 0;
631 
632  Array<OneD, NekDouble> sign =
633  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
634  const Array<OneD, const int> bndmap =
635  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
636 
637  for (int i = 0; i < m_bndCondExpansions.size(); ++i)
638  {
639  Array<OneD, NekDouble> &bcoeffs =
640  m_bndCondExpansions[i]->UpdateCoeffs();
641 
642  if (m_locToGloMap->GetSignChange())
643  {
644  for (int j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); ++j)
645  {
646  bcoeffs[j] = sign[bndcnt + j] * coeffs[bndmap[bndcnt + j]];
647  }
648  }
649  else
650  {
651  for (int j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); ++j)
652  {
653  bcoeffs[j] = coeffs[bndmap[bndcnt + j]];
654  }
655  }
656 
657  bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
658  }
659 }

References Nektar::MultiRegions::ExpList::GetNcoeffs(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, m_locToGloMap, and sign.

◆ v_FillBndCondFromField() [2/2]

void Nektar::MultiRegions::ContField::v_FillBndCondFromField ( const int  nreg,
const Array< OneD, NekDouble coeffs 
)
overrideprotectedvirtual

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 661 of file ContField.cpp.

663 {
664  int bndcnt = 0;
665 
666  ASSERTL1(nreg < m_bndCondExpansions.size(),
667  "nreg is out or range since this many boundary "
668  "regions to not exist");
669 
670  Array<OneD, NekDouble> sign =
671  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
672  const Array<OneD, const int> bndmap =
673  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
674 
675  // Now fill in all other Dirichlet coefficients.
676  Array<OneD, NekDouble> &bcoeffs = m_bndCondExpansions[nreg]->UpdateCoeffs();
677 
678  for (int j = 0; j < nreg; ++j)
679  {
680  bndcnt += m_bndCondExpansions[j]->GetNcoeffs();
681  }
682 
683  if (m_locToGloMap->GetSignChange())
684  {
685  for (int j = 0; j < (m_bndCondExpansions[nreg])->GetNcoeffs(); ++j)
686  {
687  bcoeffs[j] = sign[bndcnt + j] * coeffs[bndmap[bndcnt + j]];
688  }
689  }
690  else
691  {
692  for (int j = 0; j < (m_bndCondExpansions[nreg])->GetNcoeffs(); ++j)
693  {
694  bcoeffs[j] = coeffs[bndmap[bndcnt + j]];
695  }
696  }
697 }

References ASSERTL1, Nektar::MultiRegions::ExpList::GetNcoeffs(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, m_locToGloMap, and sign.

◆ v_FwdTrans()

void Nektar::MultiRegions::ContField::v_FwdTrans ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
)
overrideprotectedvirtual

Template method virtual forwarder for FwdTrans().

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 562 of file ContField.cpp.

564 {
565  FwdTrans(inarray, outarray);
566 }
void FwdTrans(const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
Performs the global forward transformation of a function , subject to the boundary conditions specifi...
Definition: ContField.cpp:244

References FwdTrans().

◆ v_GetBndConditions()

const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & Nektar::MultiRegions::ContField::v_GetBndConditions ( void  )
overrideprotectedvirtual

Template method virtual forwarder for GetBndConditions().

Reimplemented from Nektar::MultiRegions::DisContField.

Definition at line 1011 of file ContField.cpp.

1012 {
1013  return GetBndConditions();
1014 }
const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & GetBndConditions()
Returns the boundary conditions.
Definition: ContField.h:366

References GetBndConditions().

◆ v_GetPoolCount()

int Nektar::MultiRegions::ContField::v_GetPoolCount ( std::string  poolName)
overrideprotectedvirtual

Get the pool count for the specified poolName

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 1027 of file ContField.cpp.

1028 {
1029  return m_globalLinSysManager.PoolCount(poolName);
1030 }

References m_globalLinSysManager.

◆ v_GlobalToLocal() [1/2]

void Nektar::MultiRegions::ContField::v_GlobalToLocal ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
)
overrideprotectedvirtual

Scatters from the global coefficients \(\boldsymbol{\hat{u}}_g\) to the local coefficients \(\boldsymbol{\hat{u}}_l\).

This operation is evaluated as:

\begin{tabbing} \hspace{1cm} \= Do \= $e=$ $1, N_{\mathrm{el}}$ \\ \> \> Do \= $i=$ $0,N_m^e-1$ \\ \> \> \> $\boldsymbol{\hat{u}}^{e}[i] = \mbox{sign}[e][i] \cdot \boldsymbol{\hat{u}}_g[\mbox{map}[e][i]]$ \\ \> \> continue \\ \> continue \end{tabbing}

where map \([e][i]\) is the mapping array and sign \([e][i]\) is an array of similar dimensions ensuring the correct modal connectivity between the different elements (both these arrays are contained in the data member m_locToGloMap). This operation is equivalent to the scatter operation \(\boldsymbol{\hat{u}}_l=\mathcal{A}\boldsymbol{\hat{u}}_g\), where \(\mathcal{A}\) is the \(N_{\mathrm{eof}}\times N_{\mathrm{dof}}\) permutation matrix.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 719 of file ContField.cpp.

721 {
722  m_locToGloMap->GlobalToLocal(inarray, outarray);
723 }

References m_locToGloMap.

◆ v_GlobalToLocal() [2/2]

void Nektar::MultiRegions::ContField::v_GlobalToLocal ( void  )
overrideprotectedvirtual

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 725 of file ContField.cpp.

726 {
727  m_locToGloMap->GlobalToLocal(m_coeffs, m_coeffs);
728 }

References Nektar::MultiRegions::ExpList::m_coeffs, and m_locToGloMap.

◆ v_HelmSolve()

GlobalLinSysKey Nektar::MultiRegions::ContField::v_HelmSolve ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray,
const StdRegions::ConstFactorMap factors,
const StdRegions::VarCoeffMap pvarcoeff,
const MultiRegions::VarFactorsMap varfactors,
const Array< OneD, const NekDouble > &  dirForcing,
const bool  PhysSpaceForcing 
)
overrideprotectedvirtual

Solves the two-dimensional Helmholtz equation, subject to the boundary conditions specified.

Consider the two dimensional Helmholtz equation,

\[\nabla^2u(\boldsymbol{x})-\lambda u(\boldsymbol{x}) = f(\boldsymbol{x}),\]

supplemented with appropriate boundary conditions (which are contained in the data member m_bndCondExpansions). Applying a \(C^0\) continuous Galerkin discretisation, this equation leads to the following linear system:

\[\left(\boldsymbol{L}+\lambda\boldsymbol{M}\right) \boldsymbol{\hat{u}}_g=\boldsymbol{\hat{f}}\]

where \(\boldsymbol{L}\) and \(\boldsymbol{M}\) are the Laplacian and mass matrix respectively. This function solves the system above for the global coefficients \(\boldsymbol{\hat{u}}\) by a call to the function GlobalSolve.

Parameters
inarrayAn Array<OneD, NekDouble> , containing the discrete evaluation of the forcing function \(f(\boldsymbol{x})\) at the quadrature points
factorsThe parameter \(\lambda\) of the Helmholtz equation is specified through the factors map

Reimplemented from Nektar::MultiRegions::DisContField.

Definition at line 794 of file ContField.cpp.

800 {
801  int i, j;
802 
803  //----------------------------------
804  // Setup RHS Inner product
805  //----------------------------------
806  // Inner product of forcing
807  Array<OneD, NekDouble> wsp(m_ncoeffs);
808  if (PhysSpaceForcing)
809  {
810  IProductWRTBase(inarray, wsp);
811  // Note -1.0 term necessary to invert forcing function to
812  // be consistent with matrix definition
813  Vmath::Neg(m_ncoeffs, wsp, 1);
814  }
815  else
816  {
817  Vmath::Smul(m_ncoeffs, -1.0, inarray, 1, wsp, 1);
818  }
819 
820  int bndcnt = 0;
821  Array<OneD, NekDouble> sign =
822  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
823  const Array<OneD, const int> map =
824  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
825  // Add weak boundary conditions to forcing
826  for (i = 0; i < m_bndCondExpansions.size(); ++i)
827  {
828  if (m_bndConditions[i]->GetBoundaryConditionType() ==
830  m_bndConditions[i]->GetBoundaryConditionType() ==
832  {
833 
834  const Array<OneD, const NekDouble> bndcoeff =
836 
837  if (m_locToGloMap->GetSignChange())
838  {
839  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
840  {
841  wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
842  }
843  }
844  else
845  {
846  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
847  {
848  wsp[map[bndcnt + j]] += bndcoeff[j];
849  }
850  }
851  }
852  bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
853  }
854 
856 
857  StdRegions::VarCoeffMap varcoeff(pvarcoeff);
858  if (factors.count(StdRegions::eFactorGJP))
859  {
860  // initialize if required
861  if (!m_GJPData)
862  {
864  GetSharedThisPtr());
865  }
866 
867  if (m_GJPData->IsSemiImplicit())
868  {
870  }
871 
872  // to set up forcing need initial guess in physical space
873  Array<OneD, NekDouble> phys(m_npoints), tmp;
874  BwdTrans(outarray, phys);
875  NekDouble scale = -1.0 * factors.find(StdRegions::eFactorGJP)->second;
876 
877  m_GJPData->Apply(phys, wsp,
878  pvarcoeff.count(StdRegions::eVarCoeffGJPNormVel)
879  ? pvarcoeff.find(StdRegions::eVarCoeffGJPNormVel)
880  ->second.GetValue()
882  scale);
883 
884  varcoeff.erase(StdRegions::eVarCoeffGJPNormVel);
885  }
886 
887  GlobalLinSysKey key(mtype, m_locToGloMap, factors, varcoeff, varfactors);
888 
889  GlobalSolve(key, wsp, outarray, dirForcing);
890 
891  return key;
892 }
void BwdTrans(const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
This function elementally evaluates the backward transformation of the global spectral/hp element exp...
Definition: ExpList.h:1677
static Array< OneD, NekDouble > NullNekDouble1DArray
double NekDouble
void Smul(int n, const T alpha, const T *x, const int incx, T *y, const int incy)
Scalar multiply y = alpha*x.
Definition: Vmath.cpp:248

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::MultiRegions::ExpList::BwdTrans(), Nektar::StdRegions::eFactorGJP, Nektar::StdRegions::eHelmholtz, Nektar::StdRegions::eHelmholtzGJP, Nektar::SpatialDomains::eNeumann, Nektar::SpatialDomains::eRobin, Nektar::StdRegions::eVarCoeffGJPNormVel, Nektar::MultiRegions::ExpList::GetCoeffs(), Nektar::MultiRegions::ExpList::GetNcoeffs(), Nektar::MultiRegions::ExpList::GetSharedThisPtr(), GlobalSolve(), Nektar::MultiRegions::ExpList::IProductWRTBase(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, m_GJPData, m_locToGloMap, Nektar::MultiRegions::ExpList::m_ncoeffs, Nektar::MultiRegions::ExpList::m_npoints, Vmath::Neg(), Nektar::NullNekDouble1DArray, sign, and Vmath::Smul().

◆ v_ImposeDirichletConditions()

void Nektar::MultiRegions::ContField::v_ImposeDirichletConditions ( Array< OneD, NekDouble > &  outarray)
overrideprotectedvirtual

Impose the Dirichlet Boundary Conditions on outarray.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 568 of file ContField.cpp.

569 {
570  int i, j;
571  int bndcnt = 0;
572 
573  Array<OneD, NekDouble> sign =
574  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
575  const Array<OneD, const int> map =
576  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
577 
578  for (i = 0; i < m_bndCondExpansions.size(); ++i)
579  {
580  if (m_bndConditions[i]->GetBoundaryConditionType() ==
582  {
583 
584  const Array<OneD, const NekDouble> bndcoeff =
586 
587  if (m_locToGloMap->GetSignChange())
588  {
589  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
590  {
591  outarray[map[bndcnt + j]] = sign[bndcnt + j] * bndcoeff[j];
592  }
593  }
594  else
595  {
596  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
597  {
598  outarray[map[bndcnt + j]] = bndcoeff[j];
599  }
600  }
601  }
602  bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
603  }
604 
605  // communicate local Dirichlet coeffs that are just
606  // touching a dirichlet boundary on another partition
607  set<int> &ParallelDirBndSign = m_locToGloMap->GetParallelDirBndSign();
608 
609  for (auto &it : ParallelDirBndSign)
610  {
611  outarray[it] *= -1;
612  }
613 
614  m_locToGloMap->UniversalAbsMaxBnd(outarray);
615 
616  for (auto &it : ParallelDirBndSign)
617  {
618  outarray[it] *= -1;
619  }
620 
621  set<ExtraDirDof> &copyLocalDirDofs = m_locToGloMap->GetCopyLocalDirDofs();
622  for (auto &it : copyLocalDirDofs)
623  {
624  outarray[std::get<0>(it)] = outarray[std::get<1>(it)] * std::get<2>(it);
625  }
626 }

References Nektar::SpatialDomains::eDirichlet, Nektar::MultiRegions::ExpList::GetCoeffs(), Nektar::MultiRegions::ExpList::GetNcoeffs(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, m_locToGloMap, and sign.

Referenced by GlobalSolve().

◆ v_LinearAdvectionDiffusionReactionSolve()

GlobalLinSysKey Nektar::MultiRegions::ContField::v_LinearAdvectionDiffusionReactionSolve ( const Array< OneD, Array< OneD, NekDouble >> &  velocity,
const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray,
const NekDouble  lambda,
const Array< OneD, const NekDouble > &  dirForcing = NullNekDouble1DArray 
)
overrideprotectedvirtual

First compute the inner product of forcing function with respect to base, and then solve the system with the linear advection operator.

Parameters
velocityArray of advection velocities in physical space
inarrayForcing function.
outarrayResult.
lambdareaction coefficient
dirForcingDirichlet Forcing.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 905 of file ContField.cpp.

910 {
911  // Inner product of forcing
912  Array<OneD, NekDouble> wsp(m_ncoeffs);
913  IProductWRTBase(inarray, wsp);
914 
915  // Note -1.0 term necessary to invert forcing function to
916  // be consistent with matrix definition
917  Vmath::Neg(m_ncoeffs, wsp, 1);
918 
919  // Forcing function with weak boundary conditions
920  int i, j;
921  int bndcnt = 0;
922  Array<OneD, NekDouble> sign =
923  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
924  const Array<OneD, const int> map =
925  m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
926  // Add weak boundary conditions to forcing
927  for (i = 0; i < m_bndCondExpansions.size(); ++i)
928  {
929  if (m_bndConditions[i]->GetBoundaryConditionType() ==
931  m_bndConditions[i]->GetBoundaryConditionType() ==
933  {
934 
935  const Array<OneD, const NekDouble> bndcoeff =
937 
938  if (m_locToGloMap->GetSignChange())
939  {
940  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
941  {
942  wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
943  }
944  }
945  else
946  {
947  for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
948  {
949  wsp[map[bndcnt + j]] += bndcoeff[bndcnt + j];
950  }
951  }
952  }
953 
954  bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
955  }
956 
957  // Solve the system
959  factors[StdRegions::eFactorLambda] = lambda;
960  StdRegions::VarCoeffMap varcoeffs;
961  varcoeffs[StdRegions::eVarCoeffVelX] = velocity[0];
962  varcoeffs[StdRegions::eVarCoeffVelY] = velocity[1];
963  if (m_expType == e3D)
964  {
965  varcoeffs[StdRegions::eVarCoeffVelZ] = velocity[2];
966  }
967 
969  m_locToGloMap, factors, varcoeffs);
970 
971  GlobalSolve(key, wsp, outarray, dirForcing);
972 
973  return key;
974 }
ExpansionType m_expType
Exapnsion type.
Definition: ExpList.h:1044

References Nektar::MultiRegions::e3D, Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eLinearAdvectionDiffusionReaction, Nektar::SpatialDomains::eNeumann, Nektar::SpatialDomains::eRobin, Nektar::StdRegions::eVarCoeffVelX, Nektar::StdRegions::eVarCoeffVelY, Nektar::StdRegions::eVarCoeffVelZ, Nektar::MultiRegions::ExpList::GetCoeffs(), Nektar::MultiRegions::ExpList::GetNcoeffs(), GlobalSolve(), Nektar::MultiRegions::ExpList::IProductWRTBase(), Nektar::MultiRegions::DisContField::m_bndCondExpansions, Nektar::MultiRegions::DisContField::m_bndConditions, Nektar::MultiRegions::ExpList::m_expType, m_locToGloMap, Nektar::MultiRegions::ExpList::m_ncoeffs, Vmath::Neg(), and sign.

◆ v_LinearAdvectionReactionSolve()

void Nektar::MultiRegions::ContField::v_LinearAdvectionReactionSolve ( const Array< OneD, Array< OneD, NekDouble >> &  velocity,
const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray,
const NekDouble  lambda,
const Array< OneD, const NekDouble > &  dirForcing = NullNekDouble1DArray 
)
overrideprotectedvirtual

First compute the inner product of forcing function with respect to base, and then solve the system with the linear advection operator.

Parameters
velocityArray of advection velocities in physical space
inarrayForcing function.
outarrayResult.
lambdareaction coefficient
dirForcingDirichlet Forcing.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 985 of file ContField.cpp.

990 {
991  // Inner product of forcing
992  Array<OneD, NekDouble> wsp(m_ncoeffs);
993  IProductWRTBase(inarray, wsp);
994 
995  // Solve the system
997  factors[StdRegions::eFactorLambda] = lambda;
998  StdRegions::VarCoeffMap varcoeffs;
999  varcoeffs[StdRegions::eVarCoeffVelX] = velocity[0];
1000  varcoeffs[StdRegions::eVarCoeffVelY] = velocity[1];
1002  factors, varcoeffs);
1003 
1004  GlobalSolve(key, wsp, outarray, dirForcing);
1005 }

References Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eLinearAdvectionReaction, Nektar::StdRegions::eVarCoeffVelX, Nektar::StdRegions::eVarCoeffVelY, GlobalSolve(), Nektar::MultiRegions::ExpList::IProductWRTBase(), m_locToGloMap, and Nektar::MultiRegions::ExpList::m_ncoeffs.

◆ v_LocalToGlobal() [1/2]

void Nektar::MultiRegions::ContField::v_LocalToGlobal ( bool  useComm)
overrideprotectedvirtual

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 757 of file ContField.cpp.

759 {
760  m_locToGloMap->LocalToGlobal(m_coeffs, m_coeffs, useComm);
761 }

References Nektar::MultiRegions::ExpList::m_coeffs, and m_locToGloMap.

◆ v_LocalToGlobal() [2/2]

void Nektar::MultiRegions::ContField::v_LocalToGlobal ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray,
bool  useComm 
)
overrideprotectedvirtual

Gathers the global coefficients \(\boldsymbol{\hat{u}}_g\) from the local coefficients \(\boldsymbol{\hat{u}}_l\).

This operation is evaluated as:

\begin{tabbing} \hspace{1cm} \= Do \= $e=$ $1, N_{\mathrm{el}}$ \\ \> \> Do \= $i=$ $0,N_m^e-1$ \\ \> \> \> $\boldsymbol{\hat{u}}_g[\mbox{map}[e][i]] = \mbox{sign}[e][i] \cdot \boldsymbol{\hat{u}}^{e}[i]$\\ \> \> continue\\ \> continue \end{tabbing}

where map \([e][i]\) is the mapping array and sign \([e][i]\) is an array of similar dimensions ensuring the correct modal connectivity between the different elements (both these arrays are contained in the data member m_locToGloMap). This operation is equivalent to the gather operation \(\boldsymbol{\hat{u}}_g=\mathcal{A}^{-1}\boldsymbol{\hat{u}}_l\), where \(\mathcal{A}\) is the \(N_{\mathrm{eof}}\times N_{\mathrm{dof}}\) permutation matrix.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 751 of file ContField.cpp.

753 {
754  m_locToGloMap->LocalToGlobal(inarray, outarray, useComm);
755 }

References m_locToGloMap.

◆ v_MultiplyByInvMassMatrix()

void Nektar::MultiRegions::ContField::v_MultiplyByInvMassMatrix ( const Array< OneD, const NekDouble > &  inarray,
Array< OneD, NekDouble > &  outarray 
)
overrideprotectedvirtual

Template method virtual forwarder for MultiplyByInvMassMatrix().

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 766 of file ContField.cpp.

769 {
770  MultiplyByInvMassMatrix(inarray, outarray);
771 }
void MultiplyByInvMassMatrix(const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
Multiply a solution by the inverse mass matrix.
Definition: ContField.cpp:279

References MultiplyByInvMassMatrix().

◆ v_SmoothField()

void Nektar::MultiRegions::ContField::v_SmoothField ( Array< OneD, NekDouble > &  field)
overrideprotectedvirtual

Template method virtual forwarded for SmoothField().

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 261 of file ContField.cpp.

262 {
263  int Ncoeffs = m_locToGloMap->GetNumLocalCoeffs();
264  Array<OneD, NekDouble> tmp1(Ncoeffs);
265  Array<OneD, NekDouble> tmp2(Ncoeffs);
266 
267  IProductWRTBase(field, tmp1);
268  MultiplyByInvMassMatrix(tmp1, tmp2);
269  BwdTrans(tmp2, field);
270 }

References Nektar::MultiRegions::ExpList::BwdTrans(), Nektar::MultiRegions::ExpList::IProductWRTBase(), m_locToGloMap, and MultiplyByInvMassMatrix().

◆ v_UnsetGlobalLinSys()

void Nektar::MultiRegions::ContField::v_UnsetGlobalLinSys ( GlobalLinSysKey  key,
bool  clearLocalMatrices 
)
overrideprotectedvirtual

Clear all memory for GlobalLinSys including StaticCond Blocks and LocalMatrix Blocks. Avoids memory leakage if matrices are updated in time

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 1037 of file ContField.cpp.

1039 {
1040  // Get GlobalLinSys from key
1041  GlobalLinSysSharedPtr LinSys = GetGlobalLinSys(key);
1042 
1043  // Loop all expansions
1044  for (int n = 0; n < m_exp->size(); ++n)
1045  {
1046  LinSys->DropStaticCondBlock(n);
1047 
1048  if (clearLocalMatrices)
1049  {
1050  LinSys->DropBlock(n);
1051  }
1052  }
1053 
1054  m_globalLinSysManager.DeleteObject(key);
1055 }
std::shared_ptr< LocalRegions::ExpansionVector > m_exp
The list of local expansions.
Definition: ExpList.h:1111

References GetGlobalLinSys(), Nektar::MultiRegions::ExpList::m_exp, and m_globalLinSysManager.

Member Data Documentation

◆ m_GJPData

GJPStabilisationSharedPtr Nektar::MultiRegions::ContField::m_GJPData
protected

Data for Gradient Jump Penalisation (GJP) stabilisaiton.

Definition at line 186 of file ContField.h.

Referenced by GetGJPForcing(), SetGJPForcing(), and v_HelmSolve().

◆ m_globalLinSysManager

LibUtilities::NekManager<GlobalLinSysKey, GlobalLinSys> Nektar::MultiRegions::ContField::m_globalLinSysManager
protected

A manager which collects all the global linear systems being assembled, such that they should be constructed only once.

Definition at line 183 of file ContField.h.

Referenced by GetGlobalLinSys(), v_ClearGlobalLinSysManager(), v_GetPoolCount(), and v_UnsetGlobalLinSys().

◆ m_globalMat

GlobalMatrixMapShPtr Nektar::MultiRegions::ContField::m_globalMat
protected

(A shared pointer to) a list which collects all the global matrices being assembled, such that they should be constructed only once.

Definition at line 177 of file ContField.h.

Referenced by GetGlobalMatrix(), and GetGlobalMatrixNnz().

◆ m_locToGloMap

AssemblyMapCGSharedPtr Nektar::MultiRegions::ContField::m_locToGloMap
protected