CArl
Code Arlequin / C++ implementation
|
Class containing the operations needed for the FETI solver. More...
#include <FETI_operations.h>
Public Member Functions | |
FETI_Operations (libMesh::Parallel::Communicator &comm, const std::string &scratch_folder_path, const std::string &coupling_folder_path) | |
Constructor with scratch folder path, coupling matrices base filename, and libMesh communicator. More... | |
FETI_Operations (libMesh::Parallel::Communicator &comm, const std::string &scratch_folder_path) | |
Constructor with scratch folder path and libMesh communicator. More... | |
~FETI_Operations () | |
Destructor, deallocates the PETSc. More... | |
void | set_coupling_matrix_R_micro () |
Read the mediator - micro system coupling matrix. More... | |
void | set_coupling_matrix_R_BIG () |
Read the mediator - macro system coupling matrix. More... | |
void | set_coupling_matrix_RR () |
Read the mediator - mediator system coupling matrix. More... | |
void | read_coupling_matrices () |
Read all the coupling matrices. More... | |
void | set_preconditioner (BaseCGPrecondType CG_precond_type, bool bInitialSet=true) |
void | using_rb_modes (bool bUseRigidBodyModes) |
Set up the. More... | |
void | set_null_space (const std::string &input_filename_base, int nb_of_vecs) |
Set and print the null space vectors and matrices. More... | |
void | read_null_space_vecs (const std::string &RB_vectors_base, int nb_of_rb_vectors) |
Read the null space vectors. More... | |
void | read_null_space_inv_RITRI_mat () |
Read the ![]() | |
void | calculate_null_space_phi_0 (const std::string &force_path) |
Calculate the inital solution, ![]() | |
void | read_decoupled_solutions () |
Read the decoupled solutions, ![]() | |
void | read_ext_solver_output () |
Read the latest external solver output. More... | |
void | read_rb_corr () |
Read the rigid body modes correction vector. More... | |
void | read_previous_phi () |
Read the previous Lagrage multiplier / solution. More... | |
void | read_previous_r () |
Read the previous residual. More... | |
void | read_all_previous_p () |
Read all the previous p vectors. More... | |
void | read_all_previous_q () |
Read all the previous q vectors. More... | |
void | read_scalar_data () |
Read the scalar data, rho(0 ... kkk) , | RB_corr(0 ... kkk) | and p(0 ... kkk - 1).q(0 ... kkk - 1) More... | |
void | read_vector_data () |
Read the vector data - essentially calls the "read_previous" and "read_all_previous" methods. More... | |
void | calculate_initial_p () |
Calculate the initial p(0) vector. More... | |
void | calculate_initial_r () |
Calculate the inital residual vector, r(0) More... | |
void | calculate_p () |
Calculate the current p(kkk+1) vector. More... | |
void | calculate_q () |
Calculate the current q(kkk) vector. More... | |
void | calculate_r () |
Calculate the current r(kkk+1) residual vector. More... | |
void | calculate_z () |
Calculate the current z(kkk+1) vector. More... | |
void | calculate_phi () |
Calculate the current phi(kkk+1) solution vector. More... | |
void | calculate_rb_correction () |
Calculate the rigid body modes corrections. More... | |
void | calculate_scalar_data () |
Calculate the scalar quantities. More... | |
void | calculate_coupled_solution () |
Calculate the final coupled solution. More... | |
IterationStatus | check_convergence (double rel_residual_conv, double abs_residual_conv, int max_iter_div, double rel_residual_div, double rb_modes_conv=-1) |
Check the convergence. More... | |
void | increase_iter_counter () |
Increase the iteration counter. More... | |
void | export_ext_solver_rhs_Ct_p () |
Calculate and export the external solver RHS's for the next iteration. More... | |
void | export_ext_solver_rhs_initial () |
Calculate and export the external solver RHS's for the first iteration. More... | |
void | export_ext_solver_rhs_Ct_phi () |
Calculate and export the external solver RHS's for the decoupled problem. More... | |
void | export_rb_correction_vector () |
Export the rigid body modes correction. More... | |
void | export_p () |
Export the current p(kkk+1) vector. More... | |
void | export_q () |
Export the current q(kkk) vector. More... | |
void | export_r () |
Export the current r(kkk+1) residual vector. More... | |
void | export_phi () |
Export the current Lagrange multiplier / solution. More... | |
void | export_inital_vecs () |
Export the initial iteration vectors, r(0) and p(0) More... | |
void | export_initial_scalar_data () |
Export the initial iteration scalar data, rho(0) and | RB_corr(0) | More... | |
void | export_scalar_data () |
Export the iteration scalar data, rho(kkk+1) , | RB_corr(kkk+1) | and p(kkk).q(kkk) More... | |
void | export_iter_vecs () |
void | export_coupled_solution (std::string output_base) |
void | print_previous_iters_conv (int nb_of_iters=5) |
Protected Types | |
enum | { maxVecLimit = 6 } |
Protected Member Functions | |
void | set_inverse_precond_solver () |
Set up the full inversed coupling matrix preconditioner. More... | |
void | set_jacobi_precond_vector () |
Set up the Jacobi coupling matrix preconditioner vector. More... | |
void | read_jacobi_precond_vector () |
Read the Jacobi coupling matrix preconditioner vector. More... | |
void | apply_inverse_coupling_precond (Vec vec_in, Vec vec_out) |
Apply the full inversed coupling matrix preconditioner. More... | |
void | apply_jacobi_coupling_precond (Vec vec_in, Vec vec_out) |
Apply the Jacobi coupling matrix preconditioner vector. More... | |
void | apply_precond (Vec vec_in, Vec vec_out) |
Common interface to the preconditionners. More... | |
void | apply_RB_projection (Vec vec_in, Vec vec_out) |
Apply the rigid body modes projection operation. More... | |
void | export_ext_solver_rhs (Vec vec_in) |
Calculate and export the external solver RHS's. More... | |
void | clear_PETSc () |
PETSc Vec and Mat deallocation, called by the destructor. More... | |
FETI_Operations () | |
Default constructor. More... | |
Protected Attributes | |
libMesh::Parallel::Communicator & | m_comm |
Communicator. More... | |
bool | m_bScratchFolderSet |
Have the scratch folder been set? More... | |
bool | m_bCouplingFolderSet |
Have the Coupling matrices folder been set? More... | |
std::string | m_scratch_folder_path |
Scratch folder path. More... | |
std::string | m_coupling_folder_path |
Coupling matrices path. More... | |
IterationStatus | m_FETI_solver_status |
Current FETI / CG solver status. More... | |
int | m_kkk |
Current iteration index. More... | |
Mat | m_C_R_micro |
Mediator - micro system coupling matrix. More... | |
Mat | m_C_R_BIG |
Mediator - macro system coupling matrix. More... | |
Mat | m_C_RR |
Mediator - mediator system coupling matrix. More... | |
PetscInt | m_C_R_micro_M |
PetscInt | m_C_R_micro_N |
PetscInt | m_C_R_micro_M_local |
PetscInt | m_C_R_micro_N_local |
PetscInt | m_C_R_BIG_M |
PetscInt | m_C_R_BIG_N |
PetscInt | m_C_R_BIG_M_local |
PetscInt | m_C_R_BIG_N_local |
PetscInt | m_C_RR_M |
PetscInt | m_C_RR_M_local |
KSP | m_coupling_precond_solver |
Preconditioner system solver. More... | |
Vec | m_coupling_jacobi_precond_vec |
Preconditioner Jacobi vector. More... | |
bool | m_bC_R_micro_MatrixSet |
Mediator - micro coupling matrix has been set? More... | |
bool | m_bC_R_BIG_MatrixSet |
Mediator - macro coupling matrix has been set? More... | |
bool | m_bC_RR_MatrixSet |
Mediator - mediator coupling matrix has been set? More... | |
bool | m_bCouplingMatricesSet |
All coupling matrices has been set? More... | |
bool | m_bmicro_sizes_set |
Have the micro dimensions been set yet? More... | |
bool | m_bBIG_sizes_set |
Have the macro dimensions been set yet? More... | |
bool | m_bR_sizes_set |
Have the mediator dimensions been set yet? More... | |
BaseCGPrecondType | m_precond_type |
Preconditioner type. Default: BaseCGPrecondType::NO_PRECONDITIONER . More... | |
RBModesSystem | m_RB_modes_system |
Which model is associated to the RB modes? Default: RBModesSystem::MICRO . More... | |
bool | m_bCreatedPrecondSolver |
Have the preconditioner system solver been set? More... | |
bool | m_bCreatedPrecondJacobiVec |
Have the preconditioner system solver been set? More... | |
PetscInt | m_null_nb_vecs |
Number of null space vectors. More... | |
Vec | m_null_vecs [maxVecLimit] |
Null space vectors. More... | |
Vec | m_null_coupled_vecs [maxVecLimit] |
Null space vectors times the coupling matrix. More... | |
PetscInt | m_null_vecs_N |
PetscInt | m_null_vecs_N_local |
Mat | m_RITRI_mat |
Matrix ![]() | |
Mat | m_inv_RITRI_mat |
Matrix ![]() | |
bool | m_bUsingNullVecs |
Do we need to use the null space vectors? More... | |
bool | m_bNullVecsSet |
Have the null space vectors been set? More... | |
bool | m_bNullVecsDimensionsSet |
Have the null space vectors' dimensions been set? More... | |
bool | m_binvRITRIMatSet |
Have the inv(RI^T * RI) matrix been set? More... | |
Vec | m_u_0_micro |
Solution of the decoupled micro model. More... | |
Vec | m_u_0_BIG |
Solution of the decoupled macro model. More... | |
Vec | m_ext_solver_sol_micro |
Micro model external solver solution. More... | |
Vec | m_ext_solver_sol_BIG |
Macro model external solver solution. More... | |
Vec | m_current_residual |
Current residual vector, r(kkk+1) (r(0) for the initialization) More... | |
Vec | m_current_z |
Current z(kkk+1) (z(0) for the initialization) More... | |
Vec | m_current_p |
Current p(kkk+1) (p(0) for the initialization) More... | |
Vec | m_current_phi |
Current Lagrange multipliers / solution, phi(kkk+1) (phi(0) for the initialization) More... | |
Vec | m_current_rb_correction |
Current rigid body modes correction, RB_corr(kkk+1) (RB_corr(0) for the initialization) More... | |
Vec | m_previous_residual |
Previous residual vector, r(kkk) More... | |
Vec | m_previous_phi |
Previous Lagrange multipliers / solution, phi(kkk) More... | |
Vec * | m_previous_p_ptr |
Pointer to the previous p vectors, p(0 ... kkk) More... | |
Vec * | m_previous_q_ptr |
Pointer to the previous q vectors, q(0 ... kkk) More... | |
double | m_gamma |
Double containing the value of rho(kkk) / p(kkk) . q(kkk) More... | |
double | m_rho_0 |
Double containing the initial rho(0) More... | |
double | m_current_rho |
Double containing the current rho(kkk+1) More... | |
double | m_current_RB_mode_corr |
Double containing the current RB_mode_corr(kkk+1) More... | |
double | m_previous_rho |
Double containing the previous rho(kkk) More... | |
double | m_previous_RB_mode_corr |
Double containing the previous RB_mode_corr(kkk) More... | |
bool | m_bSet_u_0 |
Have the u_0 vectors been set? More... | |
bool | m_bSet_ext_solver_sol |
Have the external solvers solutions been set vectors been set? More... | |
bool | m_bSet_current_residual |
Have the current r(kkk+1) vector been set? More... | |
bool | m_bSet_current_z |
Have the current z(kkk+1) vector been set? More... | |
bool | m_bSet_current_p |
Have the current p(kkk+1) vector been set? More... | |
bool | m_bSet_current_phi |
Have the current Lagrange multipliers / solution phi(kkk+1) been set? More... | |
bool | m_bSet_current_RB_correction |
Have the RB modes correction RB_corr(kkk+1) vector been set? More... | |
bool | m_bSet_previous_residual |
Have the previous r(kkk) vector been set? More... | |
bool | m_bSet_previous_phi |
Have the previous Lagrange multipliers / solution phi(kkk) been set? More... | |
bool | m_bSet_previous_p_ptr |
Have the previous p vectors, p(0 ... kkk) , been set? More... | |
bool | m_bSet_previous_q_ptr |
Have the previous q vectors, q(0 ... kkk) , been set? More... | |
std::vector< double > | m_p_dot_q |
Vector containing the p.q scalar products. More... | |
bool | m_bReadPreviousScalar |
Read the previous iterations scalar data? More... | |
bool | m_bCalculatedScalar |
Calculated the current iterations scalar data? More... | |
double | m_abs_residual_conv |
Absolute residual convergence. More... | |
double | m_rel_residual_conv |
Relative residual convergence (relative to initial value) More... | |
double | m_rb_modes_conv |
Relative RB correction convergence (relative to previous value) More... | |
double | m_rel_residual_div |
Relative residual divergence (relative to initial value) More... | |
int | m_max_iter_div |
Number of iterations divergence. More... | |
bool | m_bConvResidualAbs |
The residual converged? (absolute) More... | |
bool | m_bConvResidualRel |
The residual converged? (relative to initial value) More... | |
bool | m_bConvRBCorrRel |
The RB correction converged? (relative to previous value) More... | |
bool | m_bDivResidualRel |
The residual diverged? (relative to initial value) More... | |
bool | m_bDivResidualNeg |
The residual is negative? (more usefull for debugging, really) More... | |
bool | m_bDivIter |
The number of iterations diverged? More... | |
bool | m_bConv |
Did the solver converge? More... | |
bool | m_bDiv |
Did the solver diverge? More... | |
Vec | m_coupled_sol_micro |
Coupled system solution for the micro model. More... | |
Vec | m_coupled_sol_BIG |
Coupled system solution for the macro model. More... | |
bool | m_bCoupled_sols_set |
Have the coupled solutions been set yet? More... | |
Class containing the operations needed for the FETI solver.
This class is used by the several CArl_FETI
programs to do operations of the FETI solver, including matrix and vector I/O and iteration operations. Due to the need to read vectors and matrices and the usage of several PETSc operations for which the libMesh interface was not implemented, direct PETSc Vec
's and Mat
's are used instead of their libMesh interfaces. libMesh's parallel communicators are still used, though.
To avoid any confusion involving the iteration index m_kkk
, it is only changed when reading the previous iterations's scalar data, and is kept constant during an iteration - following the of Alg. 1 in the article.
This class methods' implementations are separated into three different files:
protected
methods).CArl_FETI
programs.Definition at line 36 of file FETI_operations.h.
|
protected |
|
protected |
Default constructor.
|
inline |
Constructor with scratch folder path, coupling matrices base filename, and libMesh communicator.
Definition at line 216 of file FETI_operations.h.
|
inline |
Constructor with scratch folder path and libMesh communicator.
Definition at line 289 of file FETI_operations.h.
|
inline |
Destructor, deallocates the PETSc.
Definition at line 362 of file FETI_operations.h.
|
protected |
Apply the full inversed coupling matrix preconditioner.
Definition at line 57 of file FETI_operations_setup.cpp.
|
protected |
Apply the Jacobi coupling matrix preconditioner vector.
Definition at line 63 of file FETI_operations_setup.cpp.
|
protected |
Common interface to the preconditionners.
Definition at line 69 of file FETI_operations_setup.cpp.
|
protected |
Apply the rigid body modes projection operation.
Definition at line 91 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::calculate_coupled_solution | ( | ) |
Calculate the final coupled solution.
Definition at line 363 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_initial_p | ( | ) |
Calculate the initial p(0)
vector.
Definition at line 78 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_initial_r | ( | ) |
Calculate the inital residual vector, r(0)
Definition at line 84 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_null_space_phi_0 | ( | const std::string & | force_path | ) |
Calculate the inital solution, .
Definition at line 6 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_p | ( | ) |
Calculate the current p(kkk+1)
vector.
Definition at line 137 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_phi | ( | ) |
Calculate the current phi(kkk+1)
solution vector.
Definition at line 266 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_q | ( | ) |
Calculate the current q(kkk)
vector.
Definition at line 163 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_r | ( | ) |
Calculate the current r(kkk+1)
residual vector.
Definition at line 175 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_rb_correction | ( | ) |
Calculate the rigid body modes corrections.
Definition at line 285 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_scalar_data | ( | ) |
Calculate the scalar quantities.
Definition at line 334 of file FETI_operations_operations.cpp.
void carl::FETI_Operations::calculate_z | ( | ) |
Calculate the current z(kkk+1)
vector.
Definition at line 191 of file FETI_operations_operations.cpp.
IterationStatus carl::FETI_Operations::check_convergence | ( | double | rel_residual_conv, |
double | abs_residual_conv, | ||
int | max_iter_div, | ||
double | rel_residual_div, | ||
double | rb_modes_conv = -1 |
||
) |
Check the convergence.
Definition at line 398 of file FETI_operations_operations.cpp.
|
protected |
PETSc Vec and Mat deallocation, called by the destructor.
Definition at line 167 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::export_coupled_solution | ( | std::string | output_base | ) |
Definition at line 764 of file FETI_operations_IO.cpp.
|
protected |
Calculate and export the external solver RHS's.
Definition at line 137 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::export_ext_solver_rhs_Ct_p | ( | ) |
Calculate and export the external solver RHS's for the next iteration.
Definition at line 510 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_ext_solver_rhs_Ct_phi | ( | ) |
Calculate and export the external solver RHS's for the decoupled problem.
Definition at line 526 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_ext_solver_rhs_initial | ( | ) |
Calculate and export the external solver RHS's for the first iteration.
Definition at line 518 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_inital_vecs | ( | ) |
Export the initial iteration vectors, r(0)
and p(0)
Definition at line 600 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_initial_scalar_data | ( | ) |
Export the initial iteration scalar data, rho(0)
and | RB_corr(0) |
Definition at line 626 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_iter_vecs | ( | ) |
Definition at line 742 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_p | ( | ) |
Export the current p(kkk+1)
vector.
Definition at line 548 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_phi | ( | ) |
Export the current Lagrange multiplier / solution.
Definition at line 587 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_q | ( | ) |
Export the current q(kkk)
vector.
Definition at line 561 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_r | ( | ) |
Export the current r(kkk+1)
residual vector.
Definition at line 574 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_rb_correction_vector | ( | ) |
Export the rigid body modes correction.
Definition at line 534 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::export_scalar_data | ( | ) |
Export the iteration scalar data, rho(kkk+1)
, | RB_corr(kkk+1) |
and p(kkk).q(kkk)
Definition at line 690 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::increase_iter_counter | ( | ) |
Increase the iteration counter.
void carl::FETI_Operations::print_previous_iters_conv | ( | int | nb_of_iters = 5 | ) |
Definition at line 779 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_all_previous_p | ( | ) |
Read all the previous p
vectors.
Definition at line 384 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_all_previous_q | ( | ) |
Read all the previous q
vectors.
Definition at line 404 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_coupling_matrices | ( | ) |
Read all the coupling matrices.
Definition at line 122 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_decoupled_solutions | ( | ) |
Read the decoupled solutions, .
Definition at line 222 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_ext_solver_output | ( | ) |
Read the latest external solver output.
Definition at line 282 of file FETI_operations_IO.cpp.
|
protected |
Read the Jacobi coupling matrix preconditioner vector.
Definition at line 44 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::read_null_space_inv_RITRI_mat | ( | ) |
Read the matrix.
Definition at line 173 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_null_space_vecs | ( | const std::string & | RB_vectors_base, |
int | nb_of_rb_vectors | ||
) |
Read the null space vectors.
Definition at line 131 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_previous_phi | ( | ) |
Read the previous Lagrage multiplier / solution.
Definition at line 356 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_previous_r | ( | ) |
Read the previous residual.
Definition at line 370 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_rb_corr | ( | ) |
Read the rigid body modes correction vector.
Definition at line 342 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_scalar_data | ( | ) |
Read the scalar data, rho(0 ... kkk)
, | RB_corr(0 ... kkk) |
and p(0 ... kkk - 1).q(0 ... kkk - 1)
Definition at line 427 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::read_vector_data | ( | ) |
Read the vector data - essentially calls the "read_previous" and "read_all_previous" methods.
Definition at line 483 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::set_coupling_matrix_R_BIG | ( | ) |
Read the mediator - macro system coupling matrix.
Definition at line 50 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::set_coupling_matrix_R_micro | ( | ) |
Read the mediator - micro system coupling matrix.
Definition at line 6 of file FETI_operations_IO.cpp.
void carl::FETI_Operations::set_coupling_matrix_RR | ( | ) |
Read the mediator - mediator system coupling matrix.
Definition at line 94 of file FETI_operations_IO.cpp.
|
protected |
Set up the full inversed coupling matrix preconditioner.
Definition at line 6 of file FETI_operations_setup.cpp.
|
protected |
Set up the Jacobi coupling matrix preconditioner vector.
Definition at line 17 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::set_null_space | ( | const std::string & | input_filename_base, |
int | nb_of_vecs | ||
) |
Set and print the null space vectors and matrices.
Definition at line 280 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::set_preconditioner | ( | BaseCGPrecondType | CG_precond_type, |
bool | bInitialSet = true |
||
) |
Set the preconditioner type. The boolean bInitialSet
determinates if, in the case of a COUPLING_JACOBI preconditioner, if it will calculate the needed vector (true
) or if it will read it (false
).
Definition at line 241 of file FETI_operations_setup.cpp.
void carl::FETI_Operations::using_rb_modes | ( | bool | bUseRigidBodyModes | ) |
Set up the.
Definition at line 275 of file FETI_operations_setup.cpp.
|
protected |
Absolute residual convergence.
Definition at line 166 of file FETI_operations.h.
|
protected |
Have the macro dimensions been set yet?
Definition at line 79 of file FETI_operations.h.
|
protected |
Mediator - macro coupling matrix has been set?
Definition at line 74 of file FETI_operations.h.
|
protected |
Mediator - micro coupling matrix has been set?
Definition at line 73 of file FETI_operations.h.
|
protected |
Mediator - mediator coupling matrix has been set?
Definition at line 75 of file FETI_operations.h.
|
protected |
Calculated the current iterations scalar data?
Definition at line 163 of file FETI_operations.h.
|
protected |
Did the solver converge?
Definition at line 179 of file FETI_operations.h.
|
protected |
The RB correction converged? (relative to previous value)
Definition at line 175 of file FETI_operations.h.
|
protected |
The residual converged? (absolute)
Definition at line 173 of file FETI_operations.h.
|
protected |
The residual converged? (relative to initial value)
Definition at line 174 of file FETI_operations.h.
|
protected |
Have the coupled solutions been set yet?
Definition at line 186 of file FETI_operations.h.
|
protected |
Have the Coupling matrices folder been set?
Definition at line 43 of file FETI_operations.h.
|
protected |
All coupling matrices has been set?
Definition at line 76 of file FETI_operations.h.
|
protected |
Have the preconditioner system solver been set?
Definition at line 88 of file FETI_operations.h.
|
protected |
Have the preconditioner system solver been set?
Definition at line 87 of file FETI_operations.h.
|
protected |
Did the solver diverge?
Definition at line 180 of file FETI_operations.h.
|
protected |
The number of iterations diverged?
Definition at line 178 of file FETI_operations.h.
|
protected |
The residual is negative? (more usefull for debugging, really)
Definition at line 177 of file FETI_operations.h.
|
protected |
The residual diverged? (relative to initial value)
Definition at line 176 of file FETI_operations.h.
|
protected |
Have the inv(RI^T * RI) matrix been set?
Definition at line 113 of file FETI_operations.h.
|
protected |
Have the micro dimensions been set yet?
Definition at line 78 of file FETI_operations.h.
|
protected |
Have the null space vectors' dimensions been set?
Definition at line 112 of file FETI_operations.h.
|
protected |
Have the null space vectors been set?
Definition at line 111 of file FETI_operations.h.
|
protected |
Have the mediator dimensions been set yet?
Definition at line 80 of file FETI_operations.h.
|
protected |
Read the previous iterations scalar data?
Definition at line 162 of file FETI_operations.h.
|
protected |
Have the scratch folder been set?
Definition at line 42 of file FETI_operations.h.
|
protected |
Have the current p(kkk+1)
vector been set?
Definition at line 149 of file FETI_operations.h.
|
protected |
Have the current Lagrange multipliers / solution phi(kkk+1)
been set?
Definition at line 150 of file FETI_operations.h.
|
protected |
Have the RB modes correction RB_corr(kkk+1)
vector been set?
Definition at line 151 of file FETI_operations.h.
|
protected |
Have the current r(kkk+1)
vector been set?
Definition at line 147 of file FETI_operations.h.
|
protected |
Have the current z(kkk+1)
vector been set?
Definition at line 148 of file FETI_operations.h.
|
protected |
Have the external solvers solutions been set vectors been set?
Definition at line 145 of file FETI_operations.h.
|
protected |
Have the previous p
vectors, p(0 ... kkk)
, been set?
Definition at line 155 of file FETI_operations.h.
|
protected |
Have the previous Lagrange multipliers / solution phi(kkk)
been set?
Definition at line 154 of file FETI_operations.h.
|
protected |
Have the previous q
vectors, q(0 ... kkk)
, been set?
Definition at line 156 of file FETI_operations.h.
|
protected |
Have the previous r(kkk)
vector been set?
Definition at line 153 of file FETI_operations.h.
|
protected |
Have the u_0 vectors been set?
Definition at line 144 of file FETI_operations.h.
|
protected |
Do we need to use the null space vectors?
Definition at line 110 of file FETI_operations.h.
|
protected |
Mediator - macro system coupling matrix.
Definition at line 53 of file FETI_operations.h.
|
protected |
Definition at line 65 of file FETI_operations.h.
|
protected |
Definition at line 65 of file FETI_operations.h.
|
protected |
Definition at line 65 of file FETI_operations.h.
|
protected |
Definition at line 65 of file FETI_operations.h.
|
protected |
Mediator - micro system coupling matrix.
Definition at line 52 of file FETI_operations.h.
|
protected |
Definition at line 64 of file FETI_operations.h.
|
protected |
Definition at line 64 of file FETI_operations.h.
|
protected |
Definition at line 64 of file FETI_operations.h.
|
protected |
Definition at line 64 of file FETI_operations.h.
|
protected |
Mediator - mediator system coupling matrix.
Definition at line 54 of file FETI_operations.h.
|
protected |
Definition at line 66 of file FETI_operations.h.
|
protected |
Definition at line 66 of file FETI_operations.h.
|
protected |
Communicator.
Definition at line 41 of file FETI_operations.h.
|
protected |
Coupled system solution for the macro model.
Definition at line 184 of file FETI_operations.h.
|
protected |
Coupled system solution for the micro model.
Definition at line 183 of file FETI_operations.h.
|
protected |
Coupling matrices path.
Definition at line 45 of file FETI_operations.h.
|
protected |
Preconditioner Jacobi vector.
Definition at line 70 of file FETI_operations.h.
|
protected |
Preconditioner system solver.
Definition at line 69 of file FETI_operations.h.
|
protected |
Current p(kkk+1)
(p(0)
for the initialization)
Definition at line 125 of file FETI_operations.h.
|
protected |
Current Lagrange multipliers / solution, phi(kkk+1)
(phi(0)
for the initialization)
Definition at line 127 of file FETI_operations.h.
|
protected |
Current rigid body modes correction, RB_corr(kkk+1)
(RB_corr(0)
for the initialization)
Definition at line 128 of file FETI_operations.h.
|
protected |
Double containing the current RB_mode_corr(kkk+1)
Definition at line 139 of file FETI_operations.h.
|
protected |
Current residual vector, r(kkk+1)
(r(0)
for the initialization)
Definition at line 123 of file FETI_operations.h.
|
protected |
Double containing the current rho(kkk+1)
Definition at line 138 of file FETI_operations.h.
|
protected |
Current z(kkk+1)
(z(0)
for the initialization)
Definition at line 124 of file FETI_operations.h.
|
protected |
Macro model external solver solution.
Definition at line 121 of file FETI_operations.h.
|
protected |
Micro model external solver solution.
Definition at line 120 of file FETI_operations.h.
|
protected |
Current FETI / CG solver status.
Definition at line 46 of file FETI_operations.h.
|
protected |
Double containing the value of rho(kkk) / p(kkk) . q(kkk)
Definition at line 136 of file FETI_operations.h.
|
protected |
Matrix , used in some projectors.
Definition at line 107 of file FETI_operations.h.
|
protected |
Current iteration index.
Definition at line 47 of file FETI_operations.h.
|
protected |
Number of iterations divergence.
Definition at line 170 of file FETI_operations.h.
|
protected |
Null space vectors times the coupling matrix.
Definition at line 100 of file FETI_operations.h.
|
protected |
Number of null space vectors.
Definition at line 97 of file FETI_operations.h.
|
protected |
Null space vectors.
Definition at line 99 of file FETI_operations.h.
|
protected |
Definition at line 103 of file FETI_operations.h.
|
protected |
Definition at line 103 of file FETI_operations.h.
|
protected |
Vector containing the p.q
scalar products.
Definition at line 159 of file FETI_operations.h.
|
protected |
Preconditioner type. Default: BaseCGPrecondType::NO_PRECONDITIONER
.
Definition at line 82 of file FETI_operations.h.
|
protected |
Pointer to the previous p
vectors, p(0 ... kkk)
Definition at line 132 of file FETI_operations.h.
|
protected |
Previous Lagrange multipliers / solution, phi(kkk)
Definition at line 131 of file FETI_operations.h.
|
protected |
Pointer to the previous q
vectors, q(0 ... kkk)
Definition at line 133 of file FETI_operations.h.
|
protected |
Double containing the previous RB_mode_corr(kkk)
Definition at line 141 of file FETI_operations.h.
|
protected |
Previous residual vector, r(kkk)
Definition at line 130 of file FETI_operations.h.
|
protected |
Double containing the previous rho(kkk)
Definition at line 140 of file FETI_operations.h.
|
protected |
Relative RB correction convergence (relative to previous value)
Definition at line 168 of file FETI_operations.h.
|
protected |
Which model is associated to the RB modes? Default: RBModesSystem::MICRO
.
Definition at line 85 of file FETI_operations.h.
|
protected |
Relative residual convergence (relative to initial value)
Definition at line 167 of file FETI_operations.h.
|
protected |
Relative residual divergence (relative to initial value)
Definition at line 169 of file FETI_operations.h.
|
protected |
Double containing the initial rho(0)
Definition at line 137 of file FETI_operations.h.
|
protected |
Matrix .
Definition at line 106 of file FETI_operations.h.
|
protected |
Scratch folder path.
Definition at line 44 of file FETI_operations.h.
|
protected |
Solution of the decoupled macro model.
Definition at line 118 of file FETI_operations.h.
|
protected |
Solution of the decoupled micro model.
Definition at line 117 of file FETI_operations.h.