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...
 
 ~ContField () override
 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 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...
 
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...
 
 ~DisContField () override
 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)
 
void GetFwdBwdTracePhys (const Array< OneD, const NekDouble > &field, Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > &bndCond, const Array< OneD, const ExpListSharedPtr > &BndCondExp)
 This method extracts the "forward" and "backward" trace data from the array field and puts the data into output vectors Fwd and Bwd. More...
 
- 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, 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 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 Curl (Array< OneD, Array< OneD, NekDouble > > &Vel, Array< OneD, Array< OneD, NekDouble > > &Q)
 
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 > &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)
 
void v_ImposeDirichletConditions (Array< OneD, NekDouble > &outarray) override
 Impose the Dirichlet Boundary Conditions on outarray. More...
 
void v_FillBndCondFromField (const Array< OneD, NekDouble > coeffs) override
 
void v_FillBndCondFromField (const int nreg, const Array< OneD, NekDouble > coeffs) override
 
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...
 
void v_LocalToGlobal (bool useComm) override
 
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...
 
void v_GlobalToLocal (void) override
 
void v_FwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 Template method virtual forwarder for FwdTrans(). More...
 
void v_SmoothField (Array< OneD, NekDouble > &field) override
 Template method virtual forwarded for SmoothField(). More...
 
void v_MultiplyByInvMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray) override
 Template method virtual forwarder for MultiplyByInvMassMatrix(). More...
 
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...
 
GlobalLinSysKey v_LinearAdvectionDiffusionReactionSolve (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
 
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
 
const Array< OneD, const MultiRegions::ExpListSharedPtr > & v_GetBndCondExpansions () override
 Returns the boundary conditions expansion. More...
 
const Array< OneD, const SpatialDomains ::BoundaryConditionShPtr > & v_GetBndConditions () override
 Template method virtual forwarder for GetBndConditions(). More...
 
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...
 
ExpListSharedPtrv_GetTrace () override
 
AssemblyMapDGSharedPtrv_GetTraceMap (void) override
 
const LocTraceToTraceMapSharedPtrv_GetLocTraceToTraceMap (void) const override
 
std::vector< bool > & v_GetLeftAdjacentTraces (void) override
 
void v_AddTraceIntegral (const Array< OneD, const NekDouble > &Fn, Array< OneD, NekDouble > &outarray) override
 Add trace contributions into elemental coefficient spaces. More...
 
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...
 
void v_AddTraceQuadPhysToField (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field) override
 
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...
 
void v_ExtractTracePhys (Array< OneD, NekDouble > &outarray) override
 
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)
 
std::map< int, RobinBCInfoSharedPtrv_GetRobinBCInfo () override
 
const Array< OneD, const MultiRegions::ExpListSharedPtr > & v_GetBndCondExpansions () override
 
const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & v_GetBndConditions () override
 
MultiRegions::ExpListSharedPtrv_UpdateBndCondExpansion (int i) override
 
Array< OneD, SpatialDomains::BoundaryConditionShPtr > & v_UpdateBndConditions () override
 
void v_GetBoundaryToElmtMap (Array< OneD, int > &ElmtID, Array< OneD, int > &TraceID) override
 
void v_GetBndElmtExpansion (int i, std::shared_ptr< ExpList > &result, const bool DeclareCoeffPhysArrays) override
 
void v_Reset () override
 Reset this field, so that geometry information can be updated. More...
 
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...
 
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
 Solve the Helmholtz equation. More...
 
void v_PeriodicBwdCopy (const Array< OneD, const NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd) override
 
void v_FillBwdWithBwdWeight (Array< OneD, NekDouble > &weightave, Array< OneD, NekDouble > &weightjmp) override
 Fill the weight with m_bndCondBndWeight. More...
 
void v_GetFwdBwdTracePhys (Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd) override
 
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
 
void v_FillBwdWithBoundCond (const Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool PutFwdInBwdOnBCs) override
 
