35 #include <boost/core/ignore_unused.hpp>
55 #include <boost/format.hpp>
67 std::string EquationSystem::equationSystemTypeLookupIds[2] = {
68 LibUtilities::SessionReader::RegisterEnumValue(
"DEALIASING",
70 LibUtilities::SessionReader::RegisterEnumValue(
"DEALIASING",
98 EquationSystem::EquationSystem(
101 : m_comm (pSession->GetComm()),
102 m_session (pSession),
108 const vector<std::string> filenames =
m_session->GetFilenames();
110 for(
int i = 0; i < filenames.size(); ++i)
112 string sessionname =
"SessionName";
113 sessionname += boost::lexical_cast<std::string>(i);
116 boost::lexical_cast<std::string>(0);
151 if (0 ==
m_comm->GetRank())
156 if (
m_session->DefinesSolverInfo(
"HOMOGENEOUS"))
158 std::string HomoStr =
m_session->GetSolverInfo(
"HOMOGENEOUS");
161 if ((HomoStr ==
"HOMOGENEOUS1D") || (HomoStr ==
"Homogeneous1D")
162 || (HomoStr ==
"1D") || (HomoStr ==
"Homo1D"))
168 if(
m_session->DefinesSolverInfo(
"ModeType"))
170 m_session->MatchSolverInfo(
"ModeType",
"SingleMode",
172 m_session->MatchSolverInfo(
"ModeType",
"HalfMode",
174 m_session->MatchSolverInfo(
"ModeType",
"MultipleModes",
179 if (
m_session->DefinesSolverInfo(
"ModeType"))
195 ASSERTL0(
false,
"SolverInfo ModeType not valid");
204 if ((HomoStr ==
"HOMOGENEOUS2D") || (HomoStr ==
"Homogeneous2D")
205 || (HomoStr ==
"2D") || (HomoStr ==
"Homo2D"))
215 if ((HomoStr ==
"HOMOGENEOUS3D") || (HomoStr ==
"Homogeneous3D")
216 || (HomoStr ==
"3D") || (HomoStr ==
"Homo3D"))
228 m_session->MatchSolverInfo(
"DEALIASING",
"True",
238 m_session->MatchSolverInfo(
"SPECTRALHPDEALIASING",
"True",
242 m_session->MatchSolverInfo(
"SPECTRALHPDEALIASING",
"On",
248 if (
m_session->DefinesSolverInfo(
"PROJECTION"))
250 std::string ProjectStr =
m_session->GetSolverInfo(
"PROJECTION");
252 if ((ProjectStr ==
"Continuous") || (ProjectStr ==
"Galerkin") ||
253 (ProjectStr ==
"CONTINUOUS") || (ProjectStr ==
"GALERKIN"))
257 else if ((ProjectStr ==
"MixedCGDG") ||
258 (ProjectStr ==
"Mixed_CG_Discontinuous"))
262 else if(ProjectStr ==
"DisContinuous")
268 ASSERTL0(
false,
"PROJECTION value not recognised");
273 cerr <<
"Projection type not specified in SOLVERINFO,"
274 "defaulting to continuous Galerkin" << endl;
282 int nvariables =
m_session->GetVariables().size();
283 bool DeclareCoeffPhysArrays =
true;
310 for (i = 0; i <
m_fields.size(); i++)
313 ::ContField3DHomogeneous2D>
323 for (i = 0; i <
m_fields.size(); i++)
350 for(i = 0; i <
m_fields.size(); i++)
353 ::ContField3DHomogeneous1D>
378 for (i = 0; i <
m_fields.size(); i++)
380 if(
m_session->GetVariable(i).compare(
"w")
384 ::ContField3DHomogeneous1D>
396 ::ContField3DHomogeneous1D>
417 for (i = 0; i <
m_fields.size(); i++)
420 ::ContField3DHomogeneous1D>
435 ContField>::AllocateSharedPtr(
438 DeclareCoeffPhysArrays,
441 for (i = 1; i <
m_fields.size(); i++)
443 if (
m_graph->SameExpansionInfo(
448 ContField>::AllocateSharedPtr(
451 DeclareCoeffPhysArrays,
457 ::ContField>::AllocateSharedPtr(
460 DeclareCoeffPhysArrays,
494 DeclareCoeffPhysArrays,
498 for (i = 1; i <
m_fields.size(); i++)
504 ::ContField>::AllocateSharedPtr(
507 DeclareCoeffPhysArrays,
513 ::ContField>::AllocateSharedPtr(
516 DeclareCoeffPhysArrays,
536 for(i = 1; i <
m_fields.size(); ++i)
544 ASSERTL0(
false,
"Expansion dimension not recognised");
567 for (i = 0; i <
m_fields.size(); i++)
570 ::DisContField3DHomogeneous2D>
580 for (i = 0; i <
m_fields.size(); i++)
583 DisContField>::AllocateSharedPtr(
600 for (i = 0; i <
m_fields.size(); i++)
603 ::DisContField3DHomogeneous1D>
612 for (i = 0; i <
m_fields.size(); i++)
615 DisContField>::AllocateSharedPtr(
628 "3D fully periodic problems not implemented yet");
632 for (i = 0; i <
m_fields.size(); i++)
635 DisContField>::AllocateSharedPtr(
643 ASSERTL0(
false,
"Expansion dimension not recognised");
667 m_session->LoadParameter(
"NumQuadPointsError",
674 "Only one of IO_CheckTime and IO_CheckSteps "
676 m_session->LoadParameter(
"TimeIncrementFactor",
737 for (
int i = 0; i < nvariables; ++i)
740 m_fields[i]->EvaluateBoundaryConditions(time, varName);
760 if (
m_fields[field]->GetPhysState() ==
false)
766 if (exactsoln.size())
769 m_fields[field]->GetPhys(), exactsoln);
771 else if (
m_session->DefinesFunction(
"ExactSolution"))
780 m_fields[field]->GetPhys(), exactsoln);
787 if (Normalised ==
true)
793 L2error =
sqrt(L2error*L2error/Vol);
819 if (
m_fields[field]->GetPhysState() ==
false)
825 if (exactsoln.size())
828 m_fields[field]->GetPhys(), exactsoln);
830 else if (
m_session->DefinesFunction(
"ExactSolution"))
839 m_fields[field]->GetPhys(), exactsoln);
851 Linferror = L2INF[1];
894 Tkeys.push_back(BkeyT1);
895 Tkeys.push_back(BkeyT2);
897 Qkeys.push_back(BkeyQ1);
898 Qkeys.push_back(BkeyQ2);
905 int ErrorCoordim = ErrorExp->GetCoordim(0);
906 int ErrorNq = ErrorExp->GetTotPoints();
915 ErrorExp->GetCoords(ErrorXc0);
918 ErrorExp->GetCoords(ErrorXc0, ErrorXc1);
921 ErrorExp->GetCoords(ErrorXc0, ErrorXc1, ErrorXc2);
925 m_session->GetFunction(
"ExactSolution", field);
930 exSol->Evaluate(ErrorXc0,ErrorXc1,ErrorXc2,
m_time,ErrorSol);
934 ErrorExp->BwdTrans_IterPerExp(
m_fields[field]->GetCoeffs(),
935 ErrorExp->UpdatePhys());
937 L2INF[0] = ErrorExp->L2 (ErrorExp->GetPhys(), ErrorSol);
938 L2INF[1] = ErrorExp->Linf(ErrorExp->GetPhys(), ErrorSol);
951 bool dumpInitialConditions,
954 boost::ignore_unused(initialtime);
956 if (
m_session->GetComm()->GetRank() == 0)
958 cout <<
"Initial Conditions:" << endl;
961 if (
m_session->DefinesFunction(
"InitialConditions"))
969 for (
int i = 0; i <
m_fields.size(); ++i)
978 if (
m_session->GetComm()->GetRank() == 0)
981 for (
int i = 0; i <
m_fields.size(); ++i)
983 std::string varName =
m_session->GetVariable(i);
984 cout <<
" - Field " << varName <<
": "
985 <<
GetFunction(
"InitialConditions")->Describe(varName, domain)
993 for (
int i = 0; i <
m_fields.size(); i++)
999 if (
m_session->GetComm()->GetRank() == 0)
1001 cout <<
" - Field " <<
m_session->GetVariable(i)
1002 <<
": 0 (default)" << endl;
1021 "ExactSolution array size mismatch.");
1023 if (
m_session->DefinesFunction(
"ExactSolution"))
1026 m_session->GetVariable(field), outfield, time);
1095 for (
int i = 0; i <
m_fields.size(); i++)
1107 for (
int i = 0; i <
m_fields.size(); i++)
1122 boost::lexical_cast<std::string>(n);
1134 std::vector<std::string> &variables)
1137 boost::lexical_cast<std::string>(n);
1138 WriteFld(outname, field, fieldcoeffs, variables);
1148 boost::lexical_cast<std::string>(n);
1159 std::vector<Array<OneD, NekDouble> > fieldcoeffs(
1161 std::vector<std::string> variables(
m_fields.size());
1163 for (
int i = 0; i <
m_fields.size(); ++i)
1167 fieldcoeffs[i] =
m_fields[i]->UpdateCoeffs();
1195 const std::string &outname,
1198 std::vector<std::string> &variables)
1200 std::vector<LibUtilities::FieldDefinitionsSharedPtr> FieldDef
1201 = field->GetFieldDefinitions();
1202 std::vector<std::vector<NekDouble> > FieldData(FieldDef.size());
1205 for(
int j = 0; j < fieldcoeffs.size(); ++j)
1207 for(
int i = 0; i < FieldDef.size(); ++i)
1210 FieldDef[i]->m_fields.push_back(variables[j]);
1211 field->AppendFieldData(FieldDef[i], FieldData[i],
1220 boost::lexical_cast<std::string>(
m_time);
1227 boost::lexical_cast<std::string>(
m_nchk);
1237 mapping->Output( fieldMetaDataMap, outname);
1239 #ifdef NEKTAR_DISABLE_BACKUPS
1240 bool backup =
false;
1245 m_fld->Write(outname, FieldDef, FieldData, fieldMetaDataMap, backup);
1256 const std::string &infile,
1259 std::vector<LibUtilities::FieldDefinitionsSharedPtr> FieldDef;
1260 std::vector<std::vector<NekDouble> > FieldData;
1263 field_fld->Import(infile,FieldDef,FieldData);
1266 for(
int j = 0; j < pFields.size(); ++j)
1269 pFields[j]->UpdateCoeffs(),1);
1271 for(
int i = 0; i < FieldDef.size(); ++i)
1275 std::string(
"Order of ") + infile
1276 + std::string(
" data and that defined in "
1277 "m_boundaryconditions differs"));
1279 pFields[j]->ExtractDataToCoeffs(FieldDef[i], FieldData[i],
1281 pFields[j]->UpdateCoeffs());
1283 pFields[j]->BwdTrans(pFields[j]->GetCoeffs(),
1284 pFields[j]->UpdatePhys());
1299 const std::string &infile,
1303 std::vector<LibUtilities::FieldDefinitionsSharedPtr> FieldDef;
1304 std::vector<std::vector<NekDouble> > FieldData;
1310 ASSERTL0(ndomains*nvariables == pFields.size(),
1311 "Number of fields does not match the number of variables and domains");
1314 for(
int j = 0; j < ndomains; ++j)
1316 for(
int i = 0; i < nvariables; ++i)
1319 pFields[j*nvariables+i]->UpdateCoeffs(),1);
1321 for(
int n = 0; n < FieldDef.size(); ++n)
1324 std::string(
"Order of ") + infile
1325 + std::string(
" data and that defined in "
1326 "m_boundaryconditions differs"));
1328 pFields[j*nvariables+i]->ExtractDataToCoeffs(
1329 FieldDef[n], FieldData[n],
1331 pFields[j*nvariables+i]->UpdateCoeffs());
1333 pFields[j*nvariables+i]->BwdTrans(
1334 pFields[j*nvariables+i]->GetCoeffs(),
1335 pFields[j*nvariables+i]->UpdatePhys());
1346 const std::string &infile,
1348 std::string &pFieldName)
1350 std::vector<LibUtilities::FieldDefinitionsSharedPtr> FieldDef;
1351 std::vector<std::vector<NekDouble> > FieldData;
1355 field_fld->Import(infile,FieldDef,FieldData);
1358 Vmath::Zero(pField->GetNcoeffs(),pField->UpdateCoeffs(),1);
1360 for(
int i = 0; i < FieldDef.size(); ++i)
1363 for(
int j = 0; j < FieldData.size(); ++j)
1365 if (FieldDef[i]->
m_fields[j] == pFieldName)
1370 ASSERTL1(idx >= 0,
"Field " + pFieldName +
" not found.");
1372 pField->ExtractDataToCoeffs(FieldDef[i], FieldData[i],
1374 pField->UpdateCoeffs());
1376 pField->BwdTrans(pField->GetCoeffs(), pField->UpdatePhys());
1387 const std::string &infile,
1388 std::vector< std::string> &fieldStr,
1392 ASSERTL0(fieldStr.size() <= coeffs.size(),
1393 "length of fieldstr should be the same as pFields");
1395 std::vector<LibUtilities::FieldDefinitionsSharedPtr> FieldDef;
1396 std::vector<std::vector<NekDouble> > FieldData;
1400 field_fld->Import(infile,FieldDef,FieldData);
1403 for(
int j = 0; j < fieldStr.size(); ++j)
1406 for(
int i = 0; i < FieldDef.size(); ++i)
1408 m_fields[0]->ExtractDataToCoeffs(FieldDef[i], FieldData[i],
1409 fieldStr[j], coeffs[j]);
1425 m_fields[0]->EvalBasisNumModesMax());
1427 if (
m_session->GetComm()->GetSize() > 1)
1468 if (
m_session->DefinesSolverInfo(
"UpwindType"))
1471 m_session->GetSolverInfo(
"UpwindType"));
1474 if (
m_session->DefinesSolverInfo(
"AdvectionType"))
1476 std::string AdvectionType;
1477 AdvectionType =
m_session->GetSolverInfo(
"AdvectionType");
1479 GetClassDescription(AdvectionType));
1493 "Mixed Continuous Galerkin and Discontinuous");
1496 if (
m_session->DefinesSolverInfo(
"DiffusionType"))
1498 std::string DiffusionType;
1499 DiffusionType =
m_session->GetSolverInfo(
"DiffusionType");
1501 GetClassDescription(DiffusionType));
1512 ASSERTL0(
false,
"This function is not valid for the Base class");
1519 std::vector<std::string> &variables)
1521 boost::ignore_unused(fieldcoeffs, variables);
#define ASSERTL0(condition, msg)
#define ASSERTL1(condition, msg)
Assert Level 1 – Debugging which is used whether in FULLDEBUG or DEBUG compilation mode....
static GLOBAL_MAPPING_EXPORT MappingSharedPtr Load(const LibUtilities::SessionReaderSharedPtr &pSession, const Array< OneD, MultiRegions::ExpListSharedPtr > &pFields)
Return a pointer to the mapping, creating it on first call.
Describes the specification for a Basis.
static std::shared_ptr< FieldIO > CreateForFile(const LibUtilities::SessionReaderSharedPtr session, const std::string &filename)
Construct a FieldIO object for a given input filename.
static std::shared_ptr< FieldIO > CreateDefault(const LibUtilities::SessionReaderSharedPtr session)
Returns an object for the default FieldIO method.
Provides a generic Factory class.
Defines a specification for a set of points.
General purpose memory allocation routines with the ability to allocate from thread specific memory p...
static std::shared_ptr< DataType > AllocateSharedPtr(const Args &...args)
Allocate a shared pointer from the memory pool.
This class is the abstraction of a global continuous two- dimensional spectral/hp element expansion w...
virtual SOLVER_UTILS_EXPORT void v_DoInitialise()
Virtual function for initialisation implementation.
int m_spacedim
Spatial dimension (>= expansion dim).
SOLVER_UTILS_EXPORT int GetTraceNpoints()
SOLVER_UTILS_EXPORT void ExtraFldOutput(std::vector< Array< OneD, NekDouble > > &fieldcoeffs, std::vector< std::string > &variables)
bool m_useFFT
Flag to determine if FFT is used for homogeneous transform.
SOLVER_UTILS_EXPORT int GetNvariables()
int m_expdim
Expansion dimension.
LibUtilities::FieldIOSharedPtr m_fld
Field input/output.
SOLVER_UTILS_EXPORT void SessionSummary(SummaryList &vSummary)
Write out a session summary.
virtual SOLVER_UTILS_EXPORT void v_SetInitialConditions(NekDouble initialtime=0.0, bool dumpInitialConditions=true, const int domain=0)
virtual SOLVER_UTILS_EXPORT ~EquationSystem()
Destructor.
SpatialDomains::MeshGraphSharedPtr m_graph
Pointer to graph defining mesh.
LibUtilities::CommSharedPtr m_comm
Communicator.
NekDouble m_timestep
Time step size.
SOLVER_UTILS_EXPORT void ImportFld(const std::string &infile, Array< OneD, MultiRegions::ExpListSharedPtr > &pFields)
Input field data from the given file.
NekDouble m_time
Current time of simulation.
bool m_multipleModes
Flag to determine if use multiple homogenenous modes are used.
Array< OneD, MultiRegions::ExpListSharedPtr > m_fields
Array holding all dependent variables.
virtual SOLVER_UTILS_EXPORT void v_TransPhysToCoeff()
Virtual function for transformation to coefficient space.
NekDouble m_fintime
Finish time of the simulation.
virtual SOLVER_UTILS_EXPORT NekDouble v_L2Error(unsigned int field, const Array< OneD, NekDouble > &exactsoln=NullNekDouble1DArray, bool Normalised=false)
Virtual function for the L_2 error computation between fields and a given exact solution.
virtual SOLVER_UTILS_EXPORT MultiRegions::ExpListSharedPtr v_GetPressure(void)
int m_npointsZ
number of points in Z direction (if homogeneous)
SOLVER_UTILS_EXPORT void Checkpoint_Output(const int n)
Write checkpoint file of m_fields.
virtual SOLVER_UTILS_EXPORT void v_ExtraFldOutput(std::vector< Array< OneD, NekDouble > > &fieldcoeffs, std::vector< std::string > &variables)
std::map< std::string, SolverUtils::SessionFunctionSharedPtr > m_sessionFunctions
Map of known SessionFunctions.
NekDouble m_checktime
Time between checkpoints.
virtual SOLVER_UTILS_EXPORT NekDouble v_LinfError(unsigned int field, const Array< OneD, NekDouble > &exactsoln=NullNekDouble1DArray)
Virtual function for the L_inf error computation between fields and a given exact solution.
virtual SOLVER_UTILS_EXPORT void v_EvaluateExactSolution(unsigned int field, Array< OneD, NekDouble > &outfield, const NekDouble time)
SOLVER_UTILS_EXPORT void WriteFld(const std::string &outname)
Write field data to the given filename.
SOLVER_UTILS_EXPORT void ImportFldToMultiDomains(const std::string &infile, Array< OneD, MultiRegions::ExpListSharedPtr > &pFields, const int ndomains)
Input field data from the given file to multiple domains.
NekDouble m_LhomY
physical length in Y direction (if homogeneous)
int m_npointsY
number of points in Y direction (if homogeneous)
std::string m_sessionName
Name of the session.
SOLVER_UTILS_EXPORT void Checkpoint_BaseFlow(const int n)
Write base flow file of m_fields.
bool m_specHP_dealiasing
Flag to determine if dealisising is usde for the Spectral/hp element discretisation.
LibUtilities::SessionReaderSharedPtr m_session
The session reader.
bool m_singleMode
Flag to determine if single homogeneous mode is used.
virtual SOLVER_UTILS_EXPORT bool v_NegatedOp()
Virtual function to identify if operator is negated in DoSolve.
SOLVER_UTILS_EXPORT void ZeroPhysFields()
int m_HomoDirec
number of homogenous directions
Array< OneD, Array< OneD, NekDouble > > m_traceNormals
Array holding trace normals for DG simulations in the forwards direction.
enum HomogeneousType m_HomogeneousType
SOLVER_UTILS_EXPORT Array< OneD, NekDouble > ErrorExtraPoints(unsigned int field)
Compute error (L2 and L_inf) over an larger set of quadrature points return [L2 Linf].
SOLVER_UTILS_EXPORT int GetNpoints()
Array< OneD, bool > m_checkIfSystemSingular
Flag to indicate if the fields should be checked for singularity.
bool m_homogen_dealiasing
Flag to determine if dealiasing is used for homogeneous simulations.
SOLVER_UTILS_EXPORT int GetNcoeffs()
int m_nchk
Number of checkpoints written so far.
enum MultiRegions::ProjectionType m_projectionType
Type of projection; e.g continuous or discontinuous.
NekDouble m_TimeIncrementFactor
virtual SOLVER_UTILS_EXPORT void v_DoSolve()
Virtual function for solve implementation.
virtual SOLVER_UTILS_EXPORT Array< OneD, bool > v_GetSystemSingularChecks()
int m_steps
Number of steps to take.
int m_NumQuadPointsError
Number of Quadrature points used to work out the error.
LibUtilities::FieldMetaDataMap m_fieldMetaDataMap
Map to identify relevant solver info to dump in output fields.
SOLVER_UTILS_EXPORT int GetNumExpModes()
SpatialDomains::BoundaryConditionsSharedPtr m_boundaryConditions
Pointer to boundary conditions object.
SOLVER_UTILS_EXPORT void SetBoundaryConditions(NekDouble time)
Evaluates the boundary conditions at the given time.
NekDouble m_LhomZ
physical length in Z direction (if homogeneous)
virtual SOLVER_UTILS_EXPORT void v_GenerateSummary(SummaryList &l)
Virtual function for generating summary information.
bool m_halfMode
Flag to determine if half homogeneous mode is used.
SOLVER_UTILS_EXPORT void FwdTransFields()
int m_checksteps
Number of steps between checkpoints.
virtual SOLVER_UTILS_EXPORT void v_InitObject()
Initialisation object for EquationSystem.
SOLVER_UTILS_EXPORT SessionFunctionSharedPtr GetFunction(std::string name, const MultiRegions::ExpListSharedPtr &field=MultiRegions::NullExpListSharedPtr, bool cache=false)
Get a SessionFunction by name.
virtual SOLVER_UTILS_EXPORT void v_Output(void)
virtual SOLVER_UTILS_EXPORT void v_TransCoeffToPhys()
Virtual function for transformation to physical space.
GLOBAL_MAPPING_EXPORT typedef std::shared_ptr< Mapping > MappingSharedPtr
A shared pointer to a Mapping object.
void Import(const std::string &infilename, std::vector< FieldDefinitionsSharedPtr > &fielddefs, std::vector< std::vector< NekDouble > > &fielddata, FieldMetaDataMap &fieldinfomap, const Array< OneD, int > &ElementIDs)
This function allows for data to be imported from an FLD file when a session and/or communicator is n...
std::shared_ptr< FieldIO > FieldIOSharedPtr
std::map< std::string, std::string > FieldMetaDataMap
std::shared_ptr< SessionReader > SessionReaderSharedPtr
std::shared_ptr< Equation > EquationSharedPtr
static FieldMetaDataMap NullFieldMetaDataMap
std::vector< BasisKey > BasisKeyVector
Name for a vector of BasisKeys.
@ eFourierEvenlySpaced
1D Evenly-spaced points using Fourier Fit
@ eGaussLobattoLegendre
1D Gauss-Lobatto-Legendre quadrature points
@ eFourierSingleModeSpaced
1D Non Evenly-spaced points for Single Mode analysis
@ eGaussRadauMAlpha1Beta0
Gauss Radau pinned at x=-1, .
@ eModified_B
Principle Modified Functions .
@ eFourierSingleMode
Fourier ModifiedExpansion with just the first mode .
@ eModified_A
Principle Modified Functions .
@ eFourierHalfModeIm
Fourier Modified expansions with just the imaginary part of the first mode
@ eFourierHalfModeRe
Fourier Modified expansions with just the real part of the first mode
@ eFourier
Fourier Expansion .
@ eMixed_CG_Discontinuous
std::shared_ptr< ExpList > ExpListSharedPtr
Shared pointer to an ExpList object.
std::shared_ptr< ContField > ContFieldSharedPtr
AdvectionFactory & GetAdvectionFactory()
Gets the factory for initialising advection objects.
std::vector< std::pair< std::string, std::string > > SummaryList
DiffusionFactory & GetDiffusionFactory()
EquationSystemFactory & GetEquationSystemFactory()
void AddSummaryItem(SummaryList &l, const std::string &name, const std::string &value)
Adds a summary item to the summary info list.
std::shared_ptr< SessionFunction > SessionFunctionSharedPtr
std::shared_ptr< ExpansionInfoMap > ExpansionInfoMapShPtr
std::shared_ptr< MeshGraph > MeshGraphSharedPtr
std::map< int, ExpansionInfoShPtr > ExpansionInfoMap
The above copyright notice and this permission notice shall be included.
NekMatrix< NekMatrix< NekDouble, StandardMatrixTag >, ScaledMatrixTag > DNekScalMat
NekMatrix< NekMatrix< NekMatrix< NekDouble, StandardMatrixTag >, ScaledMatrixTag >, BlockMatrixTag > DNekScalBlkMat
void Zero(int n, T *x, const int incx)
Zero vector.
scalarT< T > sqrt(scalarT< T > in)
Used to lookup the create function in NekManager.