|
CppNoddy
0.92
|
| ► include | |
| ArcLength_base.h | A base class for arclength-capable solvers |
| BandedLinearSystem.h | Specification of the linear system class |
| BandedMatrix.h | A matrix class that constructs a BANDED matrix |
| BVP_bundle.h | A shorter bundled include file for ODE_BVP and PDE_IBVP codes |
| cfortran.h | |
| CppNoddy.h | |
| DenseLinearEigenSystem.h | Specification of the dense linear eigensystem class |
| DenseLinearSystem.h | Specification of the linear system class |
| DenseMatrix.h | A matrix class that constructs a DENSE matrix as an STL Vector of DenseVectors |
| DenseVector.h | Specification for a templated DenseVector class – a dense, dynamic, vector object |
| DistributedLinearSystem.h | Specification of a sparse-storage distributed linear system class |
| DistributedMatrix.h | A matrix class that constructs a SPARSE/DISTRIBUTED matrix using PETSc |
| DistributedVector.h | A class that constructs a SPARSE/DISTRIBUTED vector using PETSc |
| Equation.h | A templated class for equations that can be inherited from to allow instantiation of ODE/PDE objects using the resulting class |
| Equation_1matrix.h | A templated class for equations that can be inherited from to allow instantiation of PDE_IBVP objects (amongst others) |
| Equation_2matrix.h | A templated class for equations that can be inherited from to allow instantiation of PDE_double_IBVP objects (amongst others) |
| Equation_3matrix.h | A templated class for equations that can be inherited from to allow instantiation of PDE_double_IBVP objects (amongst others) |
| EVP_bundle.h | A shorter bundled include file for ODE_EVP and general eigenvalue problems |
| Exceptions.h | The collection of CppNoddy exceptions |
| FnQuadrature.h | A specification for quadrature classes |
| FortranBLAS.h | Some interface definitions for calling external fortran routines from BLAS |
| FortranData.h | |
| FortranLAPACK.h | Some interface definitions for calling external fortran routines in LAPACK |
| FT.h | A spec for a collection of Fourier methods that act on Noddy containers |
| Functors.h | Some Function Objects that CppNoddy makes use of in algorithms applied to STL containers |
| Generic_bundle.h | A shorter bundled include file for ODE_BVP and PDE_IBVP codes |
| HST.h | Some classes useful for hydrodynamic stability theory problems |
| IBVP_bundle.h | A shorter bundled include file for initial boundary value problems |
| IBVP_double_bundle.h | A shorter bundled include file for double initial boundary value problems |
| IVP_bundle.h | A shorter bundled include file for initial-value problems |
| LinearEigenSystem_base.h | Specification of the linear eigensystem base class |
| Newton.h | A vector NEWTON iteration class |
| Newton_bundle.h | A shorter bundled include file for Newton iteration problems |
| ODE_BVP.h | A specification of a class for an |
| ODE_EVP.h | A specification of a class for an |
| ODE_IVP.h | A specification for a class to solve initial value problems of the form |
| OneD_HYP_bundle.h | A shorter bundled include file for hyperbolic problems |
| OneD_Hyperbolic_System.h | |
| OneD_Node_Mesh.h | A specification for a one dimensional mesh object |
| OneD_TVDLF_Elt.h | Specification of a one dimensional linear element for use in a TVD Lax-Friedrichs scheme |
| OneD_TVDLF_Mesh.h | Specification of an object that represents a one dimensional mesh for TVD LX methods |
| PDE_double_IBVP.h | A specification of a class for an |
| PDE_IBVP.h | A specification of a class for an |
| PetscSession.h | |
| Residual.h | A specification of a (double/complex) VECTOR residual class |
| Residual_with_coords.h | A specification of a (double/complex) residual class that not only defines a vector residual of a vector of state variables but may also depend upon N additional (double) variables |
| reversed_BL.h | An implementation of the zig-zag modification for unsteady parabolic marching with reverse flow |
| Sequential_Matrix_base.h | A base matrix class to ensure a consistent interface between the inheriting dense/banded matrix classes |
| SlepcSession.h | |
| SparseLinearEigenSystem.h | Specification of the sparse linear eigensystem class |
| SparseLinearSystem.h | Specification of a sparse-storage linear system class |
| SparseMatrix.h | A matrix class that constructs a SPARSE matrix as an STL Vector of SparseVectors, inheriting from Matrix_base |
| SparseVector.h | A templated SparseVector class – a sparse, variable size, vector object |
| Timer.h | A spec for the CppNoddy Timer object |
| TrackerFile.h | A class that can be passed pointers to scalar/vector/mesh objects, then their contents are written to a file each time that the update method is called |
| TwoD_HYP_bundle.h | A shorter bundled include file for hyperbolic problems |
| TwoD_Hyperbolic_System.h | |
| TwoD_Mapped_Node_Mesh.h | A specification for a two dimensional mapped mesh object |
| TwoD_Node_Mesh.h | A specification for a two dimensional mesh object |
| TwoD_TVDLF_Elt.h | Specification of a two dimensional linear element for use in a TVD Lax-Friedrichs scheme |
| TwoD_TVDLF_Mesh.h | Specification of an object that represents a two dimensional mesh for TVD LF methods |
| Types.h | Some standard typedefs |
| Uncopyable.h | |
| Utility.h | A spec for a collection of utility functions |
| ► src | |
| ArcLength_base.cpp | An implementation of the arclength class |
| BandedLinearSystem.cpp | Implementation for the LinearSystem class |
| BandedMatrix.cpp | Implementation of the matrix class that constructs a BANDED matrix as a DenseVector |
| DenseLinearEigenSystem.cpp | Implementation for the DenseLinearEigenSystem class This class links to LAPACK to perform the solver phase |
| DenseLinearSystem.cpp | Implementation for the LinearSystem class |
| DenseMatrix.cpp | Implementation of a DENSE matrix as an Vector of DenseVector |
| DenseVector.cpp | Implementation of the DenseVector class – a dense, variable size, vector object |
| Equation.cpp | Implementation for an equations class that can be inherited from to allow instantiation of ODE objects using the resulting class |
| Equation_1matrix.cpp | Implementation for an equations class that can be inherited from to allow instantiation of ODE objects using the resulting class |
| Equation_2matrix.cpp | Implementation for an equations class that can be inherited from to allow instantiation of ODE objects using the resulting class |
| Equation_3matrix.cpp | Implementation for an equations class that can be inherited from to allow instantiation of ODE objects using the resulting class |
| FnQuadrature.cpp | Implementation of the real quadrature class |
| FT.cpp | An implementation for a collection of Fourier methods |
| LinearEigenSystem_base.cpp | Implementation for the LinearEigenSystem_base class |
| Newton.cpp | Implementation of the vector NEWTON iteration class |
| ODE_BVP.cpp | An implementation of a class for an |
| ODE_EVP.cpp | A specification of a class for an |
| ODE_IVP.cpp | Implementation of an |
| OneD_Node_Mesh.cpp | Implementation of the one dimensional (non-)uniformly distributed mesh object |
| OneD_TVDLF_Elt.cpp | Implementation of a one dimensional linear element for use in a TVD Lax-Friedrichs scheme |
| OneD_TVDLF_Mesh.cpp | Implementation of an object that represents a one dimensional mesh for TVD LF methods |
| PDE_double_IBVP.cpp | |
| PDE_IBVP.cpp | Implementation of a class for an |
| Residual.cpp | Implementation of the (double/complex) VECTOR residual class |
| Residual_with_coords.cpp | A specification of a (double/complex) residual class that not only defines a vector residual of a vector of state variables but may also depend upon N additional (double) variables |
| reversed_BL.cpp | |
| SparseLinearEigenSystem.cpp | Implementation for the SparseLinearEigenSystem class This class links to SLEPc to perform the solver phase |
| SparseLinearSystem.cpp | Implementation for the LinearSystem class |
| SparseMatrix.cpp | Implementation of a SPARSE matrix as an STL Vector of SparseVectors, inheriting from Matrix_base |
| SparseVector.cpp | Implementation of the SparseVector class – a sparse, variable size, vector object |
| Timer.cpp | Implementation of the CppNoddy Timer object |
| TrackerFile.cpp | Implementation details for the TrackerFile object |
| TwoD_Mapped_Node_Mesh.cpp | Implementation of a two dimensional (mapped) mesh object |
| TwoD_Node_Mesh.cpp | Implementation of a two dimensional mesh object |
| TwoD_TVDLF_Elt.cpp | Implementation of an object that represents a two dimensional element for TVD LF methods |
| TwoD_TVDLF_Mesh.cpp | Implementation of an object that represents a two dimensional mesh for TVD LF methods |
| Utility.cpp | An implementation for a collection of utility functions |
| ► Tests | |
| ► Arclength | |
| ArcCircle.cpp | A simple arc-length continuation solving the equation |
| ArcCircleVector.cpp | A simple arc-length continuation solving the vector equation |
| ArcShootFalknerSkan.cpp | Arc-length continue the Falkner-Skan equation |
| ArcTranscritFold.cpp | Solve the nonlinear scalar residual problem |
| ► BVP | |
| BermanShooting.cpp | Solving the fourth-order Berman (porous channel) similarity equation |
| BlasiusShooting.cpp | Solving the Blasius equation |
| BVPBerman.cpp | |
| BVPBlasius.cpp | Solving the Blasius equation |
| BVPHarmonic.cpp | |
| BVPKarman.cpp | |
| BVPKarmanAdaptive.cpp | Adaptively solve the Karman rotating-disk equations for the flow above an infinite rotating disk: |
| BVPKarmanArclength.cpp | Arc-length continuation of the Karman rotating-disk equations for the flow above an infinite rotating disk: |
| BVPKarmanJacobian.cpp | Solving the Karman rotating-disk equations for the flow above an infinite rotating disk by applying a user-provided Jacobian |
| BVPNonIdentityMatrix0.cpp | Solving the equation |
| BVPTroesch.cpp | |
| ► double_IBVP | |
| IBVPLinear.cpp | Solving the linear equation |
| IBVPNonlinearFast.cpp | Solving the nonlinear problem |
| IBVPNonlinearSlower.cpp | Solving the nonlinear problem |
| ► EVP | |
| EVP2DOrrSommerfeld_slepcz_mumps.cpp | |
| EVP2DOrrSommerfeld_slepcz_superludist.cpp | |
| EVPComplex_lapack.cpp | Solves a 4x4 complex generalised eigenvalue problem |
| EVPHarmonic_lapack.cpp | Solves the harmonic equation |
| EVPHarmonicComplex_lapack.cpp | Solves the harmonic equation |
| EVPHarmonicComplexSparse_slepcz.cpp | |
| EVPHarmonicEasy_lapack.cpp | Solves the harmonic equation |
| EVPHarmonicLocal.cpp | Solves the harmonic equation |
| EVPHarmonicSparse_slepcd.cpp | Solves the harmonic equation |
| EVPOrrSommerfeld_lapack.cpp | Solves the following linear eigenvalue problem for values |
| EVPOrrSommerfeldEasy_lapack.cpp | Solves the following linear eigenvalue problem for values |
| EVPOrrSommerfeldNeutralCurve_lapack.cpp | |
| EVPOrrSommerfeldSparse_slepcz.cpp | Solves the following linear eigenvalue problem for values |
| EVPRayleigh_lapack.cpp | Solves the Rayleigh problem for values |
| EVPShootBiharmonic.cpp | Solving a one-dimensional "Bi-harmonic" eigenvalue problem (EVP) |
| EVPSparse_slepcd.cpp | Solves a 2x2 generalised eigenvalue problem |
| EVPSparse_slepcz.cpp | Solves a 4x4 complex generalised eigenvalue problem |
| ► FT | |
| FT.cpp | A simple 1D DFT test case |
| ► Generic | |
| ExceptionChecks.cpp | We do some obviously dumb things to induce a handful of common failures |
| NewtonIter.cpp | |
| Quadrature.cpp | Compute the integral |
| TrivialComplex.cpp | A sanity test for std::complex class |
| ► HYP_1D | |
| HYPAcousticImpedance.cpp | Solve the constant coefficient linear sound wave problem |
| HYPAcousticReflection.cpp | Solve the constant coefficient linear sound wave problem |
| HYPNonlinearAdvection.cpp | Solving the 1D ‘nonlinear advection equation’ |
| HYPRadialDamBreak.cpp | Solve the shallow water equations in one dimension for an initial column of fluid |
| HYPSodsShocktube.cpp | Solving the 1D Euler problem for gas dynamics |
| ► HYP_2D | |
| HYP2DLinearAdvectionXY.cpp | Solving the 2D advection equation |
| HYP2DNonlinearAdvectionX.cpp | Solving the 1D ‘nonlinear advection equation’ |
| HYP2DNonlinearAdvectionXY.cpp | Solving the 2D ‘nonlinear advection equation’ |
| HYP2DNonlinearAdvectionY.cpp | Solving the 1D ‘nonlinear advection equation’ |
| HYP2DRadialDamBreak.cpp | |
| HYP2DShallowSource.cpp | Two dimensional shallow water equations over topography |
| ► IBVP | |
| IBVPDiffusion.cpp | Solving the heat diffusion equation |
| IBVPDiffusionNonlinear.cpp | Solving the unstead diffusion problem: |
| IBVPKarman.cpp | Solving the unsteady Karman rotating-disk equations for the flow above an infinite rotating disk in a rotating fluid: |
| IBVPNonlinearAdvDiffusion.cpp | Solving the nonlinear advection diffusion equation |
| ► IVP | |
| IVPHarmonic.cpp | Integrate the harmonic equation |
| IVPLorenz.cpp | Integrate the Lorenz equations |
| ► Matrix | |
| MatrixAccess.cpp | A quick check that the overhead associated with the matrix container class is less than 5% compared to a native array |
| MatrixBandedSolves.cpp | Example of a simple "banded" inear solver using |
| MatrixBandedSolves_lapack.cpp | |
| MatrixDistributed_petscd_mumps.cpp | |
| MatrixDistributed_petscz_mumps.cpp | |
| MatrixMultiply_lapack.cpp | |
| MatrixSolves.cpp | Example of the simple linear solvers using a simple |
| MatrixSolves_lapack.cpp | Example of the simple linear solvers implemented for dense, banded and sparse matrix objects |
| MatrixSparseSolve_petscd.cpp | |
| MatrixSparseSolve_petscd_mumps.cpp | |
| MatrixSparseSolve_petscd_superludist.cpp | |
| MatrixSparseSolve_petscz.cpp | |
| MatrixSparseSolve_petscz_mumps.cpp | |
| MatrixSparseSolve_petscz_superludist.cpp | |
| ► Meshes | |
| 1DNodeMesh.cpp | A simple check of the OneD_Node_Mesh container that stores nodal data over a given mesh |
| 1DNodeMeshAiry_lapack.cpp | Solves the Airy equation |
| 1DNodeMeshComplex.cpp | A simple check of the OneD_Node_Mesh container that stores nodal data over a given mesh |
| 2DNodeMesh.cpp | A simple check of the TwoD_Node_Mesh container that stores nodal data over a given mesh |
| ► Poisson | |
| PoissonCartesian_petscd_mumps.cpp | |
| PoissonCartesian_petscd_superludist.cpp | |
| ► Vector | |
| DenseVector.cpp | Some simple sanity checks for the NVector class with both double and complex types |
| DenseVectorOpOverloading.cpp | Just a quick and simple check that DenseVector operator overloading is functioning |
| DistributedVector_petscd.cpp | A superficial sanity check of copy and two_norm |
| DistributedVector_petscz.cpp | A superficial sanity check of copy and two_norm |
| SparseVector.cpp | |
| SpeedVector.cpp | |
| TestsOverview.h | |
| Utils_Fill.h | |
| Types.h | Some standard typedefs |
1.9.5
© 2012
R.E. Hewitt