40 #include "libmesh/linear_solver.h" 41 #include "libmesh/quadrature_gauss.h" 42 #include "libmesh/dense_vector.h" 43 #include "libmesh/boundary_info.h" 44 #include "libmesh/petsc_matrix.h" 45 #include "libmesh/petsc_vector.h" 46 #include "libmesh/petsc_nonlinear_solver.h" 47 #include "libmesh/numeric_vector.h" 48 #include "libmesh/mesh.h" 49 #include "libmesh/dense_subvector.h" 50 #include "libmesh/dense_submatrix.h" 51 #include "libmesh/dof_map.h" 52 #include "libmesh/sparse_matrix.h" 53 #include "libmesh/petsc_matrix.h" 54 #include "libmesh/default_coupling.h" 55 #include "libmesh/diagonal_matrix.h" 56 #include "libmesh/petsc_solver_exception.h" 69 auto & lin_sys = sys.linearImplicitSystem();
70 auto & matrix = *(sys.linearImplicitSystem().matrix);
71 auto & rhs = *(sys.linearImplicitSystem().rhs);
82 _rhs_non_time_tag(-1),
108 const auto & var_names =
_vars[0].names();
109 for (
const auto &
name : var_names)
111 mooseError(
"You are trying to add a nonlinear variable to a linear system! The variable " 112 "which is assigned to the wrong system: ",
118 std::vector<LinearFVElementalKernel *> fv_elemental_kernels;
121 .template condition<AttribSystem>(
"LinearFVElementalKernel")
122 .
template condition<AttribThread>(tid)
125 for (
auto * fv_kernel : fv_elemental_kernels)
126 fv_kernel->initialSetup();
128 std::vector<LinearFVFluxKernel *> fv_flux_kernels;
131 .template condition<AttribSystem>(
"LinearFVFluxKernel")
132 .
template condition<AttribThread>(tid)
135 for (
auto * fv_kernel : fv_flux_kernels)
136 fv_kernel->initialSetup();
142 const std::set<TagID> & matrix_tags,
143 const bool compute_gradients)
145 parallel_object_only();
147 TIME_SECTION(
"LinearSystem::computeLinearSystemTags", 5);
159 _console <<
"Exception detected " << e.
what() << std::endl;
173 TIME_SECTION(
"LinearVariableFV_Gradients", 3 );
183 Threads::parallel_reduce(face_info_range, gradient_face_thread);
198 Threads::parallel_reduce(elem_info_range, gradient_volume_thread);
211 const std::set<TagID> & matrix_tags,
212 const bool compute_gradients)
214 TIME_SECTION(
"computeLinearSystemInternal", 3);
223 for (
auto tag : matrix_tags)
229 LibmeshPetscCall(MatSetOption(petsc_matrix->mat(),
230 MAT_KEEP_NONZERO_PATTERN,
234 MatSetOption(petsc_matrix->mat(), MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE));
238 if (compute_gradients)
244 TIME_SECTION(
"LinearFVKernels_FullSystem", 3 );
256 Threads::parallel_reduce(elem_info_range, elem_thread);
263 Threads::parallel_reduce(face_info_range, face_thread);
292 std::vector<dof_id_type> & ,
293 std::vector<dof_id_type> & )
295 mooseError(
"LinearSystem does not support AugmentSparsity!");
301 TIME_SECTION(
"LinearSystem::solve", 2,
"Solving linear system");
311 auto & linear_solver =
315 _converged = linear_solver.get_converged_reason() > 0;
317 _console <<
"System: " << this->
name() <<
" Initial residual: " << _initial_linear_residual
327 const std::set<TagID> & vector_tags_to_close)
338 std::vector<LinearFVKernel *> kernels;
341 .template condition<AttribSysNum>(this->
number())
342 .
template condition<AttribSystem>(
"LinearFVKernel")
345 bool contains_time_kernel =
false;
346 for (
const auto kernel : kernels)
349 if (contains_time_kernel)
353 return contains_time_kernel;
std::string name(const ElemQuality q)
virtual void stopSolve(const ExecFlagType &exec_flag, const std::set< TagID > &vector_tags_to_close) override
Quit the current solve as soon as possible.
The gradient in a volume using Green Gauss theorem and a cell-centered finite-volume approximation ca...
virtual const char * what() const
Get out the error message.
void computeGradients()
Compute the Green-Gauss gradients.
unsigned int _n_linear_iters
Number of linear iterations.
void checkInvalidSolution()
face_info_iterator ownedFaceInfoBegin()
Iterators to owned faceInfo objects.
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application...
virtual bool containsTimeKernel() override
If the system has a kernel that corresponds to a time derivative.
The gradient in a volume using Green Gauss theorem and a cell-centered finite-volume approximation ca...
NumericVector< Number > & getRightHandSideNonTimeVector()
Return a numeric vector that is associated with the nontime tag.
virtual TagID addVectorTag(const TagName &tag_name, const Moose::VectorTagType type=Moose::VECTOR_TAG_RESIDUAL)
Create a Tag.
std::vector< T * > & queryInto(std::vector< T *> &results, Args &&... args)
queryInto executes the query and stores the results in the given vector.
virtual void associateVectorToTag(NumericVector< Number > &vec, TagID tag)
Associate a vector for a given tag.
void computeLinearSystemInternal(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true)
Compute the right hand side and system matrix for given tags.
virtual void compute(ExecFlagType type) override
Compute time derivatives, auxiliary variables, etc.
void compute_linear_system(libMesh::EquationSystems &es, const std::string &system_name)
NumericVector< Number > * rhs
virtual LinearSolver< Number > * get_linear_solver() const override
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
unsigned int _current_l_its
The linear iterations needed for convergence.
std::vector< std::unique_ptr< NumericVector< Number > > > _raw_grad_container
A cache for storing gradients at dof locations.
Real _initial_linear_residual
The initial linear residual.
Specialization of SubProblem for solving nonlinear equations plus auxiliary equations.
std::vector< std::unique_ptr< NumericVector< Number > > > _new_gradient
Vectors to store the new gradients during the computation.
Scope guard for starting and stopping Floating Point Exception Trapping.
elem_info_iterator ownedElemInfoBegin()
Iterators to owned faceInfo objects.
Adds contributions from volumetric terms discretized using the finite volume method to the matrix and...
virtual void initialSetup() override
Setup Functions.
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
Assemble both the right hand side and the system matrix of a given linear system. ...
virtual const std::string & name() const
void closeTaggedMatrices(const std::set< TagID > &tags)
Close all matrices associated the tags.
void solutionInvalidAccumulation()
Pass the number of solution invalid occurrences from current iteration to cumulative counters...
void syncIteration()
Sync iteration counts to main processor.
libMesh::LinearImplicitSystem & _linear_implicit_system
Base class reference to the linear implicit system in libmesh.
NumericVector< Number > * _rhs_time
right hand side vector for time contributions
const T & get(std::string_view) const
Real final_linear_residual() const
TheWarehouse & theWarehouse() const
unsigned int n_linear_iterations() const
Real _final_linear_residual
The final linear residual.
SolutionInvalidity & solutionInvalidity()
Get the SolutionInvalidity for this app.
virtual TagID addMatrixTag(TagName tag_name)
Create a Tag.
TagID _rhs_tag
Used for the right hand side vector from PETSc.
bool errorOnJacobianNonzeroReallocation() const
Will return True if the user wants to get an error when a nonzero is reallocated in the Jacobian by P...
virtual void activeAllMatrixTags()
Make all exsiting matrices ative.
unsigned int number() const
Gets the number of this system.
void attach_assemble_function(void fptr(EquationSystems &es, const std::string &name))
virtual void solve() override
Solve the system (using libMesh magic)
void closeTaggedVectors(const std::set< TagID > &tags)
Close all vectors for given tags.
Interface for objects interacting with the PerfGraph.
LinearSystem & getLinearSystem(unsigned int sys_num)
Get non-constant reference to a linear system.
Kernel that adds contributions from a time derivative term to a linear system populated using the fin...
TagID _system_matrix_tag
Tag for every contribution to system matrix.
FEProblemBase & _fe_problem
the governing finite element/volume problem
bool _converged
If the solve on the linear system converged.
std::vector< VariableWarehouse > _vars
Variable warehouses (one for each thread)
Provides a way for users to bail out of the current solve.
NumericVector< Number > * _rhs_non_time
right hand side vector for non-time contributions
Class for containing MooseEnum item information.
NumericVector< Number > & getRightHandSideTimeVector()
Return a numeric vector that is associated with the time tag.
virtual libMesh::SparseMatrix< Number > & getMatrix(TagID tag)
Get a raw SparseMatrix.
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
Set the current linear system pointer.
Query query()
query creates and returns an initialized a query object for querying objects from the warehouse...
virtual MooseMesh & mesh() override
unsigned int linearSysNum(const LinearSystemName &linear_sys_name) const override
virtual void augmentSparsity(SparsityPattern::Graph &sparsity, std::vector< dof_id_type > &n_nz, std::vector< dof_id_type > &n_oz) override
Will modify the sparsity pattern to add logical geometric connections.
Adds contributions from face terms discretized using the finite volume method to the matrix and right...
elem_info_iterator ownedElemInfoEnd()
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
const ConsoleStream _console
An instance of helper class to write streams to the Console objects.
face_info_iterator ownedFaceInfoEnd()
MooseVariableFieldBase & getVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a variable of with specified name.
virtual void initialSetup()
Setup Functions.
LinearSystem(FEProblemBase &problem, const std::string &name)
auto index_range(const T &sizable)
virtual System & system() override
Get the reference to the libMesh system.
void computeLinearSystemTags(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true)
Compute the right hand side and the system matrix of the system for given tags.