Skip to content
Snippets Groups Projects
Commit 9b22ac2f authored by Sreekanth Arikatla's avatar Sreekanth Arikatla
Browse files

ENH: Add SOR solver

parent d03575c6
No related branches found
No related tags found
No related merge requests found
/*=========================================================================
Library: iMSTK
Copyright (c) Kitware, Inc. & Center for Modeling, Simulation,
& Imaging in Medicine, Rensselaer Polytechnic Institute.
Licensed under the Apache License, Version 2.0 (the "License");
you may not use this file except in compliance with the License.
You may obtain a copy of the License at
http://www.apache.org/licenses/LICENSE-2.0.txt
Unless required by applicable law or agreed to in writing, software
distributed under the License is distributed on an "AS IS" BASIS,
WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
See the License for the specific language governing permissions and
limitations under the License.
=========================================================================*/
#include "imstkSOR.h"
namespace imstk
{
SOR::SOR(const SparseMatrixd& A, const Vectord& rhs) : SOR()
{
this->setSystem(std::make_shared<LinearSystem<SparseMatrixd>>(A, rhs));
}
void
SOR::solve(Vectord& x)
{
if(!m_linearSystem)
{
LOG(WARNING) << "SOR::solve: Linear system is not supplied for Gauss-Seidel solver!";
return;
}
if (m_FixedLinearProjConstraints->size() == 0)
{
this->SORSolve(x);
}
else
{
// Do nothing for now!
}
}
void
SOR::solve(Vectord& x, const double tolerance)
{
this->setTolerance(tolerance);
this->solve(x);
}
void
SOR::SORSolve(Vectord& x)
{
const auto &b = m_linearSystem->getRHSVector();
const auto &A = m_linearSystem->getMatrix();
// Set the initial guess to zero
x.setZero();
auto xOld = x;
size_t iterNum = 0;
while (iterNum < this->getMaxNumIterations())
{
for (auto k = 0; k < A.outerSize(); ++k)
{
double diagEle = 0.;
double aggregate = 0.;
for (SparseMatrixd::InnerIterator it(A, k); it; ++it)
{
auto col = it.col();
if (k != col)
{
aggregate += it.value()*x[col];
}
else
{
diagEle = it.value();
}
}
x[k] = (b[k] - aggregate) / diagEle; // div by zero is possible!
}
x *= m_relaxationFactor;
x += (1. - m_relaxationFactor)*xOld;
if ((x - xOld).norm() < 1.0e-4)
{
return;
}
xOld = x;
iterNum++;
}
}
double
SOR::getResidual(const Vectord& )
{
return 0;
}
void
SOR::setTolerance(const double epsilon)
{
IterativeLinearSolver::setTolerance(epsilon);
}
void
SOR::setMaxNumIterations(const size_t maxIter)
{
IterativeLinearSolver::setMaxNumIterations(maxIter);
}
void
SOR::setSystem(std::shared_ptr<LinearSystem<SparseMatrixd>> newSystem)
{
LinearSolver<SparseMatrixd>::setSystem(newSystem);
}
void
SOR::print() const
{
IterativeLinearSolver::print();
LOG(INFO) << "Solver: SOR";
LOG(INFO) << "Tolerance: " << m_tolerance;
LOG(INFO) << "max. iterations: " << m_maxIterations;
}
} // imstk
\ No newline at end of file
/*=========================================================================
Library: iMSTK
Copyright (c) Kitware, Inc. & Center for Modeling, Simulation,
& Imaging in Medicine, Rensselaer Polytechnic Institute.
Licensed under the Apache License, Version 2.0 (the "License");
you may not use this file except in compliance with the License.
You may obtain a copy of the License at
http://www.apache.org/licenses/LICENSE-2.0.txt
Unless required by applicable law or agreed to in writing, software
distributed under the License is distributed on an "AS IS" BASIS,
WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
See the License for the specific language governing permissions and
limitations under the License.
=========================================================================*/
#ifndef imstkSOR_h
#define imstkSOR_h
#include <memory>
// iMSTK includes
#include "imstkNonlinearSystem.h"
#include "imstkIterativeLinearSolver.h"
// Eigen includes
#include <Eigen/IterativeLinearSolvers>
namespace imstk
{
///
/// \brief Successive Over Relaxation (SOR) sparse linear solver
///
class SOR : public IterativeLinearSolver
{
public:
///
/// \brief Constructors/Destructor
///
SOR(const double relaxationFactor = 0.5) { m_type = Type::SuccessiveOverRelaxation; };
SOR(const SparseMatrixd &A, const Vectord& rhs);
~SOR() = default;
///
/// \brief Remove specific constructor signatures
///
SOR(const SOR &) = delete;
SOR &operator=(const SOR &) = delete;
///
/// \brief Do one iteration of the method.
///
void iterate(Vectord& x, bool updateResidual = true) override {};
///
/// \brief Gauss-Seidel solver
///
void SORSolve(Vectord& x);
///
/// \brief Solve the system of equations.
///
void solve(Vectord& x) override;
///
/// \brief Solve the linear system using Gauss-Seidel iterations to a
/// specified tolerance.
///
void solve(Vectord& x, const double tolerance);
///
/// \brief Return the error calculated by the solver.
///
double getResidual(const Vectord& x) override;
///
/// \brief Sets the system. System of linear equations.
///
void setSystem(std::shared_ptr<LinearSystemType> newSystem) override;
///
/// \brief set/get the maximum number of iterations for the iterative solver.
///
virtual void setMaxNumIterations(const size_t maxIter) override;
///
/// \brief Set solver tolerance
///
void setTolerance(const double tolerance);
///
/// \brief Print solver information
///
void print() const override;
///
/// \brief Return the relaxation factor
///
double getRelaxationFactor() const { return m_relaxationFactor; };
///
/// \brief Get the vector denoting the filter
///
void setLinearProjectors(std::vector<LinearProjectionConstraint>* f)
{
m_FixedLinearProjConstraints = f;
}
///
/// \brief Get the vector denoting the filter
///
std::vector<LinearProjectionConstraint>& getLinearProjectors()
{
return *m_FixedLinearProjConstraints;
}
///
/// \brief Get the vector denoting the filter
///
void setDynamicLinearProjectors(std::vector<LinearProjectionConstraint>* f)
{
m_DynamicLinearProjConstraints = f;
}
///
/// \brief Get the vector denoting the filter
///
std::vector<LinearProjectionConstraint>& getDynamicLinearProjectors()
{
return *m_DynamicLinearProjConstraints;
}
private:
double m_relaxationFactor = 0.5;
std::vector<LinearProjectionConstraint> *m_FixedLinearProjConstraints;
std::vector<LinearProjectionConstraint> *m_DynamicLinearProjConstraints;
};
} // imstk
#endif // imstkSOR_h
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment