additional_data | PArpackSolver< VectorType > | protected |
algebraically_largest enum value | PArpackSolver< VectorType > | |
algebraically_smallest enum value | PArpackSolver< VectorType > | |
both_ends enum value | PArpackSolver< VectorType > | |
check_no_subscribers() const noexcept | Subscriptor | private |
control() const | PArpackSolver< VectorType > | |
counter | Subscriptor | mutableprivate |
counter_map | Subscriptor | mutableprivate |
dst | PArpackSolver< VectorType > | protected |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
initial_vector_provided | PArpackSolver< VectorType > | protected |
internal_reinit(const IndexSet &locally_owned_dofs) | PArpackSolver< VectorType > | private |
largest_imaginary_part enum value | PArpackSolver< VectorType > | |
largest_magnitude enum value | PArpackSolver< VectorType > | |
largest_real_part enum value | PArpackSolver< VectorType > | |
ldv | PArpackSolver< VectorType > | protected |
ldz | PArpackSolver< VectorType > | protected |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
local_indices | PArpackSolver< VectorType > | protected |
lworkev | PArpackSolver< VectorType > | protected |
lworkl | PArpackSolver< VectorType > | protected |
map_iterator typedef | Subscriptor | private |
map_value_type typedef | Subscriptor | private |
memory_consumption() const | PArpackSolver< VectorType > | |
mpi_communicator | PArpackSolver< VectorType > | protected |
mpi_communicator_fortran | PArpackSolver< VectorType > | protected |
mutex | Subscriptor | privatestatic |
n_subscriptions() const | Subscriptor | inline |
ncv | PArpackSolver< VectorType > | protected |
nloc | PArpackSolver< VectorType > | protected |
object_info | Subscriptor | mutableprivate |
operator=(const Subscriptor &) | Subscriptor | inline |
operator=(Subscriptor &&) noexcept | Subscriptor | |
PArpackExcConvergedEigenvectors(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcIdo(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInfoMaxIt(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInfoPdnaupd(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInfoPdneupd(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInvalidEigenvalueSize(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInvalidEigenvectorSize(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInvalidEigenvectorSizeNonsymmetric(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInvalidNumberofArnoldiVectors(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcInvalidNumberofEigenvalues(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackExcMode(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcNoShifts(int arg1) | PArpackSolver< VectorType > | privatestatic |
PArpackExcSmallNumberofArnoldiVectors(int arg1, int arg2) | PArpackSolver< VectorType > | privatestatic |
PArpackSolver(SolverControl &control, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData()) | PArpackSolver< VectorType > | |
reinit(const IndexSet &locally_owned_dofs) | PArpackSolver< VectorType > | |
reinit(const IndexSet &locally_owned_dofs, const std::vector< IndexSet > &partitioning) | PArpackSolver< VectorType > | |
reinit(const VectorType &distributed_vector) | PArpackSolver< VectorType > | |
resid | PArpackSolver< VectorType > | protected |
select | PArpackSolver< VectorType > | protected |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set_initial_vector(const VectorType &vec) | PArpackSolver< VectorType > | |
set_shift(const std::complex< double > sigma) | PArpackSolver< VectorType > | |
sigmai | PArpackSolver< VectorType > | protected |
sigmar | PArpackSolver< VectorType > | protected |
size_type typedef | PArpackSolver< VectorType > | |
smallest_imaginary_part enum value | PArpackSolver< VectorType > | |
smallest_magnitude enum value | PArpackSolver< VectorType > | |
smallest_real_part enum value | PArpackSolver< VectorType > | |
solve(const MatrixType1 &A, const MatrixType2 &B, const INVERSE &inverse, std::vector< std::complex< double > > &eigenvalues, std::vector< VectorType > &eigenvectors, const unsigned int n_eigenvalues) | PArpackSolver< VectorType > | |
solve(const MatrixType1 &A, const MatrixType2 &B, const INVERSE &inverse, std::vector< std::complex< double > > &eigenvalues, std::vector< VectorType * > &eigenvectors, const unsigned int n_eigenvalues) | PArpackSolver< VectorType > | |
solver_control | PArpackSolver< VectorType > | protected |
src | PArpackSolver< VectorType > | protected |
subscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
Subscriptor() | Subscriptor | inline |
Subscriptor(const Subscriptor &) | Subscriptor | inline |
Subscriptor(Subscriptor &&) noexcept | Subscriptor | |
tmp | PArpackSolver< VectorType > | protected |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
v | PArpackSolver< VectorType > | protected |
validity_pointers | Subscriptor | mutableprivate |
WhichEigenvalues enum name | PArpackSolver< VectorType > | |
workd | PArpackSolver< VectorType > | protected |
workev | PArpackSolver< VectorType > | protected |
workl | PArpackSolver< VectorType > | protected |
z | PArpackSolver< VectorType > | protected |
~Subscriptor() | Subscriptor | virtual |