#include "Stokhos_Epetra.hpp"
#include "Stokhos_Sacado.hpp"
#include "Stokhos_Ifpack2.hpp"
#include "twoD_diffusion_problem_tpetra.hpp"
#include "Epetra_SerialComm.h"
#include "Ifpack2_Factory.hpp"
#include "BelosLinearProblem.hpp"
#include "kokkos_pce_specializations.hpp"
#include "BelosPseudoBlockCGSolMgr.hpp"
#include "BelosPseudoBlockGmresSolMgr.hpp"
#include "MatrixMarket_Tpetra.hpp"
#include "BelosBlockGmresSolMgr.hpp"
#include "Teuchos_TimeMonitor.hpp"
#include "Teuchos_CommandLineProcessor.hpp"
#include "linear2d_diffusion_scalar_types.hpp"
#include "Stokhos_MueLu.hpp"
#include "Stokhos_MueLu_QR_Interface_decl.hpp"
#include "Stokhos_MueLu_QR_Interface_def.hpp"
#include "MueLu_SmootherFactory.hpp"
#include "MueLu_TrilinosSmoother.hpp"
#include <BelosXpetraAdapter.hpp>
#include <BelosMueLuAdapter.hpp>
#include "Xpetra_MultiVectorFactory.hpp"
#include "Xpetra_Matrix.hpp"
#include "Xpetra_Map.hpp"
#include "MueLu_Level.hpp"
#include "MueLu_CoupledAggregationFactory.hpp"
#include "MueLu_SaPFactory.hpp"
Go to the source code of this file.
|
enum | SG_RF { UNIFORM
, LOGNORMAL
} |
|
enum | Krylov_Method { GMRES
, CG
} |
|
enum | Multigrid_Smoother { CHEBYSHEV
, SGS
} |
|
enum | SG_Prec { NONE
, MEAN
, STOCHASTIC
} |
|
enum | SG_Div {
DIRECT
, SPD_DIRECT
, MEAN_DIV
, QUAD
,
CGD
} |
|
enum | SG_DivPrec {
NO
, DIAG
, JACOBI
, GS
,
SCHUR
} |
|
enum | Schur_option { full
, diag
} |
|
enum | Prec_option { whole
, linear
} |
|
|
template<typename ordinal_type , typename value_type , typename Storage > |
void | returnScalarAsDenseMatrix (Sacado::PCE::OrthogPoly< value_type, Storage > const &inval, Teuchos::RCP< Teuchos::SerialDenseMatrix< ordinal_type, value_type > > &denseEntry, Teuchos::RCP< Stokhos::Sparse3Tensor< ordinal_type, value_type > > const &Cijk) |
|
template<typename ordinal_type , typename value_type > |
void | PrintMatrix (Teuchos::FancyOStream &fos, Teuchos::RCP< Xpetra_Matrix > const &A, Teuchos::RCP< Stokhos::Sparse3Tensor< ordinal_type, value_type > > const &Cijk, Teuchos::RCP< const Stokhos::OrthogPolyBasis< ordinal_type, value_type > > const &basis) |
|
int | main (int argc, char *argv[]) |
|
|
const int | num_sg_rf = 2 |
|
const SG_RF | sg_rf_values [] = { UNIFORM, LOGNORMAL } |
|
const char * | sg_rf_names [] = { "Uniform", "Log-Normal" } |
|
const int | num_krylov_method = 2 |
|
const Krylov_Method | krylov_method_values [] = { GMRES, CG } |
|
const char * | krylov_method_names [] = { "GMRES", "CG" } |
|
const int | num_multigrid_smoother = 2 |
|
const Multigrid_Smoother | multigrid_smoother_values [] = { CHEBYSHEV, SGS } |
|
const char * | multigrid_smoother_names [] = { "Chebyshev", "SGS" } |
|
const int | num_sg_prec = 3 |
|
const SG_Prec | sg_prec_values [] = { NONE, MEAN, STOCHASTIC } |
|
const char * | sg_prec_names [] |
|
const int | num_sg_div = 5 |
|
const SG_Div | sg_div_values [] = { DIRECT, SPD_DIRECT, MEAN_DIV, QUAD, CGD } |
|
const char * | sg_div_names [] |
|
const int | num_sg_divprec = 5 |
|
const SG_DivPrec | sg_divprec_values [] = {NO, DIAG, JACOBI, GS, SCHUR} |
|
const char * | sg_divprec_names [] |
|
const int | num_schur_option = 2 |
|
const Schur_option | Schur_option_values [] = { full, diag } |
|
const char * | schur_option_names [] = { "full", "diag"} |
|
const int | num_prec_option = 2 |
|
const Prec_option | Prec_option_values [] = { whole, linear } |
|
const char * | prec_option_names [] = { "full", "linear"} |
|
◆ Node
typedef KokkosClassic::DefaultNode::DefaultNodeType Node |
◆ Xpetra_Matrix
◆ Xpetra_Map
◆ SG_RF
◆ Krylov_Method
◆ Multigrid_Smoother
◆ SG_Prec
◆ SG_Div
◆ SG_DivPrec
◆ Schur_option
◆ Prec_option
◆ returnScalarAsDenseMatrix()
template<typename ordinal_type , typename value_type , typename
Storage >
void returnScalarAsDenseMatrix |
( |
Sacado::PCE::OrthogPoly< value_type, Storage > const & | inval, |
|
|
Teuchos::RCP< Teuchos::SerialDenseMatrix< ordinal_type, value_type > > & | denseEntry, |
|
|
Teuchos::RCP< Stokhos::Sparse3Tensor< ordinal_type, value_type > > const & | Cijk ) |
◆ PrintMatrix()
template<typename ordinal_type , typename value_type >
◆ main()
int main |
( |
int | argc, |
|
|
char * | argv[] ) |
◆ num_sg_rf
◆ sg_rf_values
◆ sg_rf_names
const char* sg_rf_names[] = { "Uniform", "Log-Normal" } |
◆ num_krylov_method
const int num_krylov_method = 2 |
◆ krylov_method_values
◆ krylov_method_names
const char* krylov_method_names[] = { "GMRES", "CG" } |
◆ num_multigrid_smoother
const int num_multigrid_smoother = 2 |
◆ multigrid_smoother_values
◆ multigrid_smoother_names
const char* multigrid_smoother_names[] = { "Chebyshev", "SGS" } |
◆ num_sg_prec
const int num_sg_prec = 3 |
◆ sg_prec_values
◆ sg_prec_names
const char* sg_prec_names[] |
◆ num_sg_div
◆ sg_div_values
◆ sg_div_names
const char* sg_div_names[] |
◆ num_sg_divprec
const int num_sg_divprec = 5 |
◆ sg_divprec_values
◆ sg_divprec_names
const char* sg_divprec_names[] |
◆ num_schur_option
const int num_schur_option = 2 |
◆ Schur_option_values
◆ schur_option_names
const char* schur_option_names[] = { "full", "diag"} |
◆ num_prec_option
const int num_prec_option = 2 |
◆ Prec_option_values
◆ prec_option_names
const char* prec_option_names[] = { "full", "linear"} |