FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fei_macros.hpp>
#include <cmath>
#include <fei_mpi.h>
#include <test_utils/fei_test_utils.hpp>
#include <test_utils/LibraryFactory.hpp>
#include <test_utils/test_Matrix.hpp>
#include <test_utils/test_VectorSpace.hpp>
#include <test_utils/test_MatrixGraph.hpp>
#include <fei_MatrixGraph_Impl2.hpp>
#include <fei_Factory.hpp>
#include <fei_defs.h>
#include <snl_fei_Factory.hpp>
#include <fei_Vector_Impl.hpp>
#include <fei_Matrix_Impl.hpp>
#include <fei_Factory_Trilinos.hpp>
#include <fei_ErrMacros.hpp>
Go to the source code of this file.
Macros | |
#define | fei_file "test_Matrix.cpp" |
Functions | |
int | test_matrix_unit1 () |
void | test_Matrix_unit2 (MPI_Comm comm, int numProcs, int localProc) |
void | test_Matrix_unit4 (MPI_Comm comm, int numProcs, int localProc) |
#define fei_file "test_Matrix.cpp" |
Definition at line 34 of file test_Matrix.cpp.
int test_matrix_unit1 | ( | ) |
Definition at line 37 of file test_Matrix.cpp.
References fei::Matrix_core::copyTransposeToWorkArrays(), and ERReturn.
void test_Matrix_unit2 | ( | MPI_Comm | comm, |
int | numProcs, | ||
int | localProc | ||
) |
Definition at line 70 of file test_Matrix.cpp.
References fei_test_utils::copy_feiMatrix_to_FillableMat(), fei::create_fei_Factory(), fei::Matrix::Factory::createMatrix(), fei::VectorSpace::defineFields(), fei::VectorSpace::defineIDTypes(), fei::MatrixGraph::definePattern(), FEI_COUT, FEI_ENDL, FEI_OSTRINGSTREAM, fei::Pattern::getNumIndices(), fei::MatrixGraph::getPattern(), fei::Matrix::globalAssemble(), fei::MatrixGraph::initComplete(), fei::MatrixGraph::initConnectivity(), fei::MatrixGraph::initConnectivityBlock(), fei::Matrix::sumIn(), fei_test_utils::writeMatrix(), and fei::Matrix::writeToFile().
void test_Matrix_unit4 | ( | MPI_Comm | comm, |
int | numProcs, | ||
int | localProc | ||
) |
Definition at line 168 of file test_Matrix.cpp.
References fei::ParameterSet::add(), fei::create_fei_Factory(), fei::Matrix::Factory::createMatrix(), fei::VectorSpace::defineFields(), fei::VectorSpace::defineIDTypes(), fei::MatrixGraph::definePattern(), FEI_BLOCK_DIAGONAL_ROW, FEI_COUT, FEI_ENDL, FEI_OSTRINGSTREAM, fei::Pattern::getNumIndices(), fei::MatrixGraph::getPattern(), fei::Matrix::globalAssemble(), fei::MatrixGraph::initComplete(), fei::MatrixGraph::initConnectivity(), fei::MatrixGraph::initConnectivityBlock(), fei::Factory::parameters(), fei::Matrix::sumIn(), and fei::Matrix::writeToFile().