amg_mkb/lad_petsc/las_petsc_intf.hpp File Reference
#include <stdlib.h>
#include <stdio.h>
#include <string.h>
#include <math.h>
#include "../../lsd_mkb/amg_ext/amg_ext.h"
#include "AMGSolverStructure.hpp"
#include "ResidualBasedErrorEvaluator.hpp"
#include "KnownSolutionErrorEvaluator.hpp"
#include "GhostBlockExchanger.h"
Go to the source code of this file.
Classes |
struct | AMGSolverData |
Functions |
void | amg_project_solution_to_level (int level_id) |
void | amg_project_solution_from_level (int level_id) |
int | lar_petsc_allocate_SM_and_LV (int Max_SM_size, int Nrblocks, int Nrdof_glob, int *Nrdofbl, int *Posglob, int *Nroffbl, int **L_offbl) |
int | lar_petsc_initialize_SM_and_LV (int Matrix_id, int Comp_type) |
int | lar_petsc_assemble_SM_and_LV (int Matrix_id, int Comp_type, int Nr_dof_bl, int *L_bl_id, int *L_bl_nrdof, double *Stiff_mat, double *Rhs_vect, char *Rewr_dofs) |
int | lar_petsc_fill_preconditioner (int Matrix_id) |
int | lar_petsc_free_SM_and_LV (int Matrix_id) |
void | lar_petsc_perform_BJ_or_GS_iterations (int Matrix_id, int Use_rhs, int Ini_zero, int Nr_prec, int Ndof, double *V, double *B) |
Variables |
struct AMGAlgorithmData | amg_algorithm_data |
struct AMGSolverData | amg_solver_data |
Function Documentation
void amg_project_solution_from_level |
( |
int |
level_id |
) |
|
void amg_project_solution_to_level |
( |
int |
level_id |
) |
|
int lar_petsc_allocate_SM_and_LV |
( |
int |
Max_SM_size, |
|
|
int |
Nrblocks, |
|
|
int |
Nrdof_glob, |
|
|
int * |
Nrdofbl, |
|
|
int * |
Posglob, |
|
|
int * |
Nroffbl, |
|
|
int ** |
L_offbl | |
|
) |
| | |
int lar_petsc_assemble_SM_and_LV |
( |
int |
Matrix_id, |
|
|
int |
Comp_type, |
|
|
int |
Nr_dof_bl, |
|
|
int * |
L_bl_id, |
|
|
int * |
L_bl_nrdof, |
|
|
double * |
Stiff_mat, |
|
|
double * |
Rhs_vect, |
|
|
char * |
Rewr_dofs | |
|
) |
| | |
int lar_petsc_fill_preconditioner |
( |
int |
Matrix_id |
) |
|
int lar_petsc_free_SM_and_LV |
( |
int |
Matrix_id |
) |
|
int lar_petsc_initialize_SM_and_LV |
( |
int |
Matrix_id, |
|
|
int |
Comp_type | |
|
) |
| | |
void lar_petsc_perform_BJ_or_GS_iterations |
( |
int |
Matrix_id, |
|
|
int |
Use_rhs, |
|
|
int |
Ini_zero, |
|
|
int |
Nr_prec, |
|
|
int |
Ndof, |
|
|
double * |
V, |
|
|
double * |
B | |
|
) |
| | |
Variable Documentation