![]() |
KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
|
A strategy for solving contact problems using a line search method. More...
#include <line_search_contact_strategy.h>
Public Member Functions | |
KRATOS_CLASS_POINTER_DEFINITION (LineSearchContactStrategy) | |
Pointer definition of LineSearchContactStrategy. More... | |
LineSearchContactStrategy () | |
Default constructor. More... | |
LineSearchContactStrategy (ModelPart &rModelPart, Parameters ThisParameters) | |
Default constructor. (with parameters) More... | |
LineSearchContactStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, IndexType MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false, Parameters ThisParameters=Parameters(R"({})")) | |
LineSearchContactStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, IndexType MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false, Parameters ThisParameters=Parameters(R"({})")) | |
~LineSearchContactStrategy () override=default | |
Input and output | |
std::string | Info () const override |
Turn back information as a string. More... | |
void | PrintInfo (std::ostream &rOStream) const override |
Print information about this object. More... | |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. More... | |
![]() | |
LineSearchStrategy () | |
Default constructor. More... | |
LineSearchStrategy (ModelPart &rModelPart, Parameters ThisParameters) | |
Default constructor. (with parameters) More... | |
LineSearchStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
LineSearchStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
Constructor specifying the builder and solver. More... | |
LineSearchStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
Constructor specifying the builder and solver. More... | |
LineSearchStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, Parameters ThisParameters) | |
LineSearchStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, Parameters ThisParameters) | |
~LineSearchStrategy () override | |
KRATOS_CLASS_POINTER_DEFINITION (LineSearchStrategy) | |
![]() | |
TSystemMatrixType & | GetSystemMatrix () override |
This method returns the LHS matrix. More... | |
TSystemVectorType & | GetSystemVector () override |
This method returns the RHS vector. More... | |
TSystemVectorType & | GetSolutionVector () override |
This method returns the solution vector. More... | |
void | SetKeepSystemConstantDuringIterations (bool Value) |
Set method for the flag mKeepSystemConstantDuringIterations. More... | |
bool | GetKeepSystemConstantDuringIterations () |
Get method for the flag mKeepSystemConstantDuringIterations. More... | |
KRATOS_CLASS_POINTER_DEFINITION (ResidualBasedNewtonRaphsonStrategy) | |
ResidualBasedNewtonRaphsonStrategy () | |
Default constructor. More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart) | |
Default constructor. (with parameters) More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, Parameters ThisParameters) | |
Default constructor. (with parameters) More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
Constructor specifying the builder and solver. More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, int MaxIterations=30, bool CalculateReactions=false, bool ReformDofSetAtEachStep=false, bool MoveMeshFlag=false) | |
Constructor specifying the builder and solver. More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, Parameters Settings) | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, Parameters Settings) | |
Constructor specifying the builder and solver and using Parameters. More... | |
ResidualBasedNewtonRaphsonStrategy (ModelPart &rModelPart, typename TSchemeType::Pointer pScheme, typename TLinearSolver::Pointer pNewLinearSolver, typename TConvergenceCriteriaType::Pointer pNewConvergenceCriteria, typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver, Parameters Settings) | |
Constructor specifying the builder and solver and using Parameters. More... | |
~ResidualBasedNewtonRaphsonStrategy () override | |
Destructor. More... | |
void | SetScheme (typename TSchemeType::Pointer pScheme) |
Set method for the time scheme. More... | |
TSchemeType::Pointer | GetScheme () |
Get method for the time scheme. More... | |
void | SetBuilderAndSolver (typename TBuilderAndSolverType::Pointer pNewBuilderAndSolver) |
Set method for the builder and solver. More... | |
TBuilderAndSolverType::Pointer | GetBuilderAndSolver () |
Get method for the builder and solver. More... | |
void | SetInitializePerformedFlag (bool InitializePerformedFlag=true) |
This method sets the flag mInitializeWasPerformed. More... | |
bool | GetInitializePerformedFlag () |
This method gets the flag mInitializeWasPerformed. More... | |
void | SetCalculateReactionsFlag (bool CalculateReactionsFlag) |
This method sets the flag mCalculateReactionsFlag. More... | |
bool | GetCalculateReactionsFlag () |
This method returns the flag mCalculateReactionsFlag. More... | |
void | SetUseOldStiffnessInFirstIterationFlag (bool UseOldStiffnessInFirstIterationFlag) |
This method sets the flag mFullUpdateFlag. More... | |
bool | GetUseOldStiffnessInFirstIterationFlag () |
This method returns the flag mFullUpdateFlag. More... | |
void | SetReformDofSetAtEachStepFlag (bool Flag) |
This method sets the flag mReformDofSetAtEachStep. More... | |
bool | GetReformDofSetAtEachStepFlag () |
This method returns the flag mReformDofSetAtEachStep. More... | |
void | SetMaxIterationNumber (unsigned int MaxIterationNumber) |
This method sets the flag mMaxIterationNumber. More... | |
unsigned int | GetMaxIterationNumber () |
This method gets the flag mMaxIterationNumber. More... | |
void | SetEchoLevel (int Level) override |
It sets the level of echo for the solving strategy. More... | |
void | Predict () override |
Operation to predict the solution ... if it is not called a trivial predictor is used in which the values of the solution step of interest are assumed equal to the old values. More... | |
void | Initialize () override |
Initialization of member variables and prior operations. More... | |
void | Clear () override |
Clears the internal storage. More... | |
bool | IsConverged () override |
This should be considered as a "post solution" convergence check which is useful for coupled analysis - the convergence criteria used is the one used inside the "solve" step. More... | |
void | CalculateOutputData () override |
This operations should be called before printing the results when non trivial results (e.g. stresses) Need to be calculated given the solution of the step. More... | |
void | FinalizeSolutionStep () override |
Performs all the required operations that should be done (for each step) after solving the solution step. More... | |
bool | SolveSolutionStep () override |
Solves the current step. This function returns true if a solution has been found, false otherwise. More... | |
int | Check () override |
Function to perform expensive checks. More... | |
![]() | |
ImplicitSolvingStrategy () | |
Default constructor. More... | |
ImplicitSolvingStrategy (ModelPart &rModelPart, Parameters ThisParameters) | |
Default constructor. (with parameters) More... | |
ImplicitSolvingStrategy (ModelPart &rModelPart, bool MoveMeshFlag=false) | |
Default constructor. More... | |
virtual | ~ImplicitSolvingStrategy () |
void | SetRebuildLevel (int Level) override |
This sets the build level. More... | |
int | GetRebuildLevel () const override |
This returns the build level. More... | |
void | SetStiffnessMatrixIsBuilt (const bool StiffnessMatrixIsBuilt) |
This method sets the flag mStiffnessMatrixIsBuilt. More... | |
bool | GetStiffnessMatrixIsBuilt () const |
This method gets the flag mStiffnessMatrixIsBuilt. More... | |
KRATOS_CLASS_POINTER_DEFINITION (ImplicitSolvingStrategy) | |
![]() | |
SolvingStrategy () | |
Default constructor. More... | |
SolvingStrategy (ModelPart &rModelPart, Parameters ThisParameters) | |
Default constructor. (with parameters) More... | |
SolvingStrategy (ModelPart &rModelPart, bool MoveMeshFlag=false) | |
Default constructor. More... | |
virtual | ~SolvingStrategy () |
KRATOS_CLASS_POINTER_DEFINITION (SolvingStrategy) | |
virtual double | Solve () |
The problem of interest is solved. More... | |
int | GetEchoLevel () |
This returns the level of echo for the solving strategy. More... | |
void | SetMoveMeshFlag (bool Flag) |
This function sets the flag that says if the mesh is moved. More... | |
bool | MoveMeshFlag () |
This function returns the flag that says if the mesh is moved. More... | |
bool | GetMoveMeshFlag () |
This function returns the flag that says if the mesh is moved. More... | |
virtual void | MoveMesh () |
This function is designed to move the mesh. More... | |
ModelPart & | GetModelPart () |
Operations to get the pointer to the model. More... | |
const ModelPart & | GetModelPart () const |
Operations to get the pointer to the model. More... | |
virtual double | GetResidualNorm () |
Operations to get the residual norm. More... | |
Protected Member Functions | |
Protected Operations | |
void | InitializeSolutionStep () override |
void | UpdateDatabase (TSystemMatrixType &A, TSystemVectorType &Dx, TSystemVectorType &b, const bool MoveMesh) override |
void | ComputeSplitDx (TSystemVectorType &Dx, TSystemVectorType &DxDisp, TSystemVectorType &DxLM) |
void | ComputeMixedResidual (TSystemVectorType &b, double &normDisp, double &normLM) |
void | ComputeParabola (double &Xmax, double &Xmin, const double rf, const double ro, const double rh) |
void | AssignSettings (const Parameters ThisParameters) override |
This method assigns settings to member variables. More... | |
Protected LifeCycle | |
LineSearchContactStrategy (const LineSearchContactStrategy &Other) | |
![]() | |
void | OverrideDefaultSettingsWithParameters (Parameters &rDefaultSettings, const double MaxIterations, const bool ReformDofSetAtEachStep, const bool CalculateReactions) |
This method overrides the default settings with user provided parameters. More... | |
LineSearchStrategy (const LineSearchStrategy &Other) | |
![]() | |
virtual void | EchoInfo (const unsigned int IterationNumber) |
This method returns the components of the system of equations depending of the echo level. More... | |
virtual void | MaxIterationsExceeded () |
This method prints information after reach the max number of iterations. More... | |
void | WriteDofInfo (std::string FileName, const TSystemVectorType &rDX) |
ResidualBasedNewtonRaphsonStrategy (const ResidualBasedNewtonRaphsonStrategy &Other) | |
Protected Operations | |
![]() | |
virtual Parameters | ValidateAndAssignParameters (Parameters ThisParameters, const Parameters DefaultParameters) const |
This method validate and assign default parameters. More... | |
Protected Attributes | |
Protected member Variables | |
bool | mRecalculateFactor |
![]() | |
TSchemeType::Pointer | mpScheme = nullptr |
TBuilderAndSolverType::Pointer | mpBuilderAndSolver = nullptr |
The pointer to the time scheme employed. More... | |
TConvergenceCriteriaType::Pointer | mpConvergenceCriteria = nullptr |
The pointer to the builder and solver employed. More... | |
TSystemVectorPointerType | mpDx |
The pointer to the convergence criteria employed. More... | |
TSystemVectorPointerType | mpb |
The increment in the solution. More... | |
TSystemMatrixPointerType | mpA |
The RHS vector of the system of equations. More... | |
bool | mReformDofSetAtEachStep |
The LHS matrix of the system of equations. More... | |
bool | mCalculateReactionsFlag |
Flag telling if it is needed or not to compute the reactions. More... | |
bool | mUseOldStiffnessInFirstIteration = false |
Flag telling if a full update of the database will be performed at the first iteration. More... | |
unsigned int | mMaxIterationNumber |
bool | mInitializeWasPerformed |
The maximum number of iterations, 30 by default. More... | |
bool | mKeepSystemConstantDuringIterations |
Flag to set as initialized the strategy. More... | |
![]() | |
int | mRebuildLevel |
bool | mStiffnessMatrixIsBuilt |
The current rebuild level. More... | |
![]() | |
int | mEchoLevel |
Operations | |
SolvingStrategyType::Pointer | Create (ModelPart &rModelPart, Parameters ThisParameters) const override |
Create method. More... | |
Parameters | GetDefaultParameters () const override |
This method returns the defaulr parameters in order to avoid code duplication. More... | |
static std::string | Name () |
Returns the name of the class as used in the settings (snake_case format) More... | |
Additional Inherited Members | |
![]() | |
static std::string | Name () |
Returns the name of the class as used in the settings (snake_case format) More... | |
![]() | |
static std::string | Name () |
Returns the name of the class as used in the settings (snake_case format) More... | |
![]() | |
static std::string | Name () |
Returns the name of the class as used in the settings (snake_case format) More... | |
![]() | |
static std::string | Name () |
Returns the name of the class as used in the settings (snake_case format) More... | |
A strategy for solving contact problems using a line search method.
This class is a specialization of the LineSearchStrategy
class for contact problems. It implements a line search method for solving the contact problem, which involves finding the minimum of a scalar function along a search direction. The search direction is determined by the contact forces, and the scalar function is the norm of the residual vector. The class is templated on the sparse and dense linear algebra spaces, as well as the linear solver used to solve the linear system. It inherits from the LineSearchStrategy
class and adds functionality specific to contact problems.
TSparseSpace | The sparse linear algebra space. |
TDenseSpace | The dense linear algebra space. |
TLinearSolver | The linear solver used to solve the linear system. |
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::BaseType = LineSearchStrategy<TSparseSpace, TDenseSpace, TLinearSolver> |
The base type for the line search strategy.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::ClassType = LineSearchContactStrategy<TSparseSpace, TDenseSpace, TLinearSolver> |
The current class type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::ConditionsArrayType = typename ModelPart::ConditionsContainerType |
Array type for conditions.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::DofsArrayType = typename BaseType::DofsArrayType |
The array type for degrees of freedom.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::IndexType = std::size_t |
Index type definition.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::LocalSystemMatrixType = typename BaseType::LocalSystemMatrixType |
The local system matrix type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::LocalSystemVectorType = typename BaseType::LocalSystemVectorType |
The local system vector type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::NodesArrayType = typename ModelPart::NodesContainerType |
Array type for nodes.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::NRBaseType = ResidualBasedNewtonRaphsonStrategy<TSparseSpace, TDenseSpace, TLinearSolver> |
The base type for the Newton-Raphson strategy.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SolvingStrategyType = SolvingStrategy<TSparseSpace, TDenseSpace> |
The solving strategy type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SparseSpaceType = TSparseSpace |
The sparse space used.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::StrategyBaseType = ImplicitSolvingStrategy<TSparseSpace, TDenseSpace, TLinearSolver> |
The base type for the strategy.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TBuilderAndSolverType = typename BaseType::TBuilderAndSolverType |
The type of the builder and solver.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TConvergenceCriteriaType = ConvergenceCriteria<TSparseSpace, TDenseSpace> |
The base convergence criteria class definition.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TDataType = typename BaseType::TDataType |
The data type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TSchemeType = typename BaseType::TSchemeType |
The scheme type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TSystemMatrixPointerType = typename BaseType::TSystemMatrixPointerType |
Pointer type for the system matrix.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TSystemMatrixType = typename BaseType::TSystemMatrixType |
The sparse matrix type.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TSystemVectorPointerType = typename BaseType::TSystemVectorPointerType |
Pointer type for the system vector.
using Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::TSystemVectorType = typename BaseType::TSystemVectorType |
The dense vector type.
|
inlineexplicit |
Default constructor.
|
inlineexplicit |
Default constructor. (with parameters)
rModelPart | The model part of the problem |
ThisParameters | The configuration parameters |
|
inline |
Default constructor
rModelPart | The model part of the problem |
pScheme | The integration scheme |
pNewLinearSolver | The linear solver employed |
pNewConvergenceCriteria | The convergence criteria employed |
MaxIterationNumber | The maximum number of iterations |
CalculateReactions | The flag for the reaction calculation |
ReformDofSetAtEachStep | The flag that allows to compute the modification of the DOF |
MoveMeshFlag | The flag that allows to move the mesh |
|
inline |
Default constructor
rModelPart | The model part of the problem |
pScheme | The integration scheme |
pNewLinearSolver | The linear solver employed |
pNewConvergenceCriteria | The convergence criteria employed |
MaxIterationNumber | The maximum number of iterations |
CalculateReactions | The flag for the reaction calculation |
ReformDofSetAtEachStep | The flag that allows to compute the modification of the DOF |
MoveMeshFlag | The flag that allows to move the mesh |
|
overridedefault |
Destructor.
|
inlineprotected |
Copy constructor.
|
inlineoverrideprotectedvirtual |
This method assigns settings to member variables.
ThisParameters | Parameters that are assigned to the member variables |
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineprotected |
This method calculates the norm considering one norm for the displacement and other norm for the LM
b | The residual vector |
normDisp | normDisp: The norm of the displacement |
normLM | The norm of the LM |
|
inlineprotected |
This method computes the parabola necessary for the line search
Xmax | The maximal abscissa |
Xmin | The norm of the LM |
rf | The residual norm of the full step |
ro | The residual norm without step |
rh | The residual norm of the half step |
|
inlineprotected |
This method split the vector of increment of DoF in displacement and LM
Dx | The increment of displacements and LM |
DxDisp | The increment of displacements |
DxLM | The increment of LM |
|
inlineoverridevirtual |
Create method.
rModelPart | The model part of the problem |
ThisParameters | The configuration parameters |
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineoverridevirtual |
This method returns the defaulr parameters in order to avoid code duplication.
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineoverrideprotectedvirtual |
Performs all the required operations that should be done (for each step) before solving the solution step. A member variable should be used as a flag to make sure this function is called only once per step.
Reimplemented from Kratos::ResidualBasedNewtonRaphsonStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
Kratos::LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::KRATOS_CLASS_POINTER_DEFINITION | ( | LineSearchContactStrategy< TSparseSpace, TDenseSpace, TLinearSolver > | ) |
Pointer definition of LineSearchContactStrategy.
|
inlinestatic |
Returns the name of the class as used in the settings (snake_case format)
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
inlineoverrideprotectedvirtual |
Here the database is updated
Reimplemented from Kratos::LineSearchStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.
|
protected |