void FillBwdWithBoundCond (const Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > &bndConditions, const Array< OneD, const ExpListSharedPtr > &BndCondExpansions, bool PutFwdInBwdOnBCs)
 
const Array< OneD, const NekDouble > & v_GetBndCondBwdWeight () override
 
void v_SetBndCondBwdWeight (const int index, const NekDouble value) override
 
void v_GetPeriodicEntities (PeriodicMap &periodicVerts, PeriodicMap &periodicEdges, PeriodicMap &periodicFaces) override
 Obtain a copy of the periodic edges and vertices for this field. More...
 
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 const Array< OneD, const std::shared_ptr< ExpList > > & v_GetBndCondExpansions (void)
 
virtual const Array< OneD, const NekDouble > & v_GetBndCondBwdWeight ()
 
virtual void v_SetBndCondBwdWeight (const int index, const NekDouble value)
 
virtual std::shared_ptr< ExpList > & v_UpdateBndCondExpansion (int i)
 
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 std::shared_ptr< ExpList > & v_GetTrace ()
 
virtual std::shared_ptr< AssemblyMapDG > & v_GetTraceMap ()
 
virtual const Array< OneD, const int > & v_GetTraceBndMap ()
 
virtual const std::shared_ptr< LocTraceToTraceMap > & v_GetLocTraceToTraceMap (void) const
 
virtual std::vector< bool > & v_GetLeftAdjacentTraces (void)
 
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 > &Fn, Array< OneD, NekDouble > &outarray)
 
virtual void v_AddFwdBwdTraceIntegral (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &outarray)
 
virtual void v_GetFwdBwdTracePhys (Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd)
 
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)
 
virtual void v_FillBwdWithBoundCond (const Array< OneD, NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd, bool PutFwdInBwdOnBCs)
 
virtual void v_AddTraceQuadPhysToField (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field)
 
virtual void v_AddTraceQuadPhysToOffDiag (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &field)
 
virtual void v_GetLocTraceFromTracePts (const Array< OneD, const NekDouble > &Fwd, const Array< OneD, const NekDouble > &Bwd, Array< OneD, NekDouble > &locTraceFwd, Array< OneD, NekDouble > &locTraceBwd)
 
virtual void v_FillBwdWithBwdWeight (Array< OneD, NekDouble > &weightave, Array< OneD, NekDouble > &weightjmp)
 
virtual void v_PeriodicBwdCopy (const Array< OneD, const NekDouble > &Fwd, Array< OneD, NekDouble > &Bwd)
 
virtual const std::vector< bool > & v_GetLeftAdjacentFaces (void) const
 
virtual void v_ExtractTracePhys (Array< OneD, NekDouble > &outarray)
 
virtual void v_ExtractTracePhys (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_MultiplyByInvMassMatrix (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
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)
 
virtual GlobalLinSysKey v_LinearAdvectionDiffusionReactionSolve (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)
 
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)
 
virtual void v_ImposeDirichletConditions (Array< OneD, NekDouble > &outarray)
 
virtual void v_FillBndCondFromField (const Array< OneD, NekDouble > coeffs)
 
virtual void v_FillBndCondFromField (const int nreg, const Array< OneD, NekDouble > coeffs)
 
virtual void v_Reset ()
 Reset geometry information, metrics, matrix managers and geometry information. More...
 
virtual void v_LocalToGlobal (bool UseComm)
 
virtual void v_LocalToGlobal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray, bool UseComm)
 
virtual void v_GlobalToLocal (void)
 
