Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <iostream>
#include <iomanip>
#include "Stokhos.hpp"
#include "Stokhos_Sacado.hpp"
#include "Stokhos_ReducedBasisFactory.hpp"
#include "Teuchos_CommandLineProcessor.hpp"
#include "Teuchos_TabularOutputter.hpp"
Go to the source code of this file.
Classes | |
struct | MyOptions |
class | MyResults |
Typedefs | |
typedef Stokhos::LegendreBasis < int, double > | basis_type |
typedef Sacado::ETPCE::OrthogPoly < double, Stokhos::StandardStorage< int, double > > | pce_type |
Enumerations | |
enum | Quadrature_Method { TENSOR, SPARSE } |
enum | Reduced_Basis_Method { LANCZOS, MONOMIAL_PROJ_GS, MONOMIAL_PROJ_GS2, MONOMIAL_GS, LANCZOS_GS } |
enum | Orthogonalization_Method { HOUSEHOLDER, HOUSEHOLDER_NP, CGS, MGS, MGSRO, MGSNP, MGSNPRO, SVD } |
enum | Quadrature_Reduction_Method { NONE, QSQUARED, QSQUARED2, Q2 } |
enum | Solver_Method { TRSM, GLPK, CLP, CLP_IP, QPOASES, BASIS_PURSUIT, ORTHOGONAL_MATCHING_PURSUIT } |
Functions | |
template<class ScalarType > | |
ScalarType | f (const Teuchos::Array< ScalarType > &x, double a, double b) |
template<class ScalarType > | |
ScalarType | g (const Teuchos::Array< ScalarType > &x, const ScalarType &y) |
double | coeff_error (const pce_type &z, const pce_type &z2) |
double | disc_orthog_error (const Stokhos::OrthogPolyBasis< int, double > &basis, const Stokhos::Quadrature< int, double > &quad) |
void | compute_pces (bool compute_z_red, int p, const MyOptions &options, MyResults &results) |
int | main (int argc, char **argv) |
Variables | |
static const int | num_quadrature_method = 2 |
static const Quadrature_Method | quadrature_method_values [] |
static const char * | quadrature_method_names [] |
static const int | num_reduced_basis_method = 5 |
static const Reduced_Basis_Method | reduced_basis_method_values [] |
static const char * | reduced_basis_method_names [] |
static const int | num_orthogonalization_method = 8 |
static const Orthogonalization_Method | orthogonalization_method_values [] |
static const char * | orthogonalization_method_names [] |
static const int | num_quad_reduction_method = 4 |
static const Quadrature_Reduction_Method | quad_reduction_method_values [] |
static const char * | quad_reduction_method_names [] |
static const int | num_solver_method = 7 |
static const Solver_Method | solver_method_values [] |
static const char * | solver_method_names [] |
typedef Stokhos::LegendreBasis<int,double> basis_type |
Definition at line 94 of file gram_schmidt_example3.cpp.
Definition at line 95 of file gram_schmidt_example3.cpp.
enum Quadrature_Method |
Enumerator | |
---|---|
TENSOR | |
SPARSE |
Definition at line 55 of file gram_schmidt_example3.cpp.
enum Reduced_Basis_Method |
Enumerator | |
---|---|
LANCZOS | |
MONOMIAL_PROJ_GS | |
MONOMIAL_PROJ_GS2 | |
MONOMIAL_GS | |
LANCZOS_GS |
Definition at line 63 of file gram_schmidt_example3.cpp.
Enumerator | |
---|---|
HOUSEHOLDER | |
HOUSEHOLDER_NP | |
CGS | |
MGS | |
MGSRO | |
MGSNP | |
MGSNPRO | |
SVD |
Definition at line 71 of file gram_schmidt_example3.cpp.
Enumerator | |
---|---|
NONE | |
QSQUARED | |
QSQUARED2 | |
Q2 |
Definition at line 79 of file gram_schmidt_example3.cpp.
enum Solver_Method |
Enumerator | |
---|---|
TRSM | |
GLPK | |
CLP | |
CLP_IP | |
QPOASES | |
BASIS_PURSUIT | |
ORTHOGONAL_MATCHING_PURSUIT |
Definition at line 87 of file gram_schmidt_example3.cpp.
|
inline |
Definition at line 98 of file gram_schmidt_example3.cpp.
|
inline |
Definition at line 109 of file gram_schmidt_example3.cpp.
Definition at line 121 of file gram_schmidt_example3.cpp.
double disc_orthog_error | ( | const Stokhos::OrthogPolyBasis< int, double > & | basis, |
const Stokhos::Quadrature< int, double > & | quad | ||
) |
Definition at line 131 of file gram_schmidt_example3.cpp.
Definition at line 205 of file gram_schmidt_example3.cpp.
Definition at line 358 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 56 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 57 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 59 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 64 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 65 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 67 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 72 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 73 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 75 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 80 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 81 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 83 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 88 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 89 of file gram_schmidt_example3.cpp.
|
static |
Definition at line 91 of file gram_schmidt_example3.cpp.