10 #ifndef AMESOS2_TACHO_DEF_HPP
11 #define AMESOS2_TACHO_DEF_HPP
13 #include <Teuchos_Tuple.hpp>
14 #include <Teuchos_ParameterList.hpp>
15 #include <Teuchos_StandardParameterEntryValidators.hpp>
18 #include "Amesos2_Tacho_decl.hpp"
23 template <
class Matrix,
class Vector>
25 Teuchos::RCP<const Matrix> A,
26 Teuchos::RCP<Vector> X,
27 Teuchos::RCP<const Vector> B )
33 data_.verbose =
false;
37 template <
class Matrix,
class Vector>
41 data_.solver.release();
45 template <
class Matrix,
class Vector>
49 std::ostringstream oss;
50 oss <<
"Tacho solver interface";
54 template<
class Matrix,
class Vector>
61 template <
class Matrix,
class Vector>
65 #ifdef HAVE_AMESOS2_TIMERS
66 Teuchos::TimeMonitor symFactTime( this->timers_.symFactTime_ );
71 if(do_optimization()) {
72 this->matrixA_->returnRowPtr_kokkos_view(host_row_ptr_view_);
73 this->matrixA_->returnColInd_kokkos_view(host_cols_view_);
76 data_.solver.setSolutionMethod(data_.method);
77 data_.solver.setLevelSetOptionAlgorithmVariant(data_.variant);
78 data_.solver.setSmallProblemThresholdsize(data_.small_problem_threshold_size);
79 data_.solver.setVerbose(data_.verbose);
80 data_.solver.setLevelSetOptionNumStreams(data_.streams);
85 data_.solver.analyze(this->globalNumCols_, host_row_ptr_view_, host_cols_view_);
86 data_.solver.initialize();
92 template <
class Matrix,
class Vector>
96 #ifdef HAVE_AMESOS2_TIMERS
97 Teuchos::TimeMonitor numFactTimer(this->timers_.numFactTime_);
102 if(do_optimization()) {
103 this->matrixA_->returnValues_kokkos_view(device_nzvals_view_);
105 data_.solver.factorize(device_nzvals_view_);
110 template <
class Matrix,
class Vector>
117 const global_size_type ld_rhs = this->root_ ? X->getGlobalLength() : 0;
118 const size_t nrhs = X->getGlobalNumVectors();
127 #ifdef HAVE_AMESOS2_TIMERS
128 Teuchos::TimeMonitor mvConvTimer(this->timers_.vecConvTime_);
129 Teuchos::TimeMonitor redistTimer(this->timers_.vecRedistTime_);
131 const bool initialize_data =
true;
132 const bool do_not_initialize_data =
false;
133 Util::get_1d_copy_helper_kokkos_view<MultiVecAdapter<Vector>,
134 device_solve_array_t>::do_get(initialize_data, B, this->bValues_,
136 ROOTED, this->rowIndexBase_);
137 bDidAssignX = Util::get_1d_copy_helper_kokkos_view<MultiVecAdapter<Vector>,
138 device_solve_array_t>::do_get(do_not_initialize_data, X, this->xValues_,
140 ROOTED, this->rowIndexBase_);
146 #ifdef HAVE_AMESOS2_TIMER
147 Teuchos::TimeMonitor solveTimer(this->timers_.solveTime_);
150 if (workspace_.extent(0) < this->globalNumRows_ || workspace_.extent(1) < nrhs) {
151 workspace_ = device_solve_array_t(
152 Kokkos::ViewAllocateWithoutInitializing(
"t"), this->globalNumRows_, nrhs);
155 data_.solver.solve(xValues_, bValues_, workspace_);
164 Teuchos::broadcast(*(this->getComm()), 0, &ierr);
166 TEUCHOS_TEST_FOR_EXCEPTION( ierr != 0, std::runtime_error,
167 "tacho_solve has error code: " << ierr );
174 #ifdef HAVE_AMESOS2_TIMERS
175 Teuchos::TimeMonitor redistTimer(this->timers_.vecRedistTime_);
180 Util::template put_1d_data_helper_kokkos_view<
183 ROOTED, this->rowIndexBase_);
190 template <
class Matrix,
class Vector>
195 return( this->matrixA_->getGlobalNumRows() == this->matrixA_->getGlobalNumCols() );
199 template <
class Matrix,
class Vector>
203 RCP<const Teuchos::ParameterList> valid_params = getValidParameters_impl();
208 auto method_name = parameterList->get<std::string> (
"method",
"chol");
209 if (method_name ==
"chol")
211 else if (method_name ==
"ldl")
213 else if (method_name ==
"lu")
216 std::cout <<
"Error: not supported solution method\n";
219 data_.variant = parameterList->get<
int> (
"variant", 2);
221 data_.small_problem_threshold_size = parameterList->get<
int> (
"small problem threshold size", 1024);
223 data_.verbose = parameterList->get<
bool> (
"verbose",
false);
225 data_.streams = parameterList->get<
int> (
"num-streams", 1);
232 template <
class Matrix,
class Vector>
233 Teuchos::RCP<const Teuchos::ParameterList>
236 static Teuchos::RCP<const Teuchos::ParameterList> valid_params;
238 if( is_null(valid_params) ){
239 Teuchos::RCP<Teuchos::ParameterList> pl = Teuchos::parameterList();
241 pl->set(
"method",
"chol",
"Type of factorization, chol, ldl, or lu");
242 pl->set(
"variant", 2,
"Type of solver variant, 0, 1, or 2");
243 pl->set(
"small problem threshold size", 1024,
"Problem size threshold below with Tacho uses LAPACK.");
244 pl->set(
"verbose",
false,
"Verbosity");
245 pl->set(
"num-streams", 1,
"Number of GPU streams");
257 template <
class Matrix,
class Vector>
260 return (this->root_ && (this->matrixA_->getComm()->getSize() == 1));
263 template <
class Matrix,
class Vector>
268 if(current_phase == SOLVE) {
272 if(!do_optimization()) {
273 #ifdef HAVE_AMESOS2_TIMERS
274 Teuchos::TimeMonitor convTimer(this->timers_.mtxConvTime_);
284 device_nzvals_view_ = device_value_type_array(
285 Kokkos::ViewAllocateWithoutInitializing(
"nzvals"), this->globalNumNonZeros_);
286 host_cols_view_ = host_ordinal_type_array(
287 Kokkos::ViewAllocateWithoutInitializing(
"colind"), this->globalNumNonZeros_);
288 host_row_ptr_view_ = host_size_type_array(
289 Kokkos::ViewAllocateWithoutInitializing(
"rowptr"), this->globalNumRows_ + 1);
292 typename host_size_type_array::value_type nnz_ret = 0;
294 #ifdef HAVE_AMESOS2_TIMERS
295 Teuchos::TimeMonitor mtxRedistTimer( this->timers_.mtxRedistTime_ );
298 TEUCHOS_TEST_FOR_EXCEPTION( this->rowIndexBase_ != this->columnIndexBase_,
300 "Row and column maps have different indexbase ");
303 device_value_type_array, host_ordinal_type_array, host_size_type_array>::do_get(
304 this->matrixA_.ptr(),
310 this->columnIndexBase_);
318 template<
class Matrix,
class Vector>
324 #endif // AMESOS2_TACHO_DEF_HPP
Amesos2::SolverCore: A templated interface for interaction with third-party direct sparse solvers...
Definition: Amesos2_SolverCore_decl.hpp:71
EPhase
Used to indicate a phase in the direct solution.
Definition: Amesos2_TypeDecl.hpp:31
Amesos2 interface to the Tacho package.
Definition: Amesos2_Tacho_decl.hpp:33
int symbolicFactorization_impl()
Perform symbolic factorization of the matrix using Tacho.
Definition: Amesos2_Tacho_def.hpp:63
Utility functions for Amesos2.
bool matrixShapeOK_impl() const
Determines whether the shape of the matrix is OK for this solver.
Definition: Amesos2_Tacho_def.hpp:192
int numericFactorization_impl()
Tacho specific numeric factorization.
Definition: Amesos2_Tacho_def.hpp:94
int preOrdering_impl()
Performs pre-ordering on the matrix to increase efficiency.
Definition: Amesos2_Tacho_def.hpp:56
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters_impl() const
Definition: Amesos2_Tacho_def.hpp:234
Similar to get_ccs_helper , but used to get a CRS representation of the given matrix.
Definition: Amesos2_Util.hpp:625
std::string description() const override
Returns a short description of this Solver.
Definition: Amesos2_Tacho_def.hpp:47
int solve_impl(const Teuchos::Ptr< MultiVecAdapter< Vector > > X, const Teuchos::Ptr< const MultiVecAdapter< Vector > > B) const
Tacho specific solve.
Definition: Amesos2_Tacho_def.hpp:112
TachoSolver(Teuchos::RCP< const Matrix > A, Teuchos::RCP< Vector > X, Teuchos::RCP< const Vector > B)
Initialize from Teuchos::RCP.
Definition: Amesos2_Tacho_def.hpp:24
bool loadA_impl(EPhase current_phase)
Reads matrix data into internal structures.
Definition: Amesos2_Tacho_def.hpp:265
bool do_optimization() const
can we optimize size_type and ordinal_type for straight pass through
Definition: Amesos2_Tacho_def.hpp:259
A templated MultiVector class adapter for Amesos2.
Definition: Amesos2_MultiVecAdapter_decl.hpp:142
~TachoSolver()
Destructor.
Definition: Amesos2_Tacho_def.hpp:38