virtual void v_GlobalToLocal (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_BwdTrans (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_FwdTrans (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_SmoothField (Array< OneD, NekDouble > &field)
 
virtual void v_IProductWRTBase (const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_IProductWRTDerivBase (const int dir, const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
 
virtual void v_IProductWRTDerivBase (const Array< OneD, const Array< OneD, 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_Curl (Array< OneD, Array< OneD, NekDouble > > &Vel, Array< OneD, Array< OneD, NekDouble > > &Q)
 
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_GetBoundaryToElmtMap (Array< OneD, int > &ElmtID, Array< OneD, int > &EdgeID)
 
virtual void v_GetBndElmtExpansion (int i, std::shared_ptr< ExpList > &result, const bool DeclareCoeffPhysArrays)
 
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 void v_ClearGlobalLinSysManager (void)
 
virtual int v_GetPoolCount (std::string)
 
virtual void v_UnsetGlobalLinSys (GlobalLinSysKey, bool)
 
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 const Array< OneD, const SpatialDomains::BoundaryConditionShPtr > & v_GetBndConditions ()
 
virtual Array< OneD, SpatialDomains::BoundaryConditionShPtr > & v_UpdateBndConditions ()
 
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)
 
virtual std::map< int, RobinBCInfoSharedPtrv_GetRobinBCInfo (void)
 
virtual void v_GetPeriodicEntities (PeriodicMap &periodicVerts, PeriodicMap &periodicEdges, PeriodicMap &periodicFaces)
 
virtual LibUtilities::BasisSharedPtr v_GetHomogeneousBasis (void)
 
virtual void v_SetHomo1DSpecVanVisc (Array< OneD, NekDouble > visc)
 
virtual std::shared_ptr< ExpList > & v_GetPlane (int n)
 
virtual void v_AddTraceIntegralToOffDiag (const Array< OneD, const NekDouble > &FwdFlux, const Array< OneD, const NekDouble > &BwdFlux, Array< OneD, NekDouble > &outarray)
 

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 54 of file ContField.h.

Constructor & Destructor Documentation

◆ ContField() [1/5]

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

The default constructor.

Definition at line 87 of file ContField.cpp.

90 std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
91 std::string("GlobalLinSys"))
92{
93}
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:161
GlobalLinSysSharedPtr GenGlobalLinSys(const GlobalLinSysKey &mkey)
Definition: ContField.cpp:548
AssemblyMapCGSharedPtr m_locToGloMap
(A shared pointer to) the object which contains all the required information for the transformation f...
Definition: ContField.h:150
GlobalMatrixMapShPtr m_globalMat
(A shared pointer to) a list which collects all the global matrices being assembled,...
Definition: ContField.h:155
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 116 of file ContField.cpp.

122 : DisContField(pSession, graph, variable, false, DeclareCoeffPhysArrays,
123 ImpType),
126 std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
127 std::string("GlobalLinSys"))
128{
131 CheckIfSingularSystem, variable, m_periodicVerts, m_periodicEdges,
133
134 if (m_session->DefinesCmdLineArgument("verbose"))
135 {
136 m_locToGloMap->PrintStats(std::cout, variable);
137 }
138}
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:185
PeriodicMap m_periodicFaces
A map which identifies pairs of periodic faces.
Definition: DisContField.h:190
Array< OneD, SpatialDomains::BoundaryConditionShPtr > m_bndConditions
An array which contains the information about the boundary condition structure definition on the diff...
Definition: DisContField.h:143
PeriodicMap m_periodicVerts
A map which identifies groups of periodic vertices.
Definition: DisContField.h:180
Array< OneD, MultiRegions::ExpListSharedPtr > m_bndCondExpansions
An object which contains the discretised boundary conditions.
Definition: DisContField.h:156
int m_ncoeffs
The total number of local degrees of freedom. m_ncoeffs .
Definition: ExpList.h:1060
LibUtilities::SessionReaderSharedPtr m_session
Session.
Definition: ExpList.h:1055

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 163 of file ContField.cpp.

167 : DisContField(In, graph, variable, false, DeclareCoeffPhysArrays),
170 std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
171 std::string("GlobalLinSys")),
172 m_GJPData(In.m_GJPData)
173{
174 if (!SameTypeOfBoundaryConditions(In) || CheckIfSingularSystem)
175 {
178 CheckIfSingularSystem, variable, m_periodicVerts, m_periodicEdges,
180
181 if (m_session->DefinesCmdLineArgument("verbose"))
182 {
183 m_locToGloMap->PrintStats(std::cout, variable);
184 }
185 }
186 else
187 {
188 m_locToGloMap = In.m_locToGloMap;
189 }
190}
GJPStabilisationSharedPtr m_GJPData
Data for Gradient Jump Penalisation (GJP) stabilisaiton.
Definition: ContField.h:164
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 198 of file ContField.cpp.

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

◆ 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 211 of file ContField.cpp.

215 std::bind(&ContField::GenGlobalLinSys, this, std::placeholders::_1),
216 std::string("GlobalLinSys"))
217{
219 pSession, m_ncoeffs, In);
220}

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

