#include <map>
#include <petscksp.h>
#include <time.h>
#include <math.h>
#include "uth_intf.h"
#include "uth_system.h"
#include "GhostBlockAssemblingUtil.hpp"
#include "AMGSolverStructure.hpp"
#include "ResidualBasedErrorEvaluator.hpp"
#include "KnownSolutionErrorEvaluator.hpp"
#include "las_petsc_intf.hpp"
#include "../../lsd_mkb/lah_intf.h"
#include "ns_supg/MatrixUtil.hpp"
#include "ns_supg/ApproximateInverseOpt.hpp"
#include "ns_supg/VectorTransformationUtil.hpp"
#include "ns_supg/SchurComplement.hpp"
Go to the source code of this file.
Functions | |
int | lsr_ns_supg_ext_petsc_init (int Solver_id, int Parallel, int *Max_num_levels_p, char *Filename, int Max_iter, int Error_type, double Error_tolerance, int Monitoring_level) |
int | lsr_ns_supg_ext_petsc_create_matrix (int Solver_id, int Level_id, int Nrblocks, int Nrdof_glob, int Max_sm_size, int *Nrdofbl, int *Posglob, int *Nroffbl, int **L_offbl) |
int | lsr_ns_supg_ext_petsc_assemble_local_sm (int Solver_id, int Level_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 | lsr_ns_supg_ext_petsc_assemble_local_mm (int Solver_id, int Level_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 | lsr_ns_supg_ext_petsc_fill_precon (int Solver_id, int Level_id) |
int | lsr_ns_supg_ext_petsc_solve (int Solver_id, int Ndof, int Ini_zero, double *X, double *B, int *Nr_iter, double *Toler, int Monitor, double *Conv_rate) |
void | lsr_ns_supg_ext_petsc_compreres (int Solver_id, int Subsystem_id, int Level_id, int Control, int Ini_zero, int Ndof, double *X, double *B, double *V) |
int | lsr_ns_supg_ext_petsc_free_matrix (int Solver_id) |
int | lsr_ns_supg_ext_petsc_clear_matrix (int Solver_id, int Level_id, int Comp_type) |
double | lsr_ns_supg_ext_petsc_compres (int Solver_id, double *X, int Ndof) |
void | lsr_ns_supg_ext_petsc_compres_vector (int Solver_id, int Ndof, double *X, double *B, double *V) |
void | lsr_ns_supg_ext_petsc_get_system (Mat *Avv, Mat *Avp, Mat *Apv, Mat *App, Vec *v, Vec *p) |
Variables | |
struct AMGSolverData | amg_solver_data |
int lsr_ns_supg_ext_petsc_assemble_local_mm | ( | int | Solver_id, | |
int | Level_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 lsr_ns_supg_ext_petsc_assemble_local_sm | ( | int | Solver_id, | |
int | Level_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 lsr_ns_supg_ext_petsc_clear_matrix | ( | int | Solver_id, | |
int | Level_id, | |||
int | Comp_type | |||
) |
void lsr_ns_supg_ext_petsc_compreres | ( | int | Solver_id, | |
int | Subsystem_id, | |||
int | Level_id, | |||
int | Control, | |||
int | Ini_zero, | |||
int | Ndof, | |||
double * | X, | |||
double * | B, | |||
double * | V | |||
) |
double lsr_ns_supg_ext_petsc_compres | ( | int | Solver_id, | |
double * | X, | |||
int | Ndof | |||
) |
void lsr_ns_supg_ext_petsc_compres_vector | ( | int | Solver_id, | |
int | Ndof, | |||
double * | X, | |||
double * | B, | |||
double * | V | |||
) |
int lsr_ns_supg_ext_petsc_create_matrix | ( | int | Solver_id, | |
int | Level_id, | |||
int | Nrblocks, | |||
int | Nrdof_glob, | |||
int | Max_sm_size, | |||
int * | Nrdofbl, | |||
int * | Posglob, | |||
int * | Nroffbl, | |||
int ** | L_offbl | |||
) |
int lsr_ns_supg_ext_petsc_fill_precon | ( | int | Solver_id, | |
int | Level_id | |||
) |
int lsr_ns_supg_ext_petsc_free_matrix | ( | int | Solver_id | ) |
void lsr_ns_supg_ext_petsc_get_system | ( | Mat * | Avv, | |
Mat * | Avp, | |||
Mat * | Apv, | |||
Mat * | App, | |||
Vec * | v, | |||
Vec * | p | |||
) |
int lsr_ns_supg_ext_petsc_init | ( | int | Solver_id, | |
int | Parallel, | |||
int * | Max_num_levels_p, | |||
char * | Filename, | |||
int | Max_iter, | |||
int | Error_type, | |||
double | Error_tolerance, | |||
int | Monitoring_level | |||
) |
int lsr_ns_supg_ext_petsc_solve | ( | int | Solver_id, | |
int | Ndof, | |||
int | Ini_zero, | |||
double * | X, | |||
double * | B, | |||
int * | Nr_iter, | |||
double * | Toler, | |||
int | Monitor, | |||
double * | Conv_rate | |||
) |
struct AMGSolverData amg_solver_data |