Nektar++
|
Classes | |
class | PointTestClass |
struct | TenD |
class | TestPoint |
class | VectorTestClass |
Functions | |
double | ddot (int n, double *x, int incx, double *y, int incy) |
Dot product two vectors. More... | |
std::vector< double > | z (NPUPPER) |
std::vector< double > | w (NPUPPER) |
std::vector< double > | p (NPUPPER) |
std::vector< double > | d (NPUPPER *NPUPPER) |
std::vector< double > | q (NPUPPER *NPUPPER) |
void | TestIntegral (std::function< void(double *, double *, int, double, double)> func, int o) |
Test integrals of Jacobi polynomials. More... | |
void | TestDifferentiation (std::function< void(double *, double *, int, double, double)> func, std::function< void(double *, double *, int, double, double)> funcD) |
Test derivatives using Gaussian quadrature. More... | |
void | TestInterpolation (std::function< void(double *, double *, int, double, double)> func, std::function< void(double *, double *, double *, int, int, double, double)> funcI) |
Evaluate interpolation using Gaussian quadrature. More... | |
void | TestIntegralMatrix (std::function< void(double *, double *, int, double, double)> func, std::function< void(double *, double *, int)> funcQ) |
BOOST_AUTO_TEST_CASE (TestGaussInt) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauM) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauP) | |
BOOST_AUTO_TEST_CASE (TestGaussLobatto) | |
BOOST_AUTO_TEST_CASE (TestGaussDiff) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauMDiff) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauPDiff) | |
BOOST_AUTO_TEST_CASE (TestGaussLobattoDiff) | |
BOOST_AUTO_TEST_CASE (TestGaussInterp) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauMInterp) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauPInterp) | |
BOOST_AUTO_TEST_CASE (TestGaussLobattoInterp) | |
BOOST_AUTO_TEST_CASE (TestGaussIntMatrix) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauMIntMatrix) | |
BOOST_AUTO_TEST_CASE (TestGaussRadauPIntMatrix) | |
BOOST_AUTO_TEST_CASE (TestGaussLobattoIntMatrix) | |
BOOST_AUTO_TEST_CASE (TestGammaFraction) | |
BOOST_AUTO_TEST_CASE (testNekMatrixConstruction) | |
BOOST_AUTO_TEST_CASE (testNekMatrixBasicMath) | |
bool | operator== (const PointTestClass &lhs, const PointTestClass &rhs) |
bool | operator!= (const PointTestClass &lhs, const PointTestClass &rhs) |
void | test () |
BOOST_AUTO_TEST_CASE (testNekPointConstruction) | |
bool | operator== (const VectorTestClass &lhs, const VectorTestClass &rhs) |
bool | operator!= (const VectorTestClass &lhs, const VectorTestClass &rhs) |
BOOST_AUTO_TEST_CASE (TestNekVectorConstruction) | |
BOOST_AUTO_TEST_CASE (TestNekVectorOperators) | |
BOOST_AUTO_TEST_CASE (TestNekVectorArithmetic) | |
BOOST_AUTO_TEST_CASE (TestNorms) | |
BOOST_AUTO_TEST_CASE (TestMatrixVectorMultiply) | |
BOOST_AUTO_TEST_CASE (TestVectorConstructorsWithSizeArguments) | |
void | RedirectCerrIfNeeded () |
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGammaFraction | ) |
Definition at line 324 of file TestPolylib.cpp.
References Nektar::LibUtilities::beta, EPS, Polylib::gammaF(), Polylib::gammaFracGammaF(), and test().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussDiff | ) |
Definition at line 264 of file TestPolylib.cpp.
References Polylib::Dgj(), TestDifferentiation(), and Polylib::zwgj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussInt | ) |
Definition at line 244 of file TestPolylib.cpp.
References TestIntegral(), and Polylib::zwgj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussInterp | ) |
Definition at line 284 of file TestPolylib.cpp.
References Polylib::Imgj(), TestInterpolation(), and Polylib::zwgj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussIntMatrix | ) |
Definition at line 304 of file TestPolylib.cpp.
References Polylib::Qg(), TestIntegralMatrix(), and Polylib::zwgj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussLobatto | ) |
Definition at line 259 of file TestPolylib.cpp.
References TestIntegral(), and Polylib::zwglj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussLobattoDiff | ) |
Definition at line 279 of file TestPolylib.cpp.
References Polylib::Dglj(), TestDifferentiation(), and Polylib::zwglj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussLobattoInterp | ) |
Definition at line 299 of file TestPolylib.cpp.
References Polylib::Imglj(), TestInterpolation(), and Polylib::zwglj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussLobattoIntMatrix | ) |
Definition at line 319 of file TestPolylib.cpp.
References Polylib::Qg(), TestIntegralMatrix(), and Polylib::zwglj().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauM | ) |
Definition at line 249 of file TestPolylib.cpp.
References TestIntegral(), and Polylib::zwgrjm().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauMDiff | ) |
Definition at line 269 of file TestPolylib.cpp.
References Polylib::Dgrjm(), TestDifferentiation(), and Polylib::zwgrjm().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauMInterp | ) |
Definition at line 289 of file TestPolylib.cpp.
References Polylib::Imgrjm(), TestInterpolation(), and Polylib::zwgrjm().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauMIntMatrix | ) |
Definition at line 309 of file TestPolylib.cpp.
References Polylib::Qg(), TestIntegralMatrix(), and Polylib::zwgrjm().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauP | ) |
Definition at line 254 of file TestPolylib.cpp.
References TestIntegral(), and Polylib::zwgrjp().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauPDiff | ) |
Definition at line 274 of file TestPolylib.cpp.
References Polylib::Dgrjp(), TestDifferentiation(), and Polylib::zwgrjp().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauPInterp | ) |
Definition at line 294 of file TestPolylib.cpp.
References Polylib::Imgrjp(), TestInterpolation(), and Polylib::zwgrjp().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestGaussRadauPIntMatrix | ) |
Definition at line 314 of file TestPolylib.cpp.
References Polylib::Qg(), TestIntegralMatrix(), and Polylib::zwgrjp().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestMatrixVectorMultiply | ) |
Definition at line 189 of file testNekVector.cpp.
References Nektar::NekVector< DataType >::GetDimension(), and Nektar::Transpose().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | testNekMatrixBasicMath | ) |
Definition at line 429 of file testNekMatrix.cpp.
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | testNekMatrixConstruction | ) |
Definition at line 408 of file testNekMatrix.cpp.
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | testNekPointConstruction | ) |
Definition at line 103 of file testNekPoint.cpp.
References Nektar::NekPoint< data_type >::x(), Nektar::NekPoint< data_type >::y(), and Nektar::NekPoint< data_type >::z().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestNekVectorArithmetic | ) |
Definition at line 174 of file testNekVector.cpp.
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestNekVectorConstruction | ) |
Definition at line 94 of file testNekVector.cpp.
References Nektar::NekVector< DataType >::GetDimension().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestNekVectorOperators | ) |
Definition at line 128 of file testNekVector.cpp.
References Nektar::NekVector< DataType >::x(), Nektar::NekVector< DataType >::y(), and Nektar::NekVector< DataType >::z().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestNorms | ) |
Definition at line 178 of file testNekVector.cpp.
References Nektar::NekVector< DataType >::InfinityNorm(), Nektar::NekVector< DataType >::L1Norm(), Nektar::NekVector< DataType >::L2Norm(), and tinysimd::sqrt().
Nektar::UnitTests::BOOST_AUTO_TEST_CASE | ( | TestVectorConstructorsWithSizeArguments | ) |
Definition at line 335 of file testNekVector.cpp.
References Nektar::NekVector< DataType >::begin(), Nektar::NekVector< DataType >::end(), Nektar::eWrapper, Nektar::NekVector< DataType >::GetDimension(), and Nektar::NekVector< DataType >::GetRows().
std::vector< double > Nektar::UnitTests::d | ( | NPUPPER * | NPUPPER | ) |
Referenced by CellMLToNektar.translators.ConfigurationStore::_find_transmembrane_currents_from_voltage_ode(), Nektar::SpatialDomains::GeomFactors::Adjoint(), Nektar::MemoryManager< DataType >::AllocateSharedPtrD(), Nektar::AsString(), Nektar::ScaledMatrixUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::SharedArrayUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::SolverUtils::DiffusionIP::CalcTraceNumFlux(), Nektar::GlobalMapping::MappingGeneral::CalculateMetricTerms(), Nektar::SharedArrayUnitTests::CheckAddresses(), Nektar::MultiRegions::ExpList::CreateCollections(), Nektar::SpatialDomains::MeshGraphIOXml::CreateCompositeOrdering(), Nektar::FieldUtils::Field::CreateExp(), Nektar::MMFDiffusion::DoOdeRhs(), Arpack::Dseupd(), Lapack::Dsterf(), Nektar::SolverUtils::DriverSteadyState::EvalEV_ScalarSFD(), EvaluateTangent(), Nektar::LibUtilities::Interpolator::FindNeighbours(), Nektar::LibUtilities::Interpolator::FindNNeighbours(), Nektar::PulseWaveSystem::GetCommArray(), Nektar::NavierStokesCFE::GetDivCurlSquared(), Nektar::SpatialDomains::MeshGraph::GetElementsFromEdge(), Nektar::LibUtilities::FieldIO::GetFileType(), Nektar::UnsteadyDiffusion::GetFluxVector(), Nektar::CompressibleFlowSystem::GetFluxVector(), GetInterfaces_wrapper(), Nektar::VariableConverter::GetInternalEnergy(), Nektar::SolverUtils::FilterLagrangianPoints::GetPhysicsData(), Nektar::NavierStokesCFE::GetViscousFluxBilinearFormKernel(), Nektar::NavierStokesCFE::GetViscousFluxVectorConservVar(), Nektar::NavierStokesCFE::GetViscousSymmtrFluxConservVar(), Nektar::NonlinearPeregrine::LaitoneSolitaryWave(), main(), Nektar::NekMatrix< DataType, StandardMatrixTag >::NekMatrix(), Nektar::FieldUtils::OutputVtk::OutputFromExpLowOrder(), Nektar::FieldUtils::OutputVtk::OutputFromExpLowOrderMultiBlock(), Nektar::SolverUtils::FilterLagrangianPoints::OutputSamplePoints(), Nektar::SolverUtils::EvaluatePoints::Pack2Int(), Nektar::SolverUtils::EvaluatePoints::Pack3Int(), Nektar::LibUtilities::SessionReader::ParseCommandLineArguments(), Nektar::FieldUtils::ProcessGrad::ParserOptions(), Polylib::polycoeffs(), PolyFit(), PolyInterp(), Nektar::SpatialDomains::MeshGraph::ReadExpansionInfo(), Nektar::PulseWaveSystem::SetUpDomainInterfaceBCs(), Nektar::PulseWaveSystem::SetUpDomainInterfaces(), Nektar::SpatialDomains::MeshGraph::SetUpExpansionInfoMap(), Nektar::Matrix< DataType >::SetValue(), Nektar::NekMatrix< DataType, StandardMatrixTag >::SetValue(), boost::python::converter::shared_ptr_to_python(), Nektar::SolverUtils::StatLagrangianPoints::StatLagrangianPoints(), Nektar::LocalRegions::Expansion::StdDerivBaseOnTraceMat(), TestDifferentiation(), TestInterpolation(), Polylib::TriQL(), Nektar::SolverUtils::EvaluatePoints::unPack2Int(), Nektar::SolverUtils::EvaluatePoints::unPack3Int(), Nektar::Collections::Helmholtz_IterPerExp::UpdateFactors(), Nektar::SolverUtils::StatLagrangianPoints::v_AssignPoint(), Nektar::LibUtilities::NodalTetElec::v_CalculatePoints(), Nektar::SpatialDomains::RefRegionCylinder::v_Contains(), Nektar::SpatialDomains::RefRegionParallelogram::v_Contains(), Nektar::PulseWaveSystem::v_DoInitialise(), Nektar::SpatialDomains::HexGeom::v_GenGeomFactors(), Nektar::SpatialDomains::PrismGeom::v_GenGeomFactors(), Nektar::SpatialDomains::QuadGeom::v_GenGeomFactors(), Nektar::SpatialDomains::TriGeom::v_GenGeomFactors(), Nektar::LocalRegions::Expansion2D::v_GenMatrix(), Nektar::LocalRegions::Expansion3D::v_GenMatrix(), Nektar::SolverUtils::StatLagrangianPoints::v_GetCoords(), Nektar::LibUtilities::NodalTriElec::v_GetI(), Nektar::LibUtilities::NodalTriEvenlySpaced::v_GetI(), Nektar::LibUtilities::NodalTriFekete::v_GetI(), Nektar::LibUtilities::NodalPrismElec::v_GetI(), Nektar::LibUtilities::NodalPrismEvenlySpaced::v_GetI(), Nektar::LibUtilities::NodalTetElec::v_GetI(), Nektar::LibUtilities::NodalTetEvenlySpaced::v_GetI(), Nektar::LibUtilities::PolyEPoints::v_GetI(), Nektar::MultiRegions::ExpList::v_GetNormals(), Nektar::SolverUtils::StatLagrangianPoints::v_GetPhysics(), Nektar::SolverUtils::FilterLagrangianPoints::v_Initialise(), Nektar::PulseWaveSystem::v_InitObject(), Nektar::SolverUtils::StatLagrangianPoints::v_OutputData(), Nektar::FieldUtils::InputFld::v_Process(), Nektar::FieldUtils::ProcessCreateExp::v_Process(), Nektar::FieldUtils::ProcessMRF::v_Process(), Nektar::SolverUtils::StatLagrangianPoints::v_ReSize(), Nektar::SolverUtils::StatLagrangianPoints::v_SetCoords(), Nektar::SolverUtils::StatLagrangianPoints::v_SetPhysics(), Nektar::NekMatrix< DataType, StandardMatrixTag >::v_SetValue(), and Nektar::SolverUtils::StatLagrangianPoints::v_TimeAdvance().
double Nektar::UnitTests::ddot | ( | int | n, |
double * | x, | ||
int | incx, | ||
double * | y, | ||
int | incy | ||
) |
Dot product two vectors.
Definition at line 55 of file TestPolylib.cpp.
Referenced by TestDifferentiation(), TestIntegral(), TestIntegralMatrix(), and TestInterpolation().
bool Nektar::UnitTests::operator!= | ( | const PointTestClass & | lhs, |
const PointTestClass & | rhs | ||
) |
Definition at line 76 of file testNekPoint.cpp.
bool Nektar::UnitTests::operator!= | ( | const VectorTestClass & | lhs, |
const VectorTestClass & | rhs | ||
) |
Definition at line 84 of file testNekVector.cpp.
bool Nektar::UnitTests::operator== | ( | const PointTestClass & | lhs, |
const PointTestClass & | rhs | ||
) |
Definition at line 71 of file testNekPoint.cpp.
References Nektar::UnitTests::PointTestClass::value().
bool Nektar::UnitTests::operator== | ( | const VectorTestClass & | lhs, |
const VectorTestClass & | rhs | ||
) |
Definition at line 79 of file testNekVector.cpp.
References Nektar::UnitTests::VectorTestClass::value().
std::vector< double > Nektar::UnitTests::p | ( | NPUPPER | ) |
Referenced by test(), TestDifferentiation(), TestIntegral(), TestIntegralMatrix(), and TestInterpolation().
std::vector< double > Nektar::UnitTests::q | ( | NPUPPER * | NPUPPER | ) |
Referenced by Nektar::LibUtilities::FractionalInTimeIntegrationScheme::advanceSandbox(), Nektar::MultiRegions::AssemblyMapCG::AssemblyMapCG(), Nektar::FieldUtils::ProcessInterpPoints::calcCp0(), Nektar::FieldUtils::ProcessInterpPtsToPts::calcCp0(), Polylib::chri1(), EvaluateTangent(), Nektar::LibUtilities::Basis::GenBasis(), Nektar::Collections::CoalescedGeomData::GetDerivFactorsInterLeave(), Nektar::Collections::CoalescedGeomData::GetJacInterLeave(), Nektar::StdRegions::StdPrismExp::GetMode(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::integralClassInitialize(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::integralContribution(), main(), MappingEVids(), Nektar::FieldUtils::MatSymEVals(), Nektar::LibUtilities::SessionReader::MergeDoc(), Nektar::SolverUtils::EvaluatePoints::Pack3Int(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::talbotQuadrature(), TestIntegralMatrix(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::timeAdvance(), Nektar::SolverUtils::EvaluatePoints::unPack3Int(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::updateStage(), Nektar::Collections::LinearAdvectionDiffusionReaction_MatrixFree::UpdateVarcoeffs(), Nektar::StdRegions::StdHexExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPrismExp::v_GetBoundaryMap(), Nektar::StdRegions::StdPyrExp::v_GetBoundaryMap(), Nektar::StdRegions::StdHexExp::v_GetEdgeInteriorToElementMap(), Nektar::StdRegions::StdHexExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetInteriorMap(), Nektar::StdRegions::StdPyrExp::v_GetInteriorMap(), Nektar::StdRegions::StdPrismExp::v_GetTraceCoeffMap(), Nektar::StdRegions::StdPyrExp::v_GetTraceCoeffMap(), Nektar::StdRegions::StdHexExp::v_GetTraceInteriorToElementMap(), Nektar::StdRegions::StdPrismExp::v_GetTraceInteriorToElementMap(), Nektar::StdRegions::StdPyrExp::v_GetTraceInteriorToElementMap(), Nektar::StdRegions::StdHexExp::v_GetVertexMap(), Nektar::FieldUtils::ProcessQualityMetric::v_Process(), Nektar::SpatialDomains::MeshGraphIOXml::v_WriteQuads(), and Nektar::SpatialDomains::MeshGraphIOXmlCompressed::v_WriteQuads().
void Nektar::UnitTests::RedirectCerrIfNeeded | ( | ) |
Definition at line 41 of file util.cpp.
References Nektar::ErrorUtil::HasCustomErrorStream(), and Nektar::ErrorUtil::SetErrorStream().
Referenced by Nektar::SharedArrayUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::DiagonalMatrixStoragePolicyUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::LowerTriangularStoragePolicyUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::SymmetricMatrixStoragePolicyUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::UpperTriangularUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::FullMatrixStoragePolicyUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::BandedMatrixStoragePolicyUnitTests::BOOST_AUTO_TEST_CASE(), Nektar::MatrixUnitTests::BOOST_AUTO_TEST_CASE(), and Nektar::ConsistentObjectAccessUnitTests::BOOST_AUTO_TEST_CASE().
void Nektar::UnitTests::test | ( | ) |
Definition at line 92 of file testNekPoint.cpp.
References p().
Referenced by Nektar::VariableSizedNekVectorUnitTests::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), Nektar::SolverUtils::DriverModifiedArnoldi::EV_sort(), OUTPUT(), and Nektar::FieldUtils::InputNek5000::v_Process().
|
inline |
Test derivatives using Gaussian quadrature.
This routine evaluates the deriatives
\[ \frac{d}{dx}(x^n) = nx^{n-1} \]
using \( -0.5 \leq \alpha,\beta \leq 5 \) and using \( N \) points where \( N \) lies between NPLOWER and NPUPPER. Tolerance is taken using the EPS value.
Definition at line 116 of file TestPolylib.cpp.
References Nektar::LibUtilities::beta, d(), ddot(), EPS, NPLOWER, NPUPPER, p(), w(), and z().
Referenced by BOOST_AUTO_TEST_CASE().
|
inline |
Test integrals of Jacobi polynomials.
This routine evaluates the integral
\[ \int_{-1}^1 (1-x)^\alpha (1+x)^\beta P_n^{\alpha,\beta} dx = 0 \]
using \( -0.5 \leq \alpha,\beta \leq 5 \) and using \( N \) points where \( N \) lies between NPLOWER and NPUPPER. Tolerance is taken using the EPS value.
Definition at line 81 of file TestPolylib.cpp.
References Nektar::LibUtilities::beta, ddot(), EPS, Polylib::jacobfd(), NPLOWER, NPUPPER, p(), w(), and z().
Referenced by BOOST_AUTO_TEST_CASE().
|
inline |
Definition at line 205 of file TestPolylib.cpp.
References Nektar::LibUtilities::beta, ddot(), EPS, NPLOWER, NPUPPER, p(), q(), w(), and z().
Referenced by BOOST_AUTO_TEST_CASE().
|
inline |
Evaluate interpolation using Gaussian quadrature.
This routine evaluates the interpolation of \( z^n \) to \( x^n \), where \( z \) are the quadrature zeros and \( x \) are the equispaced points
\[ x_n = \frac{2n}{N-1} - 1, \quad 0\leq n\leq N, \]
using \( -0.5 \leq \alpha,\beta \leq 5 \) and using \( N \) points where \( N \) lies between NPLOWER and NPUPPER. Tolerance is taken using the EPS value.
Definition at line 165 of file TestPolylib.cpp.
References Nektar::LibUtilities::beta, d(), ddot(), EPS, NPLOWER, NPUPPER, p(), w(), and z().
Referenced by BOOST_AUTO_TEST_CASE().
std::vector< double > Nektar::UnitTests::w | ( | NPUPPER | ) |
Referenced by Nektar::SolverUtils::DriverParareal::ApplyWindowing(), Nektar::MultiRegions::GlobalLinSysDirectFull::AssembleFullMatrix(), Nektar::VmathSIMDUnitTests::BOOST_AUTO_TEST_CASE(), sha1::calc(), Nektar::SolverUtils::DriverParareal::CopyConvergedCheckPoints(), Cutrepetitions(), Vmath::Ddot(), Nektar::LibUtilities::NekLinSysIterGMRES::DoArnoldi(), Nektar::LibUtilities::NekLinSysIterGMRESLoc::DoArnoldi(), Nektar::LibUtilities::NekLinSysIterGMRES::DoGmresRestart(), Nektar::LibUtilities::NekLinSysIterGMRESLoc::DoGmresRestart(), Vmath::Dot(), Vmath::Dot2(), Lapack::Dsbev(), Lapack::Dspev(), Nektar::MultiRegions::DisContField::FindPeriodicTraces(), Nektar::LibUtilities::Basis::GenBasis(), Nektar::NavierStokesImplicitCFE::GetdFlux_dQx_3D(), Nektar::NavierStokesImplicitCFE::GetdFlux_dQy_3D(), Nektar::NavierStokesImplicitCFE::GetdFlux_dQz_3D(), Nektar::NavierStokesImplicitCFE::GetdFlux_dU_3D(), Nektar::LibUtilities::Points< DataT >::GetZW(), Nektar::LibUtilities::Basis::GetZW(), Nektar::L2Norm(), main(), MappingEVids(), Orderfunctionx(), PolyFit(), PolyInterp(), Nektar::LibUtilities::H5::DataSet::Read(), Nektar::FieldUtils::Iso::Smooth(), Nektar::LibUtilities::FractionalInTimeIntegrationScheme::talbotQuadrature(), TestDifferentiation(), TestIntegral(), TestIntegralMatrix(), TestInterpolation(), Nektar::MultiRegions::GlobalLinSysDirectStaticCond::v_AssembleSchurComplement(), Nektar::LibUtilities::NodalPrismElec::v_CalculateWeights(), Nektar::LibUtilities::NodalPrismEvenlySpaced::v_CalculateWeights(), Nektar::LibUtilities::NodalTetElec::v_CalculateWeights(), Nektar::LibUtilities::NodalTetEvenlySpaced::v_CalculateWeights(), Nektar::LibUtilities::NodalTriElec::v_CalculateWeights(), Nektar::LibUtilities::NodalTriEvenlySpaced::v_CalculateWeights(), Nektar::LibUtilities::NodalTriFekete::v_CalculateWeights(), Nektar::LibUtilities::PolyEPoints::v_CalculateWeights(), Nektar::SolverUtils::DriverParareal::v_Execute(), Nektar::SolverUtils::DriverPFASST::v_Execute(), Nektar::StdRegions::StdPointExp::v_IProductWRTBase(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase(), Nektar::StdRegions::StdSegExp::v_IProductWRTBase_SumFac(), Nektar::MultiRegions::ExpList3DHomogeneous1D::v_L2(), Nektar::FentonKarma::v_Update(), Vmath::Vstvpp(), Vmath::SIMD::Vvtvm(), Vmath::Vvtvm(), Vmath::SIMD::Vvtvp(), Vmath::Vvtvp(), Vmath::SIMD::Vvtvvtm(), Vmath::Vvtvvtm(), Vmath::SIMD::Vvtvvtp(), Vmath::Vvtvvtp(), Polylib::zwgj(), Polylib::zwgk(), Polylib::zwglj(), Polylib::zwgrjm(), Polylib::zwgrjp(), Polylib::zwlk(), and Polylib::zwrk().
std::vector< double > Nektar::UnitTests::z | ( | NPUPPER | ) |
Referenced by Nektar::MMFAdvection::AdvectionBellPlane(), Nektar::MMFAdvection::AdvectionBellSphere(), Nektar::SolverUtils::UnsteadySystem::AppendOutput1D(), Vmath::Assmb(), Nektar::StdRegions::StdExpansion::BaryEvaluate(), Nektar::VmathSIMDUnitTests::BOOST_AUTO_TEST_CASE(), CheckTetRotation(), Polylib::chri1(), Polylib::Dgj(), Polylib::Dglj(), Polylib::Dgrjm(), Polylib::Dgrjp(), Arpack::Dneupd(), Nektar::MMFDiffusion::DoOdeRhs(), Lapack::Dsbev(), Arpack::Dseupd(), Lapack::Dspev(), Equation_Evaluate2(), Equation_Evaluate3(), Equation_Evaluate4(), Equation_Evaluate5(), Nektar::LibUtilities::Interpreter::ExpressionEvaluator::Evaluate(), Nektar::LibUtilities::Interpreter::Evaluate(), Nektar::LibUtilities::Equation::Evaluate(), Nektar::MMFMaxwell::EvaluateCoriolis(), Nektar::MMFSWE::EvaluateCoriolisForZonalFlow(), Nektar::CompressibleFlowSystem::EvaluateIsentropicVortex(), Nektar::MMFSWE::EvaluateStandardCoriolis(), Nektar::MMFSWE::EvaluateWaterDepth(), Nektar::MultiRegions::DisContField::FindPeriodicTraces(), Vmath::SIMD::Gathr(), Vmath::Gathr(), Nektar::MMFMaxwell::GaussianPulse(), Nektar::LibUtilities::Basis::GenBasis(), Nektar::MMFMaxwell::GenerateSigmaPML(), Nektar::LocalRegions::PointExp::GetCoords(), Nektar::SolverUtils::EvaluatePoints::GetDefaultValue(), Nektar::SpatialDomains::MeshGraph::GetElementsContainingPoint(), Nektar::CompressibleFlowSystem::GetExactRinglebFlow(), Nektar::MultiRegions::ExpList::GetExpIndex(), Nektar::SpatialDomains::TriGeom::GetFaceOrientation(), Nektar::SpatialDomains::QuadGeom::GetFaceOrientation(), Nektar::LibUtilities::Points< DataT >::GetI(), GetNewVertexLocation(), Nektar::StdRegions::StdNodalPrismExp::GetNodalPoints(), Nektar::StdRegions::StdNodalTetExp::GetNodalPoints(), Nektar::LibUtilities::Points< DataT >::GetPoints(), Nektar::LibUtilities::Points< DataT >::GetZW(), Nektar::LibUtilities::Basis::GetZW(), Polylib::hgj(), Polylib::hglj(), Polylib::hgrjm(), Polylib::hgrjp(), Polylib::ImagBesselComp(), Interpreter_Evaluate2(), Interpreter_Evaluate3(), Nektar::MMFSWE::IsolatedMountainFlow(), Polylib::jacobd(), Polylib::jacobfd(), Polylib::Jacobz(), Polylib::JacZeros(), Polylib::laginterp(), Polylib::laginterpderiv(), main(), MappingEVids(), Nektar::FieldUtils::MappingIdealToRef(), Nektar::MMFDiffusion::Morphogenesis(), MoveOutsidePointsfixedxpos(), MoveOutsidePointsNnormpos(), Nektar::LibUtilities::NodalPrismEvenlySpaced::NodalPointReorder3d(), Nektar::LibUtilities::NodalTetEvenlySpaced::NodalPointReorder3d(), OUTPUT(), Nektar::FieldUtils::OutputVtk::OutputFromExpLowOrder(), Nektar::FieldUtils::OutputVtk::OutputFromExpLowOrderMultiBlock(), Nektar::LibUtilities::EulerExponentialTimeIntegrationScheme::phi_function(), Nektar::MMFDiffusion::PlanePhiWave(), Polylib::polycoeffs(), Nektar::MMFMaxwell::Printout_SurfaceCurrent(), Polylib::Qg(), Nektar::MMFSWE::RossbyWave(), Vmath::Scatr(), Nektar::IncNavierStokes::SetUpWomersley(), Nektar::MMFSWE::SteadyZonalFlow(), Vmath::Svtsvtp(), Vmath::Svtvm(), Vmath::Svtvp(), Nektar::MMFDiffusion::TestCubeProblem(), TestDifferentiation(), TestIntegral(), TestIntegralMatrix(), TestInterpolation(), Nektar::MMFMaxwell::TestMaxwellSphere(), Nektar::MMFDiffusion::TestPlaneProblem(), Nektar::MMFSWE::TestVorticityComputation(), Polylib::TriQL(), Nektar::MMFSWE::UnstableJetFlow(), Nektar::MMFSWE::UnsteadyZonalFlow(), Nektar::FilterMovingBody::UpdateForce(), Nektar::IsentropicVortexBC::v_Apply(), Nektar::LibUtilities::NodalPrismEvenlySpaced::v_CalculatePoints(), Nektar::LibUtilities::NodalTetEvenlySpaced::v_CalculatePoints(), Nektar::LibUtilities::PolyEPoints::v_CalculateWeights(), Nektar::MultiRegions::PreconditionerBlock::v_DoPreconditioner(), Nektar::MultiRegions::PreconditionerLowEnergy::v_DoPreconditioner(), Nektar::MMFMaxwell::v_DoSolve(), Nektar::MultiRegions::DisContField3DHomogeneous2D::v_EvaluateBoundaryConditions(), Nektar::SolverUtils::DriverArpack::v_Execute(), Nektar::SpatialDomains::Geometry2D::v_FindDistance(), Nektar::SolverUtils::MMFSystem::v_GenerateSummary(), Nektar::MultiRegions::ExpList3DHomogeneous1D::v_GetCoords(), Nektar::MultiRegions::ExpList3DHomogeneous2D::v_GetCoords(), Nektar::MultiRegions::ExpList2DHomogeneous1D::v_GetCoords(), Nektar::MultiRegions::ExpList2DHomogeneous2D::v_GetCoords(), Nektar::LibUtilities::NodalPrismElec::v_GetI(), Nektar::LibUtilities::NodalPrismEvenlySpaced::v_GetI(), Nektar::LibUtilities::NodalTetElec::v_GetI(), Nektar::LibUtilities::NodalTetEvenlySpaced::v_GetI(), Nektar::SpatialDomains::Geometry2D::v_GetLocCoords(), Nektar::SolverUtils::FilterLagrangianPoints::v_Initialise(), Nektar::FilterElectrogram::v_Initialise(), DummyEquationSystem::v_InitObject(), Nektar::StdRegions::StdSegExp::v_Integral(), Nektar::StdRegions::StdPointExp::v_IProductWRTBase(), Nektar::MMFSWE::v_LinfError(), Nektar::FieldUtils::OutputTecplot::v_OutputFromExp(), Nektar::FieldUtils::ProcessFieldFromString::v_Process(), Nektar::MultiRegions::ExpList2DHomogeneous1D::v_WriteVtkPieceHeader(), Nektar::MultiRegions::ExpList3DHomogeneous1D::v_WriteVtkPieceHeader(), Vmath::SIMD::Vadd(), Vmath::Vadd(), Vmath::Vdiv(), Vmath::SIMD::Vmul(), Vmath::Vmul(), Vmath::Vstvpp(), Vmath::Vsub(), Vmath::SIMD::Vvtvm(), Vmath::Vvtvm(), Vmath::SIMD::Vvtvp(), Vmath::Vvtvp(), Vmath::SIMD::Vvtvvtm(), Vmath::Vvtvvtm(), Vmath::SIMD::Vvtvvtp(), Vmath::Vvtvvtp(), Nektar::NonlinearPeregrine::WallBoundaryContVariables(), Nektar::SpatialDomains::Movement::WriteMovement(), Polylib::zwgj(), Polylib::zwgk(), Polylib::zwglj(), Polylib::zwgrjm(), Polylib::zwgrjp(), Polylib::zwlk(), and Polylib::zwrk().