◆ ~ContField()

Nektar::MultiRegions::ContField::~ContField ( )
override

The default destructor.

Definition at line 225 of file ContField.cpp.

226{
227}

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 295 of file ContField.h.

296{
297 m_locToGloMap->Assemble(m_coeffs, m_coeffs);
298}
Array< OneD, NekDouble > m_coeffs
Concatenation of all local expansion coefficients.
Definition: ExpList.h:1080

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 327 of file ContField.h.

329{
330 m_locToGloMap->Assemble(inarray, outarray);
331}

References m_locToGloMap.

◆ GenGlobalLinSys()

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

Definition at line 548 of file ContField.cpp.

549{
550 ASSERTL1(mkey.LocToGloMapIsDefined(),
551 "To use method must have a AssemblyMap "
552 "attached to key");
554}
#define ASSERTL1(condition, msg)
Assert Level 1 – Debugging which is used whether in FULLDEBUG or DEBUG compilation mode....
Definition: ErrorUtil.hpp:242
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:2782

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

◆ GetGJPForcing()

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

Definition at line 127 of file ContField.h.

128 {
129 // initialize if required
130 if (!m_GJPData)
131 {
134 }
135
136 return m_GJPData;
137 }
std::shared_ptr< ExpList > GetSharedThisPtr()
Returns a shared pointer to the current object.
Definition: ExpList.h:954

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 543 of file ContField.cpp.

544{
545 return m_globalLinSysManager[mkey];
546}

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 513 of file ContField.cpp.

514{
515 ASSERTL1(mkey.LocToGloMapIsDefined(),
516 "To use method must have a AssemblyMap "
517 "attached to key");
518
519 GlobalMatrixSharedPtr glo_matrix;
520 auto matrixIter = m_globalMat->find(mkey);
521
522 if (matrixIter == m_globalMat->end())
523 {
524 glo_matrix = GenGlobalMatrix(mkey, m_locToGloMap);
525 (*m_globalMat)[mkey] = glo_matrix;
526 }
527 else
528 {
529 glo_matrix = matrixIter->second;
530 }
531
532 return glo_matrix;
533}
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:2497
std::shared_ptr< GlobalMatrix > GlobalMatrixSharedPtr
Shared pointer to a GlobalMatrix object.
Definition: GlobalMatrix.h:84

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 350 of file ContField.h.

351{
352 ASSERTL1(gkey.LocToGloMapIsDefined(),
353 "To use method must have a AssemblyMap "
354 "attached to key");
355
356 auto matrixIter = m_globalMat->find(gkey);
357
358 if (matrixIter == m_globalMat->end())
359 {
360 return 0;
361 }
362 else
363 {
364 return matrixIter->second->GetNumNonZeroEntries();
365 }
366
367 return 0;
368}

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 333 of file ContField.h.

334{
335 return m_locToGloMap;
336}

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 486 of file ContField.cpp.

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

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

Referenced by LaplaceSolve(), v_FwdTrans(), v_HelmSolve(), v_LinearAdvectionDiffusionReactionSolve(), v_LinearAdvectionReactionSolve(), and v_MultiplyByInvMassMatrix().

◆ 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 336 of file ContField.cpp.

