Reference documentation for deal.II version 9.0.0
|
#include <deal.II/lac/slepc_solver.h>
Classes | |
struct | AdditionalData |
Public Member Functions | |
SolverPower (SolverControl &cn, const MPI_Comm &mpi_communicator=PETSC_COMM_SELF, const AdditionalData &data=AdditionalData()) | |
Public Member Functions inherited from SLEPcWrappers::SolverBase | |
SolverBase (SolverControl &cn, const MPI_Comm &mpi_communicator) | |
virtual | ~SolverBase () |
template<typename OutputVector > | |
void | solve (const PETScWrappers::MatrixBase &A, std::vector< PetscScalar > &eigenvalues, std::vector< OutputVector > &eigenvectors, const unsigned int n_eigenpairs=1) |
template<typename OutputVector > | |
void | solve (const PETScWrappers::MatrixBase &A, const PETScWrappers::MatrixBase &B, std::vector< PetscScalar > &eigenvalues, std::vector< OutputVector > &eigenvectors, const unsigned int n_eigenpairs=1) |
template<typename OutputVector > | |
void | solve (const PETScWrappers::MatrixBase &A, const PETScWrappers::MatrixBase &B, std::vector< double > &real_eigenvalues, std::vector< double > &imag_eigenvalues, std::vector< OutputVector > &real_eigenvectors, std::vector< OutputVector > &imag_eigenvectors, const unsigned int n_eigenpairs=1) |
void | set_initial_vector (const PETScWrappers::VectorBase &this_initial_vector) |
template<typename Vector > | |
void | set_initial_space (const std::vector< Vector > &initial_space) |
void | set_transformation (SLEPcWrappers::TransformationBase &this_transformation) |
void | set_target_eigenvalue (const PetscScalar &this_target) |
void | set_which_eigenpairs (EPSWhich set_which) |
void | set_problem_type (EPSProblemType set_problem) |
void | get_solver_state (const SolverControl::State state) |
SolverControl & | control () const |
Protected Attributes | |
const AdditionalData | additional_data |
Protected Attributes inherited from SLEPcWrappers::SolverBase | |
SolverControl & | solver_control |
const MPI_Comm | mpi_communicator |
EPS | eps |
Additional Inherited Members | |
Static Public Member Functions inherited from SLEPcWrappers::SolverBase | |
static ::ExceptionBase & | ExcSLEPcWrappersUsageError () |
static ::ExceptionBase & | ExcSLEPcError (int arg1) |
static ::ExceptionBase & | ExcSLEPcEigenvectorConvergenceMismatchError (int arg1, int arg2) |
Protected Member Functions inherited from SLEPcWrappers::SolverBase | |
void | solve (const unsigned int n_eigenpairs, unsigned int *n_converged) |
void | get_eigenpair (const unsigned int index, PetscScalar &eigenvalues, PETScWrappers::VectorBase &eigenvectors) |
void | get_eigenpair (const unsigned int index, double &real_eigenvalues, double &imag_eigenvalues, PETScWrappers::VectorBase &real_eigenvectors, PETScWrappers::VectorBase &imag_eigenvectors) |
void | set_matrices (const PETScWrappers::MatrixBase &A) |
void | set_matrices (const PETScWrappers::MatrixBase &A, const PETScWrappers::MatrixBase &B) |
An implementation of the solver interface using the SLEPc Power solver. Usage: Largest values of spectrum only, all problem types, complex.
Definition at line 520 of file slepc_solver.h.
SLEPcWrappers::SolverPower::SolverPower | ( | SolverControl & | cn, |
const MPI_Comm & | mpi_communicator = PETSC_COMM_SELF , |
||
const AdditionalData & | data = AdditionalData() |
||
) |
SLEPc solvers will want to have an MPI communicator context over which computations are parallelized. By default, this carries the same behaviour as the PETScWrappers, but you can change that.
Definition at line 393 of file slepc_solver.cc.
|
protected |
Store a copy of the flags for this particular solver.
Definition at line 544 of file slepc_solver.h.