Loading [MathJax]/extensions/tex2jax.js
https://mooseframework.inl.gov
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends
NonlinearEigenSystem.C
Go to the documentation of this file.
1 //* This file is part of the MOOSE framework
2 //* https://mooseframework.inl.gov
3 //*
4 //* All rights reserved, see COPYRIGHT for full restrictions
5 //* https://github.com/idaholab/moose/blob/master/COPYRIGHT
6 //*
7 //* Licensed under LGPL 2.1, please see LICENSE for details
8 //* https://www.gnu.org/licenses/lgpl-2.1.html
9 
10 #include "NonlinearEigenSystem.h"
11 
12 // MOOSE includes
13 #include "DirichletBC.h"
14 #include "EigenDirichletBC.h"
15 #include "ArrayDirichletBC.h"
16 #include "EigenArrayDirichletBC.h"
17 #include "EigenProblem.h"
18 #include "IntegratedBC.h"
19 #include "KernelBase.h"
20 #include "NodalBC.h"
21 #include "TimeIntegrator.h"
22 #include "SlepcSupport.h"
23 #include "DGKernelBase.h"
24 #include "ScalarKernelBase.h"
25 #include "MooseVariableScalar.h"
26 #include "ResidualObject.h"
27 
28 #include "libmesh/libmesh_config.h"
29 #include "libmesh/petsc_matrix.h"
30 #include "libmesh/sparse_matrix.h"
31 #include "libmesh/diagonal_matrix.h"
32 #include "libmesh/petsc_shell_matrix.h"
33 #include "libmesh/petsc_solver_exception.h"
34 #include "libmesh/slepc_eigen_solver.h"
35 
36 using namespace libMesh;
37 
38 #ifdef LIBMESH_HAVE_SLEPC
39 
40 namespace Moose
41 {
42 
43 void
44 assemble_matrix(EquationSystems & es, const std::string & system_name)
45 {
46  EigenProblem * p = es.parameters.get<EigenProblem *>("_eigen_problem");
47  CondensedEigenSystem & eigen_system = es.get_system<CondensedEigenSystem>(system_name);
48  NonlinearEigenSystem & eigen_nl =
49  p->getNonlinearEigenSystem(/*nl_sys_num=*/eigen_system.number());
50 
51  // If this is a nonlinear eigenvalue problem,
52  // we do not need to assemble anything
53  if (p->isNonlinearEigenvalueSolver(eigen_nl.number()))
54  {
55  // If you want an efficient eigensolver,
56  // please use PETSc 3.13 or newer.
57  // We need to do an unnecessary assembly,
58  // if you use PETSc that is older than 3.13.
59 #if PETSC_RELEASE_LESS_THAN(3, 13, 0)
60  if (eigen_system.has_matrix_B())
61  p->computeJacobianTag(*eigen_system.current_local_solution,
62  eigen_system.get_matrix_B(),
63  eigen_nl.eigenMatrixTag());
64 #endif
65  return;
66  }
67 
68 #if !PETSC_RELEASE_LESS_THAN(3, 13, 0)
69  // If we use shell matrices and do not use a shell preconditioning matrix,
70  // we only need to form a preconditioning matrix
71  if (eigen_system.use_shell_matrices() && !eigen_system.use_shell_precond_matrix())
72  {
73  p->computeJacobianTag(*eigen_system.current_local_solution,
74  eigen_system.get_precond_matrix(),
75  eigen_nl.precondMatrixTag());
76  return;
77  }
78 #endif
79  // If it is a linear generalized eigenvalue problem,
80  // we assemble A and B together
81  if (eigen_system.generalized())
82  {
83  p->computeJacobianAB(*eigen_system.current_local_solution,
84  eigen_system.get_matrix_A(),
85  eigen_system.get_matrix_B(),
86  eigen_nl.nonEigenMatrixTag(),
87  eigen_nl.eigenMatrixTag());
88 #if LIBMESH_HAVE_SLEPC
89  if (p->negativeSignEigenKernel())
90  LibmeshPetscCallA(
91  p->comm().get(),
92  MatScale(static_cast<PetscMatrix<Number> &>(eigen_system.get_matrix_B()).mat(), -1.0));
93 #endif
94  return;
95  }
96 
97  // If it is a linear eigenvalue problem, we assemble matrix A
98  {
99  p->computeJacobianTag(*eigen_system.current_local_solution,
100  eigen_system.get_matrix_A(),
101  eigen_nl.nonEigenMatrixTag());
102 
103  return;
104  }
105 }
106 }
107 
108 NonlinearEigenSystem::NonlinearEigenSystem(EigenProblem & eigen_problem, const std::string & name)
110  eigen_problem, eigen_problem.es().add_system<CondensedEigenSystem>(name), name),
111  _eigen_sys(eigen_problem.es().get_system<CondensedEigenSystem>(name)),
112  _eigen_problem(eigen_problem),
113  _solver_configuration(nullptr),
114  _n_eigen_pairs_required(eigen_problem.getNEigenPairsRequired()),
115  _work_rhs_vector_AX(addVector("work_rhs_vector_Ax", false, PARALLEL)),
116  _work_rhs_vector_BX(addVector("work_rhs_vector_Bx", false, PARALLEL)),
117  _precond_matrix_includes_eigen(false),
118  _preconditioner(nullptr),
119  _num_constrained_dofs(0)
120 {
121  SlepcEigenSolver<Number> * solver =
122  cast_ptr<SlepcEigenSolver<Number> *>(_eigen_sys.eigen_solver.get());
123 
124  if (!solver)
125  mooseError("A slepc eigen solver is required");
126 
127  // setup of our class @SlepcSolverConfiguration
129  std::make_unique<SlepcEigenSolverConfiguration>(eigen_problem, *solver, *this);
130 
131  solver->set_solver_configuration(*_solver_configuration);
132 
133  _Ax_tag = eigen_problem.addVectorTag("Ax_tag");
134 
135  _Bx_tag = eigen_problem.addVectorTag("Eigen");
136 
137  _A_tag = eigen_problem.addMatrixTag("A_tag");
138 
139  _B_tag = eigen_problem.addMatrixTag("Eigen");
140 
141  // By default, _precond_tag and _A_tag will share the same
142  // objects. If we want to include eigen contributions to
143  // the preconditioning matrix, and then _precond_tag will
144  // point to part of "B" objects
145  _precond_tag = eigen_problem.addMatrixTag("Eigen_precond");
146 
147  // We do not rely on creating submatrices in the solve routine
149 }
150 
151 void
153 {
154  // If it is an eigen dirichlet boundary condition, we should skip it because their
155  // contributions should be zero. If we do not skip it, preconditioning matrix will
156  // be singular because boundary elements are zero.
157  if (_precond_matrix_includes_eigen && !dynamic_cast<EigenDirichletBC *>(&object) &&
158  !dynamic_cast<EigenArrayDirichletBC *>(&object))
159  object.useMatrixTag(_precond_tag, {});
160 
161  auto & vtags = object.getVectorTags({});
162  auto & mtags = object.getMatrixTags({});
163 
164  const bool eigen = (vtags.find(_Bx_tag) != vtags.end()) || (mtags.find(_B_tag) != mtags.end());
165 
166  if (eigen && !_eigen_sys.generalized())
167  object.mooseError("This object has been marked as contributing to B or Bx but the eigen "
168  "problem type is not a generalized one");
169 
170  // If it is an eigen kernel, mark its variable as eigen
171  if (eigen)
172  {
173  // Note: the object may be on the displaced system
174  auto sys = object.parameters().get<SystemBase *>("_sys");
175  auto vname = object.variable().name();
176  if (hasScalarVariable(vname))
177  sys->getScalarVariable(0, vname).eigen(true);
178  else
179  sys->getVariable(0, vname).eigen(true);
180 
181  // Associate the eigen matrix tag and the vector tag
182  // if this is a eigen kernel
183  object.useMatrixTag(_B_tag, {});
184  object.useVectorTag(_Bx_tag, {});
185  }
186  else
187  {
188  // Noneigen Vector tag
189  object.useVectorTag(_Ax_tag, {});
190  // Noneigen Matrix tag
191  object.useMatrixTag(_A_tag, {});
192  // Noneigen Kernels
193  object.useMatrixTag(_precond_tag, {});
194  }
195 }
196 
197 void
199 {
200  if (!(_num_constrained_dofs = dofMap().n_constrained_dofs()))
201  return;
202 
204  const auto m = cast_int<numeric_index_type>(_eigen_sys.local_non_condensed_dofs_vector.size());
205  auto M = m;
206  _communicator.sum(M);
208  {
209  _eigen_sys.get_condensed_matrix_A().init(M, M, m, m);
210  // A bit ludicrously MatCopy requires the matrix being copied to to be assembled
212  }
214  {
215  _eigen_sys.get_condensed_matrix_B().init(M, M, m, m);
217  }
219  {
222  }
223 }
224 
225 void
227 {
230 }
231 
232 void
234 {
237 }
238 
239 void
241 {
242  const bool presolve_succeeded = preSolve();
243  if (!presolve_succeeded)
244  return;
245 
246  std::unique_ptr<NumericVector<Number>> subvec;
247 
248  // We apply initial guess for only nonlinear solver
250  {
252  {
254  _eigen_sys.set_initial_space(*subvec);
255  }
256  else
258  }
259 
260  const bool time_integrator_solve = std::any_of(_time_integrators.begin(),
261  _time_integrators.end(),
262  [](auto & ti) { return ti->overridesSolve(); });
263  if (time_integrator_solve)
264  mooseAssert(_time_integrators.size() == 1,
265  "If solve is overridden, then there must be only one time integrator");
266 
267  if (time_integrator_solve)
268  _time_integrators.front()->solve();
269  else
270  system().solve();
271 
272  for (auto & ti : _time_integrators)
273  {
274  if (!ti->overridesSolve())
275  ti->setNumIterationsLastSolve();
276  ti->postSolve();
277  }
278 
279  // store eigenvalues
280  unsigned int n_converged_eigenvalues = getNumConvergedEigenvalues();
281 
283 
284  if (_n_eigen_pairs_required < n_converged_eigenvalues)
285  n_converged_eigenvalues = _n_eigen_pairs_required;
286 
287  _eigen_values.resize(n_converged_eigenvalues);
288  for (unsigned int n = 0; n < n_converged_eigenvalues; n++)
290 
291  // Update the solution vector to the active eigenvector
292  if (n_converged_eigenvalues)
294 
297 }
298 
299 void
301 {
302  // Tell libmesh not to close matrices before solve
303  _eigen_sys.get_eigen_solver().set_close_matrix_before_solve(false);
304 
306  {
307  // Condensed Matrix A
309  {
310  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_condensed_matrix_A()).mat();
311 
313  }
314 
315  // Condensed Matrix B
317  {
318  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_condensed_matrix_B()).mat();
319 
321  }
322 
323  // Condensed Preconditioning matrix
325  {
326  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_condensed_precond_matrix()).mat();
327 
329  }
330  }
331  else
332  {
333  // Matrix A
334  if (_eigen_sys.has_matrix_A())
335  {
336  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_matrix_A()).mat();
337 
339  }
340 
341  // Matrix B
342  if (_eigen_sys.has_matrix_B())
343  {
344  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_matrix_B()).mat();
345 
347  }
348 
349  // Preconditioning matrix
351  {
352  Mat mat = static_cast<PetscMatrix<Number> &>(_eigen_sys.get_precond_matrix()).mat();
353 
355  }
356  }
357 
358  // Shell matrix A
360  {
361  Mat mat = static_cast<PetscShellMatrix<Number> &>(_eigen_sys.get_shell_matrix_A()).mat();
362 
363  // Attach callbacks for nonlinear eigenvalue solver
365 
366  // Set MatMult operations for shell
368  }
369 
370  // Shell matrix B
372  {
373  Mat mat = static_cast<PetscShellMatrix<Number> &>(_eigen_sys.get_shell_matrix_B()).mat();
374 
376 
377  // Set MatMult operations for shell
379  }
380 
381  // Shell preconditioning matrix
383  {
384  Mat mat = static_cast<PetscShellMatrix<Number> &>(_eigen_sys.get_shell_precond_matrix()).mat();
385 
387  }
388 }
389 
390 void
391 NonlinearEigenSystem::stopSolve(const ExecFlagType &, const std::set<TagID> &)
392 {
393  mooseError("did not implement yet \n");
394 }
395 
396 void
398 {
399  mooseError("did not implement yet \n");
400 }
401 
402 bool
404 {
405  return _eigen_sys.get_n_converged();
406 }
407 
408 unsigned int
410 {
411  mooseError("did not implement yet \n");
412  return 0;
413 }
414 
417 {
418  return _work_rhs_vector_BX;
419 }
420 
423 {
424  return _work_rhs_vector_AX;
425 }
426 
429 {
430  return _work_rhs_vector_BX;
431 }
432 
435 {
436  mooseError("did not implement yet \n");
437  return NULL;
438 }
439 
440 SNES
442 {
443  EPS eps = getEPS();
444 
446  {
447  SNES snes = nullptr;
448  LibmeshPetscCall(Moose::SlepcSupport::mooseSlepcEPSGetSNES(eps, &snes));
449  return snes;
450  }
451  else
452  mooseError("There is no SNES in linear eigen solver");
453 }
454 
455 EPS
457 {
458  SlepcEigenSolver<Number> * solver =
459  cast_ptr<SlepcEigenSolver<Number> *>(&(*_eigen_sys.eigen_solver));
460 
461  if (!solver)
462  mooseError("Unable to retrieve eigen solver");
463 
464  return solver->eps();
465 }
466 
467 void
469 {
471  {
472  const auto & nodal_bcs = _nodal_bcs.getActiveObjects();
473  for (const auto & nodal_bc : nodal_bcs)
474  {
475  // If this is a dirichlet boundary condition
476  auto nbc = std::dynamic_pointer_cast<DirichletBC>(nodal_bc);
477  // If this is a eigen Dirichlet boundary condition
478  auto eigen_nbc = std::dynamic_pointer_cast<EigenDirichletBC>(nodal_bc);
479  // ArrayDirichletBC
480  auto anbc = std::dynamic_pointer_cast<ArrayDirichletBC>(nodal_bc);
481  // EigenArrayDirichletBC
482  auto aeigen_nbc = std::dynamic_pointer_cast<EigenArrayDirichletBC>(nodal_bc);
483  // If it is a Dirichlet boundary condition, then value has to be zero
484  if (nbc && nbc->variable().eigen() && nbc->getParam<Real>("value"))
485  mooseError(
486  "Can't set an inhomogeneous Dirichlet boundary condition for eigenvalue problems.");
487  // If it is an array Dirichlet boundary condition, all values should be zero
488  else if (anbc)
489  {
490  auto & values = anbc->getParam<RealEigenVector>("values");
491  for (MooseIndex(values) i = 0; i < values.size(); i++)
492  {
493  if (values(i))
494  mooseError("Can't set an inhomogeneous array Dirichlet boundary condition for "
495  "eigenvalue problems.");
496  }
497  }
498  else if (!nbc && !eigen_nbc && !anbc && !aeigen_nbc)
499  mooseError(
500  "Invalid NodalBC for eigenvalue problems, please use homogeneous (array) Dirichlet.");
501  }
502  }
503 }
504 
505 std::pair<Real, Real>
507 {
508  unsigned int n_converged_eigenvalues = getNumConvergedEigenvalues();
509  if (n >= n_converged_eigenvalues)
510  mooseError(n, " not in [0, ", n_converged_eigenvalues, ")");
511  return _eigen_sys.get_eigenvalue(n);
512 }
513 
514 std::pair<Real, Real>
516 {
517  unsigned int n_converged_eigenvalues = getNumConvergedEigenvalues();
518 
519  if (n >= n_converged_eigenvalues)
520  mooseError(n, " not in [0, ", n_converged_eigenvalues, ")");
521 
522  return _eigen_sys.get_eigenpair(n);
523 }
524 
525 void
527 {
529 
530  // If we have a customized preconditioner,
531  // We need to let PETSc know that
532  if (_preconditioner)
533  {
534  LibmeshPetscCall(Moose::SlepcSupport::registerPCToPETSc());
535  // Mark this, and then we can setup correct petsc options
538  }
539 }
540 
541 void
543 {
544  // Let us do nothing at the current moment
545 }
546 
547 void
549 {
550  mooseError(
551  "NonlinearEigenSystem::residualAndJacobianTogether is not implemented. It might even be "
552  "nonsensical. If it is sensical and you want this capability, please contact a MOOSE "
553  "developer.");
554 }
555 
556 void
558 {
560 }
561 
562 void
564 {
566 }
567 
568 std::set<TagID>
570 {
572  tags.insert(eigenVectorTag());
573  tags.insert(nonEigenVectorTag());
574  return tags;
575 }
576 
577 std::set<TagID>
579 {
581  tags.insert(eigenMatrixTag());
582  tags.insert(nonEigenMatrixTag());
583  return tags;
584 }
585 
586 #else
587 
589  const std::string & /*name*/)
590  : libMesh::ParallelObject(eigen_problem)
591 {
592  mooseError("Need to install SLEPc to solve eigenvalue problems, please reconfigure libMesh\n");
593 }
594 
595 #endif /* LIBMESH_HAVE_SLEPC */
std::string name(const ElemQuality q)
Nonlinear eigenvalue system to be solved.
std::vector< std::shared_ptr< TimeIntegrator > > _time_integrators
Time integrator.
Definition: SystemBase.h:1041
virtual void computeResidualTag(const NumericVector< Number > &soln, NumericVector< Number > &residual, TagID tag) override
Form a vector for all kernels and BCs with a given tag.
Definition: EigenProblem.C:294
const SparseMatrix< Number > & get_precond_matrix() const
NumericVector< Number > & residualVectorAX()
int eps(unsigned int i, unsigned int j)
2D version
std::unique_ptr< SlepcEigenSolverConfiguration > _solver_configuration
unsigned int activeEigenvalueIndex() const
Which eigenvalue is active.
Definition: EigenProblem.h:176
NumericVector< Number > & solution()
Definition: SystemBase.h:195
const SparseMatrix< Number > & get_matrix_A() const
SparseMatrix< Number > & get_condensed_precond_matrix()
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application...
Definition: MooseError.h:302
virtual void postAddResidualObject(ResidualObject &object) override
Called after any ResidualObject-derived objects are added to the system.
TagID nonEigenVectorTag() const
Vector tag ID of left hand side.
const SparseMatrix< Number > & get_matrix_B() const
virtual libMesh::NonlinearSolver< Number > * nonlinearSolver() override
virtual void reinit() override
Reinitialize the system when the degrees of freedom in this system have changed.
TagID eigenVectorTag() const
Vector tag ID of right hand side.
void initializeCondensedMatrices()
Initialize the condensed matrices.
bool has_condensed_precond_matrix() const
MooseObjectTagWarehouse< NodalBCBase > _nodal_bcs
std::set< TagID > defaultVectorTags() const override
Get the default vector tags associated with this system.
bool negativeSignEigenKernel() const
A flag indicates if a negative sign is used in eigen kernels.
Definition: EigenProblem.h:57
const Parallel::Communicator & comm() const
NumericVector< Number > & _work_rhs_vector_AX
virtual void postInit() override
std::unique_ptr< T_DEST, T_DELETER > dynamic_pointer_cast(std::unique_ptr< T_SRC, T_DELETER > &src)
These are reworked from https://stackoverflow.com/a/11003103.
std::unique_ptr< libMesh::DiagonalMatrix< Number > > _scaling_matrix
A diagonal matrix used for computing scaling.
bool _customized_pc_for_eigen
Definition: SolverParams.h:29
const Parallel::Communicator & _communicator
void set_initial_space(NumericVector< Number > &initial_space_in)
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
const EigenSolver< Number > & get_eigen_solver() const
Base class for a system (of equations)
Definition: SystemBase.h:84
const T_sys & get_system(std::string_view name) const
NonlinearEigenSystem(EigenProblem &problem, const std::string &name)
NumericVector< Number > & _work_rhs_vector_BX
const ShellMatrix< Number > & get_shell_matrix_A() const
bool isNonlinearEigenvalueSolver(unsigned int eigen_sys_num) const
Definition: EigenProblem.C:675
unsigned int getNumConvergedEigenvalues() const
Get the number of converged eigenvalues.
Nonlinear system to be solved.
virtual const std::string & name() const
Definition: SystemBase.C:1301
unsigned int getNEigenPairsRequired() const
Definition: EigenProblem.h:37
SparseMatrix< Number > & get_condensed_matrix_A()
virtual libMesh::DofMap & dofMap()
Gets writeable reference to the dof map.
Definition: SystemBase.C:1136
virtual EPS getEPS()
Retrieve EPS (SLEPc eigen solver)
libMesh::Preconditioner< Number > * _preconditioner
const T & get(std::string_view) const
const std::vector< std::shared_ptr< T > > & getActiveObjects(THREAD_ID tid=0) const
Retrieve complete vector to the active all/block/boundary restricted objects for a given thread...
virtual void stopSolve(const ExecFlagType &exec_flag, const std::set< TagID > &vector_tags_to_close) override
Quit the current solve as soon as possible.
void attachCallbacksToMat(EigenProblem &eigen_problem, Mat mat, bool eigen)
Attach call backs to mat.
NumericVector< Number > & residualVectorBX()
virtual void turnOffJacobian() override
Turn off the Jacobian (must be called before equation system initialization)
std::pair< Real, Real > getConvergedEigenpair(dof_id_type n) const
Return the Nth converged eigenvalue and copies the respective eigen vector to the solution vector...
Jacobian-Free Newton Krylov.
Definition: MooseTypes.h:839
virtual bool converged() override
Returns the convergence state.
Boundary condition of a Dirichlet type.
Definition: DirichletBC.h:19
Moose::SolveType _type
Definition: SolverParams.h:19
const ShellMatrix< Number > & get_shell_precond_matrix() const
void initialize_condensed_dofs(const std::set< dof_id_type > &global_condensed_dofs_set=std::set< dof_id_type >())
unsigned int number() const
Gets the number of this system.
Definition: SystemBase.C:1130
void assemble_matrix(EquationSystems &es, const std::string &system_name)
virtual std::unique_ptr< NumericVector< T > > get_subvector(const std::vector< numeric_index_type > &)
Set Dirichlet boundary condition for eigenvalue problems.
virtual void setupFiniteDifferencedPreconditioner() override
virtual void solve()
bool has_shell_precond_matrix() const
virtual std::pair< Real, Real > get_eigenvalue(dof_id_type i)
const NumericVector< Number > * _current_solution
solution vector from solver
Definition: SolverSystem.h:105
virtual std::set< TagID > defaultMatrixTags() const
Get the default matrix tags associted with this system.
Definition: SystemBase.h:310
void computeScalingResidual() override
Compute a "residual" for automatic scaling purposes.
virtual void postInit()
Definition: SystemBase.h:162
dof_id_type _num_constrained_dofs
The number of degrees of freedom constrained at the libMesh level, e.g.
virtual unsigned int getCurrentNonlinearIterationNumber() override
Returns the current nonlinear iteration number.
NonlinearEigenSystem & getNonlinearEigenSystem(const unsigned int nl_sys_num)
Definition: EigenProblem.h:299
virtual void close()=0
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
This is the common base class for objects that give residual contributions.
PetscErrorCode mooseSlepcEPSGetSNES(EPS eps, SNES *snes)
Retrieve SNES from EPS.
Class for containing MooseEnum item information.
Definition: MooseEnumItem.h:18
bool hasActiveObjects(THREAD_ID tid=0) const
std::unique_ptr< EigenSolver< Number > > eigen_solver
const ShellMatrix< Number > & get_shell_matrix_B() const
libMesh::CondensedEigenSystem & sys()
void residualAndJacobianTogether() override
Call this method if you want the residual and Jacobian to be computed simultaneously.
virtual std::set< TagID > defaultVectorTags() const
Get the default vector tags associated with this system.
Definition: SystemBase.h:303
virtual SNES getSNES() override
Retrieve snes from slepc eigen solver.
virtual std::pair< Real, Real > get_eigenpair(dof_id_type i) override
TagID eigenMatrixTag() const
Matrix tag ID of right hand side.
std::vector< dof_id_type > local_non_condensed_dofs_vector
void computeScalingJacobian() override
Compute a "Jacobian" for automatic scaling purposes.
virtual void reinit()
Reinitialize the system when the degrees of freedom in this system have changed.
Definition: SystemBase.h:168
SolverParams & solverParams(unsigned int solver_sys_num=0)
Get the solver parameters.
Boundary condition of a Dirichlet type for the eigen side.
void setOperationsForShellMat(EigenProblem &eigen_problem, Mat mat, bool eigen)
Set operations to shell mat.
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
Definition: MooseTypes.h:142
std::pair< Real, Real > getConvergedEigenvalue(dof_id_type n) const
Return the Nth converged eigenvalue.
TagID nonEigenMatrixTag() const
Matrix tag ID of left hand side.
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
SparseMatrix< Number > & get_condensed_matrix_B()
unsigned int get_n_converged() const
bool preSolve()
Perform some steps to get ready for the solver.
Problem for solving eigenvalue problems.
Definition: EigenProblem.h:21
std::vector< std::pair< Real, Real > > _eigen_values
PETSC_EXTERN PetscErrorCode registerPCToPETSc()
Let PETSc know there is a preconditioner.
virtual NumericVector< Number > & RHS() override
unsigned int _n_eigen_pairs_required
virtual void solve() override
Solve the system (using libMesh magic)
virtual bool hasScalarVariable(const std::string &var_name) const
Definition: SystemBase.C:830
libMesh::CondensedEigenSystem & _eigen_sys
Boundary condition of a Dirichlet type.
std::set< TagID > defaultMatrixTags() const override
Get the default matrix tags associted with this system.
libMesh::Preconditioner< Number > * preconditioner() const
void checkIntegrity()
For eigenvalue problems (including standard and generalized), inhomogeneous (Dirichlet or Neumann) bo...
virtual void attachPreconditioner(libMesh::Preconditioner< Number > *preconditioner) override
Attach a customized preconditioner that requires physics knowledge.
void computeJacobianAB(const NumericVector< Number > &soln, SparseMatrix< Number > &jacobianA, SparseMatrix< Number > &jacobianB, TagID tagA, TagID tagB)
Form two Jacobian matrices, where each is associated with one tag, through one element-loop.
Definition: EigenProblem.C:258
virtual void computeJacobianTag(const NumericVector< Number > &soln, SparseMatrix< Number > &jacobian, TagID tag) override
Form a Jacobian matrix for all kernels and BCs with a given tag.
Definition: EigenProblem.C:175
uint8_t dof_id_type
virtual void init(const numeric_index_type m, const numeric_index_type n, const numeric_index_type m_l, const numeric_index_type n_l, const numeric_index_type nnz=30, const numeric_index_type noz=10, const numeric_index_type blocksize=1)=0
virtual void restore_subvector(std::unique_ptr< NumericVector< T >>, const std::vector< numeric_index_type > &)
virtual libMesh::System & system() override
Get the reference to the libMesh system.