341{
342 // Inner product of forcing
343 Array<OneD, NekDouble> wsp(m_ncoeffs);
344 IProductWRTBase(inarray, wsp);
345
346 // Note -1.0 term necessary to invert forcing function to
347 // be consistent with matrix definition
348 Vmath::Neg(m_ncoeffs, wsp, 1);
349
350 // Forcing function with weak boundary conditions
351 int i, j;
352 int bndcnt = 0;
353 Array<OneD, NekDouble> sign =
354 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
355 const Array<OneD, const int> map =
356 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
357
358 // Add weak boundary conditions to forcing
359 for (i = 0; i < m_bndCondExpansions.size(); ++i)
360 {
361 if (m_bndConditions[i]->GetBoundaryConditionType() ==
363 m_bndConditions[i]->GetBoundaryConditionType() ==
365 {
366
367 const Array<OneD, const NekDouble> bndcoeff =
369
370 if (m_locToGloMap->GetSignChange())
371 {
372 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
373 {
374 wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
375 }
376 }
377 else
378 {
379 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
380 {
381 wsp[map[bndcnt + j]] += bndcoeff[bndcnt + j];
382 }
383 }
384 }
385
386 bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
387 }
388
389 StdRegions::VarCoeffMap varcoeffs;
390 varcoeffs[StdRegions::eVarCoeffD00] = variablecoeffs[0];
391 varcoeffs[StdRegions::eVarCoeffD01] = variablecoeffs[1];
392 varcoeffs[StdRegions::eVarCoeffD11] = variablecoeffs[3];
393 varcoeffs[StdRegions::eVarCoeffD22] = variablecoeffs[5];
396
397 // Solve the system
398 GlobalLinSysKey key(StdRegions::eLaplacian, m_locToGloMap, factors,
399 varcoeffs);
400
401 GlobalSolve(key, wsp, outarray, dirForcing);
402}
#define sign(a, b)
return the sign(b)*a
Definition: Polylib.cpp:47
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:486
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:1650
int GetNcoeffs(void) const
Returns the total number of local degrees of freedom .
Definition: ExpList.h:1512
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:1952
std::map< ConstFactorType, NekDouble > ConstFactorMap
Definition: StdRegions.hpp:402
std::map< StdRegions::VarCoeffType, VarCoeffEntry > VarCoeffMap
Definition: StdRegions.hpp:346
StdRegions::ConstFactorMap factors
void Neg(int n, T *x, const int incx)
Negate x = -x.
Definition: Vmath.hpp:292

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::VarcoeffHashingTest::factors, 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 414 of file ContField.cpp.

418{
419 // Solve the system
420 Array<OneD, Array<OneD, NekDouble>> vel(2);
421 Array<OneD, NekDouble> vel_x(m_npoints, ax);
422 Array<OneD, NekDouble> vel_y(m_npoints, ay);
423 vel[0] = vel_x;
424 vel[1] = vel_y;
425
426 StdRegions::VarCoeffMap varcoeffs;
427 varcoeffs[StdRegions::eVarCoeffVelX] =
428 Array<OneD, NekDouble>(m_npoints, ax);
429 varcoeffs[StdRegions::eVarCoeffVelY] =
430 Array<OneD, NekDouble>(m_npoints, ay);
434 factors, varcoeffs);
435
437 Gmat->EigenSolve(Real, Imag, Evecs);
438}
std::shared_ptr< DNekMat > GenGlobalMatrixFull(const GlobalLinSysKey &mkey, const std::shared_ptr< AssemblyMapCG > &locToGloMap)
Definition: ExpList.cpp:2630
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::VarcoeffHashingTest::factors, Nektar::MultiRegions::ExpList::GenGlobalMatrixFull(), m_locToGloMap, and Nektar::MultiRegions::ExpList::m_npoints.

◆ SetGJPForcing()

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

Definition at line 139 of file ContField.h.

141 {
142 m_GJPData = GJPData;
143 }

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 1017 of file ContField.cpp.

1018{
1019 m_globalLinSysManager.ClearManager("GlobalLinSys");
1020}

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 616 of file ContField.cpp.

