38class AlephVectorTrilinos :
public IAlephVector
43 : IAlephVector(tm, kernel, index)
45 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorTrilinos] new SolverVectorTrilinos";
47 m_trilinos_Comm =
new Epetra_MpiComm(*(MPI_Comm*)(m_kernel->subParallelMng(m_index)->getMPICommunicator()));
49 m_trilinos_Comm =
new Epetra_SerialComm();
53 ~AlephVectorTrilinos()
55 delete m_trilinos_vector;
56 delete m_trilinos_Comm;
64 void AlephVectorCreate(
void)
66 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorCreate] TRILINOS VectorCreate";
69 for (
int iCpu = 0; iCpu < m_kernel->size(); ++iCpu) {
70 if (m_kernel->rank() != m_kernel->solverRanks(m_index)[iCpu])
73 jlower = m_kernel->topology()->gathered_nb_row(iCpu);
74 jupper = m_kernel->topology()->gathered_nb_row(iCpu + 1) - 1;
76 Integer size = jupper - jlower + 1;
77 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorCreate] jlower=" << jlower <<
", jupper=" << jupper;
78 Epetra_Map trilinos_Map = Epetra_Map(m_kernel->topology()->nb_row_size(),
82 m_trilinos_vector =
new Epetra_Vector(trilinos_Map);
83 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorCreate] done";
89 void AlephVectorSet(
const double* bfr_val,
const int* bfr_idx,
Integer size)
91 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorSet]";
92 m_trilinos_vector->ReplaceGlobalValues(size, bfr_val, bfr_idx);
99 int AlephVectorAssemble(
void)
108 void AlephVectorGet(
double* bfr_val,
const int* bfr_idx,
Integer size)
110 ARCANE_UNUSED(bfr_idx);
111 debug() <<
"\t\t[AlephVectorTrilinos::AlephVectorGet]";
112 for (
int i = 0; i < size; ++i) {
114 bfr_val[i] = (*m_trilinos_vector)[i];
124 void writeToFile(
const String filename)
126 ARCANE_UNUSED(filename);
127 debug() <<
"\t\t[AlephVectorTrilinos::writeToFile]";
134 Real LinftyNorm(
void)
137 if (m_trilinos_vector->NormInf(&Result) != 0)
138 throw Exception(
"LinftyNorm",
"NormInf error");
145 void fill(
Real value)
147 m_trilinos_vector->PutScalar(value);
151 Epetra_Vector* m_trilinos_vector =
nullptr;
152 Epetra_Comm* m_trilinos_Comm =
nullptr;
161class AlephMatrixTrilinos
169 : IAlephMatrix(tm, kernel, index)
171 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixTrilinos] new AlephMatrixTrilinos";
173 m_trilinos_Comm =
new Epetra_MpiComm(*(MPI_Comm*)(m_kernel->subParallelMng(m_index)->getMPICommunicator()));
175 m_trilinos_Comm =
new Epetra_SerialComm();
179 ~AlephMatrixTrilinos()
181 delete m_trilinos_matrix;
182 delete m_trilinos_Comm;
188 void AlephMatrixCreate(
void)
190 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixCreate] TRILINOS MatrixCreate idx:" << m_index;
193 for (
int iCpu = 0; iCpu < m_kernel->size(); ++iCpu) {
194 if (m_kernel->rank() != m_kernel->solverRanks(m_index)[iCpu])
197 ilower = m_kernel->topology()->gathered_nb_row(iCpu);
198 iupper = m_kernel->topology()->gathered_nb_row(iCpu + 1) - 1;
200 Integer size = iupper - ilower + 1;
202 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixCreate] ilower=" << ilower <<
", iupper=" << iupper;
206 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixCreate] jlower=" << jlower <<
", jupper=" << jupper;
207 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixCreate] global=" << m_kernel->topology()->nb_row_size();
208 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixCreate] size=" << size;
210 Epetra_Map trilinos_Map = Epetra_Map(m_kernel->topology()->nb_row_size(),
214 m_trilinos_matrix =
new Epetra_CrsMatrix(Copy,
216 m_kernel->topology()->gathered_nb_row_elements().subView(ilower, size).unguardedBasePointer(),
223 void AlephMatrixSetFilled(
bool) {}
228 int AlephMatrixAssemble(
void)
230 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixAssemble] AlephMatrixAssemble";
231 m_trilinos_matrix->FillComplete();
238 void AlephMatrixFill(
int size,
int* rows,
int* cols,
double* values)
240 [[maybe_unused]]
int rtn = 0;
241 for (
int i = 0; i < size; i++) {
246 rtn += m_trilinos_matrix->InsertGlobalValues(rows[i], 1, &values[i], &cols[i]);
249 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixFill] done";
272 const bool convergence_analyse =
true;
275 const Real res0 = b->LinftyNorm();
277 if (convergence_analyse)
278 debug() <<
"analyse convergence : norme max du second membre res0 : " << res0;
280 const Real considered_as_null = params->minRHSNorm();
281 if (res0 < considered_as_null) {
283 residual_norm[0] = res0;
284 if (convergence_analyse)
285 debug() <<
"analyse convergence : le second membre du système linéaire est inférieur à : " << considered_as_null;
289 if (params->xoUser()) {
292 m_trilinos_matrix->Multiply(
false,
293 *x->m_trilinos_vector,
294 *tmp->m_trilinos_vector);
295 tmp->m_trilinos_vector->Update(-1.0,
296 *b->m_trilinos_vector,
298 const Real residu = tmp->LinftyNorm();
301 if (residu < considered_as_null) {
302 if (convergence_analyse) {
303 debug() <<
"analyse convergence : |Ax0-b| est inférieur à " << considered_as_null;
304 debug() <<
"analyse convergence : x0 est déjà solution du système.";
306 residual_norm[0] = residu;
310 const Real relative_error = residu / res0;
311 if (convergence_analyse)
312 debug() <<
"analyse convergence : résidu initial : " << residu
313 <<
" --- residu relatif initial (residu/res0) : " << residu / res0;
315 if (relative_error < (params->epsilon())) {
316 if (convergence_analyse)
317 debug() <<
"analyse convergence : X est déjà solution du système";
318 residual_norm[0] = residu;
322 if (convergence_analyse)
323 debug() <<
"analyse convergence : return false";
337 Ifpack_IC* ICPrecond =
nullptr;
338 Teuchos::ParameterList* MLList =
nullptr;
339 ML_Epetra::MultiLevelPreconditioner* MLPrecond =
nullptr;
340 const String func_name(
"SolverMatrixTrilinos::solve");
350 if (isAlreadySolved(x_tri, b_tri, t_tri, residual_norm, solver_param)) {
352 debug() <<
"\t[AlephMatrixSloop::AlephMatrixSolve] isAlreadySolved !";
357 Epetra_Vector* X = x_tri->m_trilinos_vector;
358 Epetra_Vector* B = b_tri->m_trilinos_vector;
360 if (!solver_param->xoUser())
364 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] Create Linear Problem";
365 Epetra_LinearProblem problem(m_trilinos_matrix, X, B);
368 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] Create AztecOO instance";
369 AztecOO solver(problem);
371 solver.SetAztecOption(AZ_output, solver_param->getOutputLevel());
373 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] Setting options";
374 switch (solver_param->method()) {
375 case TypesSolver::PCG:
376 solver.SetAztecOption(AZ_solver, AZ_cg);
378 case TypesSolver::BiCGStab:
379 solver.SetAztecOption(AZ_solver, AZ_bicgstab);
381 case TypesSolver::BiCGStab2:
382 solver.SetAztecOption(AZ_solver, AZ_bicgstab);
384 case TypesSolver::GMRES:
385 solver.SetAztecOption(AZ_solver, AZ_gmres);
387 case TypesSolver::SuperLU:
388 solver.SetAztecOption(AZ_solver, AZ_slu);
394 switch (solver_param->precond()) {
395 case TypesSolver::NONE:
396 solver.SetAztecOption(AZ_precond, AZ_none);
398 case TypesSolver::DIAGONAL:
399 solver.SetAztecOption(AZ_precond, AZ_Jacobi);
401 case TypesSolver::ILU: {
402 solver.SetAztecOption(AZ_precond, AZ_dom_decomp);
403 solver.SetAztecOption(AZ_subdomain_solve, AZ_ilu);
406 case TypesSolver::ILUp:
407 solver.SetAztecOption(AZ_precond, AZ_bilu);
409 case TypesSolver::POLY:
410 solver.SetAztecOption(AZ_precond, AZ_Neumann);
412 case TypesSolver::AMG: {
413 MLList =
new Teuchos::ParameterList();
423 ML_Epetra::SetDefaults(
"SA", *MLList);
427 MLList->set(
"cycle applications", solver_param->getAmgSolverIter());
428 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] Setting cycle application=" << solver_param->getAmgSolverIter();
431 MLList->set(
"smoother: sweeps", solver_param->getAmgSmootherIter());
432 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] Setting smoother: sweeps=" << solver_param->getAmgSmootherIter();
436 MLList->set(
"ML debug mode",
false);
438 MLPrecond =
new ML_Epetra::MultiLevelPreconditioner(*m_trilinos_matrix, *MLList);
448 solver.SetPrecOperator(MLPrecond);
451 case TypesSolver::IC: {
452 ICPrecond =
new Ifpack_IC(m_trilinos_matrix);
453 IFPACK_CHK_ERR(ICPrecond->Compute());
454 solver.SetPrecOperator(ICPrecond);
457 case TypesSolver::SPAIstat:
458 throw ArgumentException(func_name,
"preconditionnement AztecOO::SPAIstat indisponible");
459 case TypesSolver::AINV:
460 throw ArgumentException(func_name,
"preconditionnement AztecOO::AINV indisponible");
461 case TypesSolver::SPAIdyn:
462 throw ArgumentException(func_name,
"preconditionnement AztecOO::SPAIdyn indisponible");
469 solver.Iterate(solver_param->maxIter(), solver_param->epsilon());
472 solver.GetLHS()->Norm2(norm);
473 double real_residual;
474 X->Norm2(&real_residual);
476 debug() <<
"[AlephMatrixTrilinos::AlephMatrixSolve]"
478 <<
"\n\t\tNumIters=" << solver.NumIters()
480 <<
"\n\t\tTrueResidual=" << solver.TrueResidual()
482 <<
"\n\t\tScaledResidual=" << solver.ScaledResidual()
484 <<
"\n\t\tRecursiveResidual=" << solver.RecursiveResidual()
485 <<
"\n\t\tnorm=" << norm[0]
486 <<
"\n\t\tRealResidual=" << real_residual;
488 nb_iteration =
static_cast<Integer>(solver.NumIters());
489 residual_norm[0] =
static_cast<Real>(solver.TrueResidual());
491 if (solver_param->maxIter() <= nb_iteration)
492 throw Exception(
"Nombre max d'itérations du solveur atteint!",
493 "AlephMatrixTrilinos::AlephMatrixSolve");
500 if (MLPrecond != NULL)
502 if (ICPrecond != NULL)
505 debug() <<
"\t\t[AlephMatrixTrilinos::AlephMatrixSolve] done";
512 void writeToFile(
const String filename)
514 ARCANE_UNUSED(filename);
518 Epetra_CrsMatrix* m_trilinos_matrix =
nullptr;
519 Epetra_Comm* m_trilinos_Comm =
nullptr;