18 #ifndef AMESOS2_MUMPS_DEF_HPP
19 #define AMESOS2_MUMPS_DEF_HPP
21 #include <Teuchos_Tuple.hpp>
22 #include <Teuchos_ParameterList.hpp>
23 #include <Teuchos_StandardParameterEntryValidators.hpp>
26 #include <Teuchos_DefaultMpiComm.hpp>
38 template <
class Matrix,
class Vector>
39 MUMPS<Matrix,Vector>::MUMPS(
40 Teuchos::RCP<const Matrix> A,
41 Teuchos::RCP<Vector> X,
42 Teuchos::RCP<const Vector> B )
43 : SolverCore<Amesos2::MUMPS,Matrix,Vector>(A, X, B)
44 , is_contiguous_(true)
47 typedef FunctionMap<MUMPS,scalar_type> function_map;
49 MUMPS_MATRIX_LOAD =
false;
51 MUMPS_MATRIX_LOAD_PREORDERING =
false;
55 using Teuchos::MpiComm;
58 using Teuchos::rcp_dynamic_cast;
61 mumps_par.comm_fortran = -987654;
62 RCP<const Comm<int> > matComm = this->
matrixA_->getComm();
64 TEUCHOS_TEST_FOR_EXCEPTION(
65 matComm.is_null(), std::logic_error,
"Amesos2::Comm");
66 RCP<const MpiComm<int> > matMpiComm =
67 rcp_dynamic_cast<
const MpiComm<int> >(matComm);
69 TEUCHOS_TEST_FOR_EXCEPTION(
70 matMpiComm->getRawMpiComm().is_null(),
71 std::logic_error,
"Amesos2::MPI");
72 MPI_Comm rawMpiComm = (* (matMpiComm->getRawMpiComm()) )();
73 mumps_par.comm_fortran = (int) MPI_Comm_c2f(rawMpiComm);
80 function_map::mumps_c(&(mumps_par));
86 mumps_par.icntl[0] = -1;
87 mumps_par.icntl[1] = -1;
88 mumps_par.icntl[2] = -1;
89 mumps_par.icntl[3] = 1;
90 mumps_par.icntl[4] = 0;
91 mumps_par.icntl[5] = 7;
92 mumps_par.icntl[6] = 7;
93 mumps_par.icntl[7] = 7;
94 mumps_par.icntl[8] = 1;
95 mumps_par.icntl[9] = 0;
96 mumps_par.icntl[10] = 0;
97 mumps_par.icntl[11] = 0;
98 mumps_par.icntl[12] = 0;
99 mumps_par.icntl[13] = 20;
100 mumps_par.icntl[17] = 0;
101 mumps_par.icntl[18] = 0;
102 mumps_par.icntl[19] = 0;
103 mumps_par.icntl[20] = 0;
104 mumps_par.icntl[21] = 0;
105 mumps_par.icntl[22] = 0;
106 mumps_par.icntl[23] = 0;
107 mumps_par.icntl[24] = 0;
108 mumps_par.icntl[25] = 0;
109 mumps_par.icntl[27] = 1;
110 mumps_par.icntl[28] = 0;
111 mumps_par.icntl[29] = 0;
112 mumps_par.icntl[30] = 0;
113 mumps_par.icntl[31] = 0;
114 mumps_par.icntl[32] = 0;
117 template <
class Matrix,
class Vector>
118 MUMPS<Matrix,Vector>::~MUMPS( )
121 typedef FunctionMap<MUMPS,scalar_type> function_map;
123 if(MUMPS_STRUCT ==
true)
130 if (this->rank_ < this->nprocs_) {
131 function_map::mumps_c(&(mumps_par));
136 template<
class Matrix,
class Vector>
142 #ifdef HAVE_AMESOS2_TIMERS
143 Teuchos::TimeMonitor preOrderTimer(this->timers_.preOrderTime_);
149 template <
class Matrix,
class Vector>
153 #ifdef HAVE_AMESOS2_TIMERS
154 Teuchos::TimeMonitor symFactTime( this->timers_.symFactTime_ );
158 if ( this->globalNumRows_ > 0 ) {
161 function_map::mumps_c(&(mumps_par));
168 template <
class Matrix,
class Vector>
172 #ifdef HAVE_AMESOS2_TIMERS
173 Teuchos::TimeMonitor numFactTimer(this->timers_.numFactTime_);
177 if ( this->globalNumRows_ > 0 ) {
179 function_map::mumps_c(&(mumps_par));
186 template <
class Matrix,
class Vector>
194 const global_size_type ld_rhs = this->root_ ? X->getGlobalLength() : 0;
195 const size_t nrhs = X->getGlobalNumVectors();
196 const size_t val_store_size = Teuchos::as<size_t>(ld_rhs * nrhs);
198 xvals_.resize(val_store_size);
199 bvals_.resize(val_store_size);
201 #ifdef HAVE_AMESOS2_TIMERS
202 Teuchos::TimeMonitor mvConvTimer(this->timers_.vecConvTime_);
203 Teuchos::TimeMonitor redistTimer( this->timers_.vecRedistTime_ );
207 mumps_type>::do_get(B, bvals_(), Teuchos::as<size_t>(ld_rhs),
208 (is_contiguous_ ==
true) ? ROOTED : CONTIGUOUS_AND_ROOTED,
209 this->rowIndexBase_);
212 if ( this->globalNumRows_ > 0 ) {
213 mumps_par.nrhs = nrhs;
214 mumps_par.lrhs = mumps_par.n;
219 mumps_par.rhs = bvals_.getRawPtr();
222 #ifdef HAVE_AMESOS2_TIMERS
223 Teuchos::TimeMonitor solveTimer(this->timers_.solveTime_);
226 function_map::mumps_c(&(mumps_par));
230 #ifdef HAVE_AMESOS2_TIMERS
231 Teuchos::TimeMonitor redistTimer2(this->timers_.vecRedistTime_);
236 (is_contiguous_ ==
true) ? ROOTED : CONTIGUOUS_AND_ROOTED);
239 MUMPS_MATRIX_LOAD_PREORDERING =
false;
244 template <
class Matrix,
class Vector>
249 return( this->globalNumRows_ == this->globalNumCols_ );
253 template <
class Matrix,
class Vector>
258 using Teuchos::getIntegralValue;
259 using Teuchos::ParameterEntryValidator;
261 RCP<const Teuchos::ParameterList> valid_params = getValidParameters_impl();
263 if(parameterList->isParameter(
"ICNTL(1)")){
264 mumps_par.icntl[0] = parameterList->get<
int>(
"ICNTL(1)", -1);
266 if(parameterList->isParameter(
"ICNTL(2)")){
267 mumps_par.icntl[1] = parameterList->get<
int>(
"ICNTL(2)", -1);
269 if(parameterList->isParameter(
"ICNTL(3)")){
270 mumps_par.icntl[2] = parameterList->get<
int>(
"ICNTL(3)", -1);
272 if(parameterList->isParameter(
"ICNTL(4)")){
273 mumps_par.icntl[3] = parameterList->get<
int>(
"ICNTL(4)", 1);
275 if(parameterList->isParameter(
"ICNTL(6)")){
276 mumps_par.icntl[5] = parameterList->get<
int>(
"ICNTL(6)", 0);
278 if(parameterList->isParameter(
"ICNTL(7)")){
279 mumps_par.icntl[6] = parameterList->get<
int>(
"ICNTL(7)", 7);
281 if(parameterList->isParameter(
"ICNTL(9)")){
282 mumps_par.icntl[8] = parameterList->get<
int>(
"ICNTL(9)", 1);
284 if(parameterList->isParameter(
"ICNTL(11)")){
285 mumps_par.icntl[10] = parameterList->get<
int>(
"ICNTL(11)", 0);
287 if(parameterList->isParameter(
"ICNTL(14)")){
288 mumps_par.icntl[13] = parameterList->get<
int>(
"ICNTL(14)", 20);
290 if( parameterList->isParameter(
"IsContiguous") ){
291 is_contiguous_ = parameterList->get<
bool>(
"IsContiguous");
296 template <
class Matrix,
class Vector>
297 Teuchos::RCP<const Teuchos::ParameterList>
300 using Teuchos::ParameterList;
302 static Teuchos::RCP<const Teuchos::ParameterList> valid_params;
304 if( is_null(valid_params) ){
305 Teuchos::RCP<Teuchos::ParameterList> pl = Teuchos::parameterList();
307 pl->set(
"ICNTL(1)", -1,
"See Manual" );
308 pl->set(
"ICNTL(2)", -1,
"See Manual" );
309 pl->set(
"ICNTL(3)", -1,
"See Manual" );
310 pl->set(
"ICNTL(4)", 1,
"See Manual" );
311 pl->set(
"ICNTL(6)", 0,
"See Manual" );
312 pl->set(
"ICNTL(9)", 1,
"See Manual" );
313 pl->set(
"ICNTL(11)", 0,
"See Manual" );
314 pl->set(
"ICNTL(14)", 20,
"See Manual" );
315 pl->set(
"IsContiguous",
true,
"Whether GIDs contiguous");
324 template <
class Matrix,
class Vector>
328 #ifdef HAVE_AMESOS2_TIMERS
329 Teuchos::TimeMonitor convTimer(this->timers_.mtxConvTime_);
331 if(MUMPS_MATRIX_LOAD ==
false || current_phase==NUMFACT)
334 if( !MUMPS_MATRIX_LOAD && this->root_ ){
335 Kokkos::resize(host_nzvals_view_, this->globalNumNonZeros_);
336 Kokkos::resize(host_rows_view_, this->globalNumNonZeros_);
337 Kokkos::resize(host_col_ptr_view_, this->globalNumRows_ + 1);
340 local_ordinal_type nnz_ret = 0;
342 #ifdef HAVE_AMESOS2_TIMERS
343 Teuchos::TimeMonitor mtxRedistTimer( this->timers_.mtxRedistTime_ );
348 ::do_get(this->matrixA_.ptr(), host_nzvals_view_, host_rows_view_, host_col_ptr_view_, nnz_ret,
349 (is_contiguous_ ==
true) ? ROOTED : CONTIGUOUS_AND_ROOTED,
351 this->rowIndexBase_);
354 TEUCHOS_TEST_FOR_EXCEPTION( nnz_ret != Teuchos::as<local_ordinal_type>(this->globalNumNonZeros_),
356 "Did not get the expected number of non-zero vals");
368 if (current_phase==PREORDERING){
369 MUMPS_MATRIX_LOAD_PREORDERING =
true;
375 MUMPS_MATRIX_LOAD =
true;
379 template <
class Matrix,
class Vector>
383 if ( !MUMPS_STRUCT ) {
385 mumps_par.n = this->globalNumCols_;
386 mumps_par.nz = this->globalNumNonZeros_;
387 mumps_par.a = (mumps_type*)malloc(mumps_par.nz *
sizeof(mumps_type));
388 mumps_par.irn = (MUMPS_INT*)malloc(mumps_par.nz *
sizeof(MUMPS_INT));
389 mumps_par.jcn = (MUMPS_INT*)malloc(mumps_par.nz *
sizeof(MUMPS_INT));
391 if((mumps_par.a == NULL) || (mumps_par.irn == NULL)
392 || (mumps_par.jcn == NULL))
398 local_ordinal_type tri_count = 0;
399 local_ordinal_type i,j;
400 local_ordinal_type max_local_ordinal = 0;
402 for(i = 0; i < (local_ordinal_type)this->globalNumCols_; i++)
404 for( j = host_col_ptr_view_(i); j < host_col_ptr_view_(i+1)-1; j++)
406 mumps_par.jcn[tri_count] = (MUMPS_INT)i+1;
407 mumps_par.irn[tri_count] = (MUMPS_INT)host_rows_view_(j)+1;
408 mumps_par.a[tri_count] = host_nzvals_view_(j);
413 j = host_col_ptr_view_(i+1)-1;
414 mumps_par.jcn[tri_count] = (MUMPS_INT)i+1;
415 mumps_par.irn[tri_count] = (MUMPS_INT)host_rows_view_(j)+1;
416 mumps_par.a[tri_count] = host_nzvals_view_(j);
420 if(host_rows_view_(j) > max_local_ordinal)
422 max_local_ordinal = host_rows_view_(j);
425 TEUCHOS_TEST_FOR_EXCEPTION(std::numeric_limits<MUMPS_INT>::max() <= max_local_ordinal,
427 "Matrix index larger than MUMPS_INT");
432 template<
class Matrix,
class Vector>
434 MUMPS<Matrix,Vector>::MUMPS_ERROR()
const
438 bool Wrong = ((mumps_par.info[0] != 0) || (mumps_par.infog[0] != 0)) && (this->rank_ < this->nprocs_);
440 if (this->rank_==0) {
441 std::cerr <<
"Amesos2_Mumps : ERROR" << std::endl;
442 if ( this->status_.getNumSolve() > 0) {
443 std::cerr <<
" Last Phase : SOLVE" << std::endl;
444 }
else if( this->status_.numericFactorizationDone() ){
445 std::cerr <<
" Last Phase : NUMFACT" << std::endl;
446 }
else if( this->status_.symbolicFactorizationDone() ){
447 std::cerr <<
" Last Phase : SYMBFACT" << std::endl;
448 }
else if( this->status_.preOrderingDone() ){
449 std::cerr <<
" Last Phase : PREORDERING" << std::endl;
451 std::cerr <<
" Last Phase : CLEAN" << std::endl;
453 std::cerr <<
"Amesos2_Mumps : INFOG(1) = " << mumps_par.infog[0] << std::endl;
454 std::cerr <<
"Amesos2_Mumps : INFOG(2) = " << mumps_par.infog[1] << std::endl;
456 if (mumps_par.info[0] != 0 && Wrong) {
457 std::cerr <<
"Amesos2_Mumps : On process " << this->matrixA_->getComm()->getRank()
458 <<
", INFO(1) = " << mumps_par.info[0] << std::endl;
459 std::cerr <<
"Amesos2_Mumps : On process " << this->matrixA_->getComm()->getRank()
460 <<
", INFO(2) = " << mumps_par.info[1] << std::endl;
466 int WrongInt = Wrong;
467 RCP<const Comm<int> > matComm = this->matrixA_->getComm();
468 Teuchos::broadcast<int,int>(*matComm,0,1,&WrongInt);
469 TEUCHOS_TEST_FOR_EXCEPTION(WrongInt>0,
476 template<
class Matrix,
class Vector>
477 const char* MUMPS<Matrix,Vector>::name =
"MUMPS";
481 #endif // AMESOS2_MUMPS_DEF_HPP
A generic helper class for getting a CCS representation of a Matrix.
Definition: Amesos2_Util.hpp:618
int numericFactorization_impl()
MUMPS specific numeric factorization.
Definition: Amesos2_MUMPS_def.hpp:170
EPhase
Used to indicate a phase in the direct solution.
Definition: Amesos2_TypeDecl.hpp:31
global_size_type globalNumCols_
Number of global columns in matrixA_.
Definition: Amesos2_SolverCore_decl.hpp:445
Amesos2 MUMPS declarations.
Helper class for getting 1-D copies of multivectors.
Definition: Amesos2_MultiVecAdapter_decl.hpp:233
int preOrdering_impl()
Performs pre-ordering on the matrix to increase efficiency.
Definition: Amesos2_MUMPS_def.hpp:138
int solve_impl(const Teuchos::Ptr< MultiVecAdapter< Vector > > X, const Teuchos::Ptr< const MultiVecAdapter< Vector > > B) const
MUMPS specific solve.
Definition: Amesos2_MUMPS_def.hpp:188
bool matrixShapeOK_impl() const
Determines whether the shape of the matrix is OK for this solver.
Definition: Amesos2_MUMPS_def.hpp:246
bool loadA_impl(EPhase current_phase)
Reads matrix data into internal structures.
Definition: Amesos2_MUMPS_def.hpp:326
Amesos2 interface to the MUMPS package.
Definition: Amesos2_MUMPS_decl.hpp:50
A Matrix adapter interface for Amesos2.
Definition: Amesos2_MatrixAdapter_decl.hpp:42
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters_impl() const
Definition: Amesos2_MUMPS_def.hpp:298
void setParameters_impl(const Teuchos::RCP< Teuchos::ParameterList > ¶meterList)
Definition: Amesos2_MUMPS_def.hpp:255
Passes functions to TPL functions based on type.
Definition: Amesos2_FunctionMap.hpp:42
Helper class for putting 1-D data arrays into multivectors.
Definition: Amesos2_MultiVecAdapter_decl.hpp:339
A templated MultiVector class adapter for Amesos2.
Definition: Amesos2_MultiVecAdapter_decl.hpp:142
Teuchos::RCP< const MatrixAdapter< Matrix > > matrixA_
The LHS operator.
Definition: Amesos2_SolverCore_decl.hpp:421