617{
618 int bndcnt = 0;
619
620 Array<OneD, NekDouble> sign =
621 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
622 const Array<OneD, const int> bndmap =
623 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
624
625 for (int i = 0; i < m_bndCondExpansions.size(); ++i)
626 {
627 Array<OneD, NekDouble> &bcoeffs =
628 m_bndCondExpansions[i]->UpdateCoeffs();
629
630 if (m_locToGloMap->GetSignChange())
631 {
632 for (int j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); ++j)
633 {
634 bcoeffs[j] = sign[bndcnt + j] * coeffs[bndmap[bndcnt + j]];
635 }
636 }
637 else
638 {
639 for (int j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); ++j)
640 {
641 bcoeffs[j] = coeffs[bndmap[bndcnt + j]];
642 }
643 }
644
645 bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
646 }
647}

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 649 of file ContField.cpp.

651{
652 int bndcnt = 0;
653
654 ASSERTL1(nreg < m_bndCondExpansions.size(),
655 "nreg is out or range since this many boundary "
656 "regions to not exist");
657
658 Array<OneD, NekDouble> sign =
659 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
660 const Array<OneD, const int> bndmap =
661 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
662
663 // Now fill in all other Dirichlet coefficients.
664 Array<OneD, NekDouble> &bcoeffs = m_bndCondExpansions[nreg]->UpdateCoeffs();
665
666 for (int j = 0; j < nreg; ++j)
667 {
668 bndcnt += m_bndCondExpansions[j]->GetNcoeffs();
669 }
670
671 if (m_locToGloMap->GetSignChange())
672 {
673 for (int j = 0; j < (m_bndCondExpansions[nreg])->GetNcoeffs(); ++j)
674 {
675 bcoeffs[j] = sign[bndcnt + j] * coeffs[bndmap[bndcnt + j]];
676 }
677 }
678 else
679 {
680 for (int j = 0; j < (m_bndCondExpansions[nreg])->GetNcoeffs(); ++j)
681 {
682 bcoeffs[j] = coeffs[bndmap[bndcnt + j]];
683 }
684 }
685}

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().

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.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 242 of file ContField.cpp.

245{
246 // Inner product of forcing
247 Array<OneD, NekDouble> wsp(m_ncoeffs);
248 IProductWRTBase(inarray, wsp);
249
250 // Solve the system
251 GlobalLinSysKey key(StdRegions::eMass, m_locToGloMap);
252
253 GlobalSolve(key, wsp, outarray);
254}

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

◆ v_GetBndCondExpansions()

const Array< OneD, const MultiRegions::ExpListSharedPtr > & Nektar::MultiRegions::ContField::v_GetBndCondExpansions ( void  )
inlineoverrideprotectedvirtual

Returns the boundary conditions expansion.

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 339 of file ContField.h.

340{
341 return m_bndCondExpansions;
342}

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

◆ v_GetBndConditions()

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

Template method virtual forwarder for GetBndConditions().

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 345 of file ContField.h.

346{
347 return m_bndConditions;
348}

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

◆ 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 1025 of file ContField.cpp.

1026{
1027 return m_globalLinSysManager.PoolCount(poolName);
1028}

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 707 of file ContField.cpp.

709{
710 m_locToGloMap->GlobalToLocal(inarray, outarray);
711}

References m_locToGloMap.

◆ v_GlobalToLocal() [2/2]

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

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 713 of file ContField.cpp.

714{
715 m_locToGloMap->GlobalToLocal(m_coeffs, m_coeffs);
716}

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::ExpList.

Definition at line 772 of file ContField.cpp.

