MueLu Version of the Day
Loading...
Searching...
No Matches
MueLu_SteepestDescentSolver_def.hpp
Go to the documentation of this file.
1// @HEADER
2// *****************************************************************************
3// MueLu: A package for multigrid based preconditioning
4//
5// Copyright 2012 NTESS and the MueLu contributors.
6// SPDX-License-Identifier: BSD-3-Clause
7// *****************************************************************************
8// @HEADER
9
10#ifndef MUELU_STEEPESTDESCENTSOLVER_DEF_HPP
11#define MUELU_STEEPESTDESCENTSOLVER_DEF_HPP
12
13#include <Xpetra_CrsMatrixFactory.hpp>
14#include <Xpetra_CrsMatrixWrap.hpp>
15#include <Xpetra_MatrixMatrix.hpp>
16
17#include "MueLu_Constraint.hpp"
18#include "MueLu_Monitor.hpp"
19#include "MueLu_Utilities.hpp"
20
22
23namespace MueLu {
24
25using Teuchos::rcp_const_cast;
26
27template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
29 : nIts_(Its)
30 , stepLength_(StepLength) {}
31
32template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
33void SteepestDescentSolver<Scalar, LocalOrdinal, GlobalOrdinal, Node>::Iterate(const Matrix& Aref, const Constraint& C, const Matrix& P0, RCP<Matrix>& P) const {
34 PrintMonitor m(*this, "SD iterations");
35
36 RCP<const Matrix> A = rcpFromRef(Aref);
37 RCP<Matrix> AP, G;
38
39 Teuchos::FancyOStream& mmfancy = this->GetOStream(Statistics2);
40
41 RCP<CrsMatrix> Ptmp_ = CrsMatrixFactory::Build(C.GetPattern());
42 Ptmp_->fillComplete(P0.getDomainMap(), P0.getRangeMap());
43 RCP<Matrix> Ptmp = rcp(new CrsMatrixWrap(Ptmp_));
44
45 // Initial P0 would only be used for multiplication
46 P = rcp_const_cast<Matrix>(rcpFromRef(P0));
47
48 const auto rowMap = A->getRowMap();
49 auto invDiag = Xpetra::VectorFactory<Scalar, LocalOrdinal, GlobalOrdinal, Node>::Build(rowMap, true);
50 A->getLocalDiagCopy(*invDiag);
51 invDiag->reciprocal(*invDiag);
52
53 for (size_t k = 0; k < nIts_; k++) {
54 AP = Xpetra::MatrixMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>::Multiply(*A, false, *P, false, mmfancy, true, true);
55#if 0
56 // gradient = -2 A^T * A * P
57 SC stepLength = 2*stepLength_;
58 G = Xpetra::MatrixMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>::Multiply(*A, true, *AP, false, true, true);
59 C.Apply(*G, *Ptmp);
60#else
61 // gradient = - A * P
62 SC stepLength = stepLength_;
63 AP->leftScale(*invDiag);
64 C.Apply(*AP, *Ptmp);
65#endif
66
67 RCP<Matrix> newP;
68 Xpetra::MatrixMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>::TwoMatrixAdd(*Ptmp, false, -stepLength, *P, false, Teuchos::ScalarTraits<Scalar>::one(), newP, mmfancy);
69 newP->fillComplete(P->getDomainMap(), P->getRangeMap());
70 P = newP;
71 }
72}
73} // namespace MueLu
74
75#endif // ifndef MUELU_STEEPESTDESCENTSOLVER_DECL_HPP
Constraint space information for the potential prolongator.
RCP< const CrsGraph > GetPattern() const
void Apply(const Matrix &P, Matrix &Projected) const
Apply constraint.
void Iterate(const Matrix &A, const Constraint &C, const Matrix &P0, RCP< Matrix > &P) const
Iterate.
SteepestDescentSolver(size_t Its, SC StepLength=Teuchos::ScalarTraits< Scalar >::one())
Namespace for MueLu classes and methods.
@ Statistics2
Print even more statistics.