#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.
|
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
} |
|
|
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) |
|
◆ basis_type
◆ pce_type
◆ Quadrature_Method
◆ Reduced_Basis_Method
◆ Orthogonalization_Method
◆ Quadrature_Reduction_Method
◆ Solver_Method
Enumerator |
---|
TRSM | |
GLPK | |
CLP | |
CLP_IP | |
QPOASES | |
BASIS_PURSUIT | |
ORTHOGONAL_MATCHING_PURSUIT | |
Definition at line 87 of file gram_schmidt_example3.cpp.
◆ f()
template<class ScalarType >
ScalarType f |
( |
const Teuchos::Array< ScalarType > & |
x, |
|
|
double |
a, |
|
|
double |
b |
|
) |
| |
|
inline |
◆ g()
template<class ScalarType >
ScalarType g |
( |
const Teuchos::Array< ScalarType > & |
x, |
|
|
const ScalarType & |
y |
|
) |
| |
|
inline |
◆ coeff_error()
◆ disc_orthog_error()
◆ compute_pces()
void compute_pces |
( |
bool |
compute_z_red, |
|
|
int |
p, |
|
|
const MyOptions & |
options, |
|
|
MyResults & |
results |
|
) |
| |
◆ main()
int main |
( |
int |
argc, |
|
|
char ** |
argv |
|
) |
| |
◆ num_quadrature_method
const int num_quadrature_method = 2 |
|
static |
◆ quadrature_method_values
◆ quadrature_method_names
const char* quadrature_method_names[] |
|
static |
◆ num_reduced_basis_method
const int num_reduced_basis_method = 5 |
|
static |
◆ reduced_basis_method_values
◆ reduced_basis_method_names
const char* reduced_basis_method_names[] |
|
static |
Initial value:= {
"Lanczos", "Monomial-Proj-GS", "Monomial-Proj-GS2", "Monomial-GS", "Lanczos-GS" }
Definition at line 67 of file gram_schmidt_example3.cpp.
◆ num_orthogonalization_method
const int num_orthogonalization_method = 8 |
|
static |
◆ orthogonalization_method_values
◆ orthogonalization_method_names
const char* orthogonalization_method_names[] |
|
static |
Initial value:= {
"Householder", "Householder without Pivoting", "Classical Gram-Schmidt", "Modified Gram-Schmidt", "Modified Gram-Schmidt with Reorthogonalization", "Modified Gram-Schmidt without Pivoting", "Modified Gram-Schmidt without Pivoting with Reorthogonalization", "SVD" }
Definition at line 75 of file gram_schmidt_example3.cpp.
◆ num_quad_reduction_method
const int num_quad_reduction_method = 4 |
|
static |
◆ quad_reduction_method_values
◆ quad_reduction_method_names
const char* quad_reduction_method_names[] |
|
static |
◆ num_solver_method
const int num_solver_method = 7 |
|
static |
◆ solver_method_values
◆ solver_method_names
const char* solver_method_names[] |
|
static |
Initial value:= {
"TRSM", "GLPK", "Clp", "Clp-IP", "qpOASES", "Basis Pursuit", "Orthogonal Matching Pursuit" }
Definition at line 91 of file gram_schmidt_example3.cpp.