778{
779 int i, j;
780
781 //----------------------------------
782 // Setup RHS Inner product
783 //----------------------------------
784 // Inner product of forcing
785 Array<OneD, NekDouble> wsp(m_ncoeffs);
786 if (PhysSpaceForcing)
787 {
788 IProductWRTBase(inarray, wsp);
789 // Note -1.0 term necessary to invert forcing function to
790 // be consistent with matrix definition
791 Vmath::Neg(m_ncoeffs, wsp, 1);
792 }
793 else
794 {
795 Vmath::Smul(m_ncoeffs, -1.0, inarray, 1, wsp, 1);
796 }
797
798 int bndcnt = 0;
799 Array<OneD, NekDouble> sign =
800 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
801 const Array<OneD, const int> map =
802 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
803 // Add weak boundary conditions to forcing
804 for (i = 0; i < m_bndCondExpansions.size(); ++i)
805 {
806 if (m_bndConditions[i]->GetBoundaryConditionType() ==
808 m_bndConditions[i]->GetBoundaryConditionType() ==
810 {
811
812 const Array<OneD, const NekDouble> bndcoeff =
814
815 if (m_locToGloMap->GetSignChange())
816 {
817 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
818 {
819 wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
820 }
821 }
822 else
823 {
824 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
825 {
826 wsp[map[bndcnt + j]] += bndcoeff[j];
827 }
828 }
829 }
830 bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
831 }
832
834
835 StdRegions::VarCoeffMap varcoeff(pvarcoeff);
837 {
838 // initialize if required
839 if (!m_GJPData)
840 {
843 }
844
845 if (m_GJPData->IsSemiImplicit())
846 {
848 }
849
850 // to set up forcing need initial guess in physical space
851 Array<OneD, NekDouble> phys(m_npoints), tmp;
852 BwdTrans(outarray, phys);
853 NekDouble scale = -1.0 * factors.find(StdRegions::eFactorGJP)->second;
854
855 m_GJPData->Apply(phys, wsp,
856 pvarcoeff.count(StdRegions::eVarCoeffGJPNormVel)
857 ? pvarcoeff.find(StdRegions::eVarCoeffGJPNormVel)
858 ->second.GetValue()
860 scale);
861
862 varcoeff.erase(StdRegions::eVarCoeffGJPNormVel);
863 }
864
865 GlobalLinSysKey key(mtype, m_locToGloMap, factors, varcoeff, varfactors);
866
867 GlobalSolve(key, wsp, outarray, dirForcing);
868
869 return key;
870}
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:1717
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.hpp:100

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::VarcoeffHashingTest::factors, 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 556 of file ContField.cpp.

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

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, 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

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 883 of file ContField.cpp.

889{
890 // Inner product of forcing
891 Array<OneD, NekDouble> wsp(m_ncoeffs);
892 if (PhysSpaceForcing)
893 {
894 IProductWRTBase(inarray, wsp);
895 // Note -1.0 term necessary to invert forcing function to
896 // be consistent with matrix definition
897 Vmath::Neg(m_ncoeffs, wsp, 1);
898 }
899 else
900 {
901 Vmath::Smul(m_ncoeffs, -1.0, inarray, 1, wsp, 1);
902 }
903
904 // Forcing function with weak boundary conditions
905 int i, j;
906 int bndcnt = 0;
907 Array<OneD, NekDouble> sign =
908 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsSign();
909 const Array<OneD, const int> map =
910 m_locToGloMap->GetBndCondCoeffsToLocalCoeffsMap();
911 // Add weak boundary conditions to forcing
912 for (i = 0; i < m_bndCondExpansions.size(); ++i)
913 {
914 if (m_bndConditions[i]->GetBoundaryConditionType() ==
916 m_bndConditions[i]->GetBoundaryConditionType() ==
918 {
919
920 const Array<OneD, const NekDouble> bndcoeff =
922
923 if (m_locToGloMap->GetSignChange())
924 {
925 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
926 {
927 wsp[map[bndcnt + j]] += sign[bndcnt + j] * bndcoeff[j];
928 }
929 }
930 else
931 {
932 for (j = 0; j < (m_bndCondExpansions[i])->GetNcoeffs(); j++)
933 {
934 wsp[map[bndcnt + j]] += bndcoeff[bndcnt + j];
935 }
936 }
937 }
938
939 bndcnt += m_bndCondExpansions[i]->GetNcoeffs();
940 }
941
944
945 StdRegions::VarCoeffMap varcoeff(pvarcoeff);
947 {
948 // initialize if required
949 if (!m_GJPData)
950 {
953 }
954
955 if (m_GJPData->IsSemiImplicit())
956 {
958 }
959
960 // to set up forcing need initial guess in physical space
961 Array<OneD, NekDouble> phys(m_npoints), tmp;
962 BwdTrans(outarray, phys);
963 NekDouble scale = -1.0 * factors.find(StdRegions::eFactorGJP)->second;
964
965 m_GJPData->Apply(phys, wsp,
966 pvarcoeff.count(StdRegions::eVarCoeffGJPNormVel)
967 ? pvarcoeff.find(StdRegions::eVarCoeffGJPNormVel)
968 ->second.GetValue()
970 scale);
971
972 varcoeff.erase(StdRegions::eVarCoeffGJPNormVel);
973 }
974
975 // Solve the system
976 GlobalLinSysKey key(mtype, m_locToGloMap, factors, pvarcoeff, varfactors);
977
978 GlobalSolve(key, wsp, outarray, dirForcing);
979
980 return key;
981}
@ eLinearAdvectionDiffusionReactionGJP
Definition: StdRegions.hpp:105

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), Nektar::MultiRegions::ExpList::BwdTrans(), Nektar::StdRegions::eFactorGJP, Nektar::StdRegions::eLinearAdvectionDiffusionReaction, Nektar::StdRegions::eLinearAdvectionDiffusionReactionGJP, Nektar::SpatialDomains::eNeumann, Nektar::SpatialDomains::eRobin, Nektar::StdRegions::eVarCoeffGJPNormVel, Nektar::VarcoeffHashingTest::factors, 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_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 992 of file ContField.cpp.

997{
998 // Inner product of forcing
999 Array<OneD, NekDouble> wsp(m_ncoeffs);
1000 IProductWRTBase(inarray, wsp);
1001
1002 // Solve the system
1005 StdRegions::VarCoeffMap varcoeffs;
1006 varcoeffs[StdRegions::eVarCoeffVelX] = velocity[0];
1007 varcoeffs[StdRegions::eVarCoeffVelY] = velocity[1];
1009 factors, varcoeffs);
1010
1011 GlobalSolve(key, wsp, outarray, dirForcing);
1012}
const std::vector< NekDouble > velocity

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

