Damped Jacobi "solver" templated by matrix type. The "solver" exists in many different incarnations: It's an IterativeLinearSolver, and a Smoother, all of which use the same basic iteration. More...
#include <complex_smoother.h>
Inheritance diagram for oomph::ComplexDampedJacobi< MATRIX >:Public Member Functions | |
| ComplexDampedJacobi (const double &omega=0.5) | |
| Constructor (empty) | |
| ~ComplexDampedJacobi () | |
| Empty destructor. | |
| void | clean_up_memory () |
| Cleanup data that's stored for resolve (if any has been stored) | |
| ComplexDampedJacobi (const ComplexDampedJacobi &)=delete | |
| Broken copy constructor. | |
| void | operator= (const ComplexDampedJacobi &)=delete |
| Broken assignment operator. | |
| void | calculate_omega (const double &k, const double &h) |
| Function to calculate the value of Omega by passing in the value of k and h [see Elman et al. "A multigrid method enhanced by
Krylov subspace iteration for discrete Helmholtz equations", p.1303]. | |
| double & | omega () |
| Get access to the value of Omega (lvalue) | |
| void | complex_smoother_setup (Vector< CRDoubleMatrix * > helmholtz_matrix_pt) |
| Setup: Pass pointer to the matrix and store in cast form. | |
| void | complex_smoother_solve (const Vector< DoubleVector > &rhs, Vector< DoubleVector > &solution) |
| The smoother_solve function performs fixed number of iterations on the system A*result=rhs. The number of (smoothing) iterations is the same as the max. number of iterations in the underlying IterativeLinearSolver class. | |
| void | solve (Problem *const &problem_pt, DoubleVector &result) |
| Use damped Jacobi iteration as an IterativeLinearSolver: This obtains the Jacobian matrix J and the residual vector r (needed for the Newton method) from the problem's get_jacobian function and returns the result of Jx=r. | |
| unsigned | iterations () const |
| Number of iterations taken. | |
Public Member Functions inherited from oomph::HelmholtzSmoother | |
| HelmholtzSmoother () | |
| Empty constructor. | |
| virtual | ~HelmholtzSmoother () |
| Virtual empty destructor. | |
| void | complex_matrix_multiplication (Vector< CRDoubleMatrix * > matrices_pt, const Vector< DoubleVector > &x, Vector< DoubleVector > &soln) |
| Helper function to calculate a complex matrix-vector product. Assumes the matrix has been provided as a Vector of length two; the first entry containing the real part of the system matrix and the second entry containing the imaginary part. | |
| template<typename MATRIX > | |
| void | check_validity_of_solve_helper_inputs (CRDoubleMatrix *const &real_matrix_pt, CRDoubleMatrix *const &imag_matrix_pt, const Vector< DoubleVector > &rhs, Vector< DoubleVector > &solution, const double &n_dof) |
| Self-test to check that all the dimensions of the inputs to solve helper are consistent and everything that needs to be built, is. | |
Public Member Functions inherited from oomph::IterativeLinearSolver | |
| IterativeLinearSolver () | |
| Constructor: Set (default) trivial preconditioner and set defaults for tolerance and max. number of iterations. | |
| IterativeLinearSolver (const IterativeLinearSolver &)=delete | |
| Broken copy constructor. | |
| void | operator= (const IterativeLinearSolver &)=delete |
| Broken assignment operator. | |
| virtual | ~IterativeLinearSolver () |
| Destructor (empty) | |
| Preconditioner *& | preconditioner_pt () |
| Access function to preconditioner. | |
| Preconditioner *const & | preconditioner_pt () const |
| Access function to preconditioner (const version) | |
| double & | tolerance () |
| Access to convergence tolerance. | |
| unsigned & | max_iter () |
| Access to max. number of iterations. | |
| void | enable_doc_convergence_history () |
| Enable documentation of the convergence history. | |
| void | disable_doc_convergence_history () |
| Disable documentation of the convergence history. | |
| void | open_convergence_history_file_stream (const std::string &file_name, const std::string &zone_title="") |
| Write convergence history into file with specified filename (automatically switches on doc). Optional second argument is a string that can be used (as a zone title) to identify what case we're running (e.g. what combination of linear solver and preconditioner or parameter values are used). | |
| void | close_convergence_history_file_stream () |
| Close convergence history output stream. | |
| double | jacobian_setup_time () const |
| returns the time taken to assemble the jacobian matrix and residual vector | |
| double | linear_solver_solution_time () const |
| return the time taken to solve the linear system | |
| virtual double | preconditioner_setup_time () const |
| returns the the time taken to setup the preconditioner | |
| void | enable_setup_preconditioner_before_solve () |
| Setup the preconditioner before the solve. | |
| void | disable_setup_preconditioner_before_solve () |
| Don't set up the preconditioner before the solve. | |
| void | enable_error_after_max_iter () |
| Throw an error if we don't converge within max_iter. | |
| void | disable_error_after_max_iter () |
| Don't throw an error if we don't converge within max_iter (default). | |
| void | enable_iterative_solver_as_preconditioner () |
| Enables the iterative solver be used as preconditioner (when calling the solve method it bypass the setup solver method – currently only used by Trilinos solver —) | |
| void | disable_iterative_solver_as_preconditioner () |
| Disables the iterative solver be used as preconditioner (when calling the solve method it bypass the setup solver method – currently only used by Trilinos solver —) | |
Public Member Functions inherited from oomph::LinearSolver | |
| LinearSolver () | |
| Empty constructor, initialise the member data. | |
| LinearSolver (const LinearSolver &dummy)=delete | |
| Broken copy constructor. | |
| void | operator= (const LinearSolver &)=delete |
| Broken assignment operator. | |
| virtual | ~LinearSolver () |
| Empty virtual destructor. | |
| void | enable_doc_time () |
| Enable documentation of solve times. | |
| void | disable_doc_time () |
| Disable documentation of solve times. | |
| bool | is_doc_time_enabled () const |
| Is documentation of solve times enabled? | |
| bool | is_resolve_enabled () const |
| Boolean flag indicating if resolves are enabled. | |
| virtual void | enable_resolve () |
| Enable resolve (i.e. store matrix and/or LU decomposition, say) Virtual so it can be overloaded to perform additional tasks. | |
| virtual void | disable_resolve () |
| Disable resolve (i.e. store matrix and/or LU decomposition, say) This function simply resets an internal flag. It's virtual so it can be overloaded to perform additional tasks such as cleaning up memory that is only required for the resolve. | |
| virtual void | solve (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &result) |
| Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. | |
| virtual void | solve (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result) |
| Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. | |
| virtual void | solve_transpose (Problem *const &problem_pt, DoubleVector &result) |
| Solver: Takes pointer to problem and returns the results vector which contains the solution of the linear system defined by the problem's fully assembled Jacobian and residual vector (broken virtual). | |
| virtual void | solve_transpose (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &result) |
| Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. | |
| virtual void | solve_transpose (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result) |
| Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. | |
| virtual void | resolve (const DoubleVector &rhs, DoubleVector &result) |
| Resolve the system defined by the last assembled jacobian and the rhs vector. Solution is returned in the vector result. (broken virtual) | |
| virtual void | resolve_transpose (const DoubleVector &rhs, DoubleVector &result) |
| Solver: Resolve the system defined by the last assembled jacobian and the rhs vector. Solution is returned in the vector result. (broken virtual) | |
| virtual void | enable_computation_of_gradient () |
| function to enable the computation of the gradient required for the globally convergent Newton method | |
| void | disable_computation_of_gradient () |
| function to disable the computation of the gradient required for the globally convergent Newton method | |
| void | reset_gradient () |
| function to reset the size of the gradient before each Newton solve | |
| void | get_gradient (DoubleVector &gradient) |
| function to access the gradient, provided it has been computed | |
Public Member Functions inherited from oomph::DistributableLinearAlgebraObject | |
| DistributableLinearAlgebraObject () | |
| Default constructor - create a distribution. | |
| DistributableLinearAlgebraObject (const DistributableLinearAlgebraObject &matrix)=delete | |
| Broken copy constructor. | |
| void | operator= (const DistributableLinearAlgebraObject &)=delete |
| Broken assignment operator. | |
| virtual | ~DistributableLinearAlgebraObject () |
| Destructor. | |
| LinearAlgebraDistribution * | distribution_pt () const |
| access to the LinearAlgebraDistribution | |
| unsigned | nrow () const |
| access function to the number of global rows. | |
| unsigned | nrow_local () const |
| access function for the num of local rows on this processor. | |
| unsigned | nrow_local (const unsigned &p) const |
| access function for the num of local rows on this processor. | |
| unsigned | first_row () const |
| access function for the first row on this processor | |
| unsigned | first_row (const unsigned &p) const |
| access function for the first row on this processor | |
| bool | distributed () const |
| distribution is serial or distributed | |
| bool | distribution_built () const |
| if the communicator_pt is null then the distribution is not setup then false is returned, otherwise return true | |
| void | build_distribution (const LinearAlgebraDistribution *const dist_pt) |
| setup the distribution of this distributable linear algebra object | |
| void | build_distribution (const LinearAlgebraDistribution &dist) |
| setup the distribution of this distributable linear algebra object | |
Private Member Functions | |
| void | complex_solve_helper (const Vector< DoubleVector > &rhs, Vector< DoubleVector > &solution) |
| This is where the actual work is done. | |
Private Attributes | |
| bool | Matrix_can_be_deleted |
| Boolean flag to indicate if the matrices pointed to by Matrix_real_pt and Matrix_imag_pt can be deleted. | |
| CRDoubleMatrix * | Matrix_real_pt |
| Pointer to the real part of the system matrix. | |
| CRDoubleMatrix * | Matrix_imag_pt |
| Pointer to the real part of the system matrix. | |
| Vector< double > | Matrix_diagonal_real |
| Vector containing the diagonal entries of A_r (real(A)) | |
| Vector< double > | Matrix_diagonal_imag |
| Vector containing the diagonal entries of A_c (imag(A)) | |
| Vector< double > | Matrix_diagonal_inv_sq |
| Vector whose j'th entry is given by 1/(A_r(j,j)^2 + A_c(j,j)^2) | |
| unsigned | Iterations |
| Number of iterations taken. | |
| double | Omega |
| Damping factor. | |
Additional Inherited Members | |
Protected Member Functions inherited from oomph::DistributableLinearAlgebraObject | |
| void | clear_distribution () |
| clear the distribution of this distributable linear algebra object | |
Protected Attributes inherited from oomph::HelmholtzSmoother | |
| bool | Use_as_smoother |
| When a derived class object is being used as a smoother in the MG algorithm the residual norm does not need to be calculated. This boolean is used as a flag to indicate this in solve_helper(...) | |
Protected Attributes inherited from oomph::IterativeLinearSolver | |
| bool | Doc_convergence_history |
| Flag indicating if the convergence history is to be documented. | |
| std::ofstream | Output_file_stream |
| Output file stream for convergence history. | |
| double | Tolerance |
| Convergence tolerance. | |
| unsigned | Max_iter |
| Maximum number of iterations. | |
| Preconditioner * | Preconditioner_pt |
| Pointer to the preconditioner. | |
| double | Jacobian_setup_time |
| Jacobian setup time. | |
| double | Solution_time |
| linear solver solution time | |
| double | Preconditioner_setup_time |
| Preconditioner setup time. | |
| bool | Setup_preconditioner_before_solve |
| indicates whether the preconditioner should be setup before solve. Default = true; | |
| bool | Throw_error_after_max_iter |
| Should we throw an error instead of just returning when we hit the max iterations? | |
| bool | Use_iterative_solver_as_preconditioner |
| Use the iterative solver as preconditioner. | |
| bool | First_time_solve_when_used_as_preconditioner |
| When the iterative solver is used a preconditioner then we call the setup of solver method only once (the first time the solve method is called) | |
Protected Attributes inherited from oomph::LinearSolver | |
| bool | Enable_resolve |
| Boolean that indicates whether the matrix (or its factors, in the case of direct solver) should be stored so that the resolve function can be used. | |
| bool | Doc_time |
| Boolean flag that indicates whether the time taken. | |
| bool | Compute_gradient |
| flag that indicates whether the gradient required for the globally convergent Newton method should be computed or not | |
| bool | Gradient_has_been_computed |
| flag that indicates whether the gradient was computed or not | |
| DoubleVector | Gradient_for_glob_conv_newton_solve |
| DoubleVector storing the gradient for the globally convergent Newton method. | |
Static Protected Attributes inherited from oomph::IterativeLinearSolver | |
| static IdentityPreconditioner | Default_preconditioner |
| Default preconditioner: The base class for preconditioners is a fully functional (if trivial!) preconditioner. | |
Damped Jacobi "solver" templated by matrix type. The "solver" exists in many different incarnations: It's an IterativeLinearSolver, and a Smoother, all of which use the same basic iteration.
Definition at line 281 of file complex_smoother.h.
|
inline |
Constructor (empty)
Definition at line 285 of file complex_smoother.h.
|
inline |
Empty destructor.
Definition at line 292 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::clean_up_memory().
|
delete |
Broken copy constructor.
|
inline |
Function to calculate the value of Omega by passing in the value of k and h [see Elman et al. "A multigrid method enhanced by Krylov subspace iteration for discrete Helmholtz equations", p.1303].
Definition at line 333 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::omega(), oomph::ComplexDampedJacobi< MATRIX >::Omega, oomph::MathematicalConstants::Pi, and oomph::IterativeLinearSolver::tolerance().
|
inlinevirtual |
Cleanup data that's stored for resolve (if any has been stored)
Reimplemented from oomph::LinearSolver.
Definition at line 299 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::Matrix_can_be_deleted, oomph::ComplexDampedJacobi< MATRIX >::Matrix_imag_pt, and oomph::ComplexDampedJacobi< MATRIX >::Matrix_real_pt.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::~ComplexDampedJacobi().
|
inlinevirtual |
Setup: Pass pointer to the matrix and store in cast form.
Implements oomph::HelmholtzSmoother.
Definition at line 398 of file complex_smoother.h.
References oomph::CRDoubleMatrix::diagonal_entries(), i, oomph::ComplexDampedJacobi< MATRIX >::Matrix_can_be_deleted, oomph::ComplexDampedJacobi< MATRIX >::Matrix_diagonal_imag, oomph::ComplexDampedJacobi< MATRIX >::Matrix_diagonal_inv_sq, oomph::ComplexDampedJacobi< MATRIX >::Matrix_diagonal_real, oomph::ComplexDampedJacobi< MATRIX >::Matrix_imag_pt, oomph::ComplexDampedJacobi< MATRIX >::Matrix_real_pt, and oomph::CRDoubleMatrix::nrow().
|
inlinevirtual |
The smoother_solve function performs fixed number of iterations on the system A*result=rhs. The number of (smoothing) iterations is the same as the max. number of iterations in the underlying IterativeLinearSolver class.
Implements oomph::HelmholtzSmoother.
Definition at line 472 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::complex_solve_helper(), and oomph::HelmholtzSmoother::Use_as_smoother.
|
private |
This is where the actual work is done.
Definition at line 532 of file complex_smoother.h.
References i, oomph::oomph_info, oomph::TAdvectionDiffusionReactionElement< NREAGENT, DIM, NNODE_1D >::TAdvectionDiffusionReactionElement(), and oomph::TimingHelpers::timer().
Referenced by oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_solve().
|
inlinevirtual |
Number of iterations taken.
Implements oomph::IterativeLinearSolver.
Definition at line 492 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::Iterations.
|
inline |
Get access to the value of Omega (lvalue)
Definition at line 391 of file complex_smoother.h.
References oomph::ComplexDampedJacobi< MATRIX >::Omega.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::calculate_omega().
|
delete |
Broken assignment operator.
|
inlinevirtual |
Use damped Jacobi iteration as an IterativeLinearSolver: This obtains the Jacobian matrix J and the residual vector r (needed for the Newton method) from the problem's get_jacobian function and returns the result of Jx=r.
Implements oomph::LinearSolver.
Definition at line 486 of file complex_smoother.h.
References oomph::BrokenCopy::broken_assign().
|
private |
Number of iterations taken.
Definition at line 522 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::iterations().
|
private |
Boolean flag to indicate if the matrices pointed to by Matrix_real_pt and Matrix_imag_pt can be deleted.
Definition at line 504 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::clean_up_memory(), and oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Vector containing the diagonal entries of A_c (imag(A))
Definition at line 516 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Vector whose j'th entry is given by 1/(A_r(j,j)^2 + A_c(j,j)^2)
Definition at line 519 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Vector containing the diagonal entries of A_r (real(A))
Definition at line 513 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Pointer to the real part of the system matrix.
Definition at line 510 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::clean_up_memory(), and oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Pointer to the real part of the system matrix.
Definition at line 507 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::clean_up_memory(), and oomph::ComplexDampedJacobi< MATRIX >::complex_smoother_setup().
|
private |
Damping factor.
Definition at line 525 of file complex_smoother.h.
Referenced by oomph::ComplexDampedJacobi< MATRIX >::calculate_omega(), and oomph::ComplexDampedJacobi< MATRIX >::omega().