◆ v_LocalToGlobal() [1/2]

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

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 745 of file ContField.cpp.

747{
748 m_locToGloMap->LocalToGlobal(m_coeffs, m_coeffs, useComm);
749}

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 739 of file ContField.cpp.

741{
742 m_locToGloMap->LocalToGlobal(inarray, outarray, useComm);
743}

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().

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

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

Reimplemented from Nektar::MultiRegions::ExpList.

Definition at line 277 of file ContField.cpp.

281{
282 GlobalLinSysKey key(StdRegions::eMass, m_locToGloMap);
283 GlobalSolve(key, inarray, outarray);
284}

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

◆ 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 259 of file ContField.cpp.

260{
261 int Ncoeffs = m_locToGloMap->GetNumLocalCoeffs();
262 Array<OneD, NekDouble> tmp1(Ncoeffs);
263 Array<OneD, NekDouble> tmp2(Ncoeffs);
264
265 IProductWRTBase(field, tmp1);
266 MultiplyByInvMassMatrix(tmp1, tmp2);
267 BwdTrans(tmp2, field);
268}
void MultiplyByInvMassMatrix(const Array< OneD, const NekDouble > &inarray, Array< OneD, NekDouble > &outarray)
Definition: ExpList.h:1725

References Nektar::MultiRegions::ExpList::BwdTrans(), Nektar::MultiRegions::ExpList::IProductWRTBase(), m_locToGloMap, and Nektar::MultiRegions::ExpList::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 1035 of file ContField.cpp.

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

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 164 of file ContField.h.

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

◆ 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 161 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 155 of file ContField.h.

Referenced by GetGlobalMatrix(), and GetGlobalMatrixNnz().

◆ m_locToGloMap

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