Evolving towards standard naming and argument conventions.
This commit is contained in:
parent
63ff7dbfc9
commit
1ae2d2244d
@ -25,8 +25,9 @@ HYPRE_PETScMatPilutSolver HYPRE_NewPETScMatPilutSolver(
|
||||
hypre_PETScMatPilutSolverMatrix(solver) = matrix;
|
||||
|
||||
/* DistributedMatrixPilutSolver */
|
||||
hypre_PETScMatPilutSolverDistributedSolver( solver ) =
|
||||
HYPRE_NewDistributedMatrixPilutSolver( comm, NULL );
|
||||
ierr =
|
||||
HYPRE_NewDistributedMatrixPilutSolver( comm, NULL,
|
||||
&( hypre_PETScMatPilutSolverDistributedSolver( solver ) ) );
|
||||
|
||||
/* Return created structure to calling routine */
|
||||
return( (HYPRE_PETScMatPilutSolver) solver );
|
||||
|
||||
@ -25,8 +25,9 @@ HYPRE_PETScMatPilutSolver HYPRE_NewPETScMatPilutSolver(
|
||||
hypre_PETScMatPilutSolverMatrix(solver) = matrix;
|
||||
|
||||
/* DistributedMatrixPilutSolver */
|
||||
hypre_PETScMatPilutSolverDistributedSolver( solver ) =
|
||||
HYPRE_NewDistributedMatrixPilutSolver( comm, NULL );
|
||||
ierr =
|
||||
HYPRE_NewDistributedMatrixPilutSolver( comm, NULL,
|
||||
&( hypre_PETScMatPilutSolverDistributedSolver( solver ) ) );
|
||||
|
||||
/* Return created structure to calling routine */
|
||||
return( (HYPRE_PETScMatPilutSolver) solver );
|
||||
|
||||
@ -6,15 +6,16 @@
|
||||
* HYPRE_NewDistributedMatrixPilutSolver
|
||||
*--------------------------------------------------------------------------*/
|
||||
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver(
|
||||
int HYPRE_NewDistributedMatrixPilutSolver(
|
||||
MPI_Comm comm,
|
||||
HYPRE_DistributedMatrix matrix )
|
||||
HYPRE_DistributedMatrix matrix,
|
||||
HYPRE_DistributedMatrixPilutSolver *new_solver )
|
||||
/* Allocates and Initializes solver structure */
|
||||
{
|
||||
|
||||
hypre_DistributedMatrixPilutSolver *solver;
|
||||
hypre_PilutSolverGlobals *globals;
|
||||
int ierr, nprocs, myid;
|
||||
int ierr=0, nprocs, myid;
|
||||
|
||||
/* Allocate structure for holding solver data */
|
||||
solver = (hypre_DistributedMatrixPilutSolver *)
|
||||
@ -55,8 +56,9 @@ HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver(
|
||||
hypre_DistributedMatrixPilutSolverTol(solver) = 0.000001; /* Drop tolerance for factor */
|
||||
|
||||
/* Return created structure to calling routine */
|
||||
return( (HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
*new_solver = ( (HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
|
||||
return( ierr );
|
||||
}
|
||||
|
||||
/*--------------------------------------------------------------------------
|
||||
|
||||
@ -1,7 +1,7 @@
|
||||
# define P(s) s
|
||||
|
||||
/* HYPRE_DistributedMatrixPilutSolver.c */
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix ));
|
||||
int HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix, HYPRE_DistributedMatrixPilutSolver *solver ));
|
||||
int HYPRE_FreeDistributedMatrixPilutSolver P((HYPRE_DistributedMatrixPilutSolver in_ptr ));
|
||||
int HYPRE_DistributedMatrixPilutSolverInitialize P((HYPRE_DistributedMatrixPilutSolver solver ));
|
||||
int HYPRE_DistributedMatrixPilutSolverSetMatrix P((HYPRE_DistributedMatrixPilutSolver in_ptr , HYPRE_DistributedMatrix matrix ));
|
||||
|
||||
@ -62,7 +62,7 @@ CFLAGS = \
|
||||
-I../utilities\
|
||||
-I.\
|
||||
-I../CI_struct_matrix_vector\
|
||||
-I../PETSc_linear_sovlers/ParILUT\
|
||||
-I../PETSc_linear_solvers/ParILUT\
|
||||
@PETSCINCLUDE@ \
|
||||
${C_COMPILE_FLAGS}\
|
||||
${CINCLUDES}\
|
||||
@ -84,7 +84,7 @@ RANLIB = @RANLIB@
|
||||
# Main rules
|
||||
##################################################################
|
||||
|
||||
lib_HYPRE_DistributedMatrixPilutSolver.a: ${PROTOS} ${OBJS}
|
||||
libHYPRE_DistributedMatrixPilutSolver.a: ${PROTOS} ${OBJS}
|
||||
@echo "Building $@ ... "
|
||||
ar -rcu $@ ${OBJS}
|
||||
@RANLIB@ $@
|
||||
|
||||
@ -22,7 +22,9 @@ int ILUT(DataDistType *ddist, HYPRE_DistributedMatrix matrix, FactorMatType *ldu
|
||||
int dummy_row_ptr[2], *col_ind, size;
|
||||
double *values;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
printf("ILUT, maxnz = %d\n ", maxnz);
|
||||
#endif
|
||||
|
||||
/* Allocate memory for ldu */
|
||||
ldu->lsrowptr = idx_malloc(ddist->ddist_lnrows, "ILUT: ldu->lsrowptr");
|
||||
|
||||
@ -1,7 +1,7 @@
|
||||
# define P(s) s
|
||||
|
||||
/* HYPRE_DistributedMatrixPilutSolver.c */
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix ));
|
||||
int HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix, HYPRE_DistributedMatrixPilutSolver *solver ));
|
||||
int HYPRE_FreeDistributedMatrixPilutSolver P((HYPRE_DistributedMatrixPilutSolver in_ptr ));
|
||||
int HYPRE_DistributedMatrixPilutSolverInitialize P((HYPRE_DistributedMatrixPilutSolver solver ));
|
||||
int HYPRE_DistributedMatrixPilutSolverSetMatrix P((HYPRE_DistributedMatrixPilutSolver in_ptr , HYPRE_DistributedMatrix matrix ));
|
||||
|
||||
@ -57,7 +57,9 @@ void ParILUT(DataDistType *ddist, FactorMatType *ldu,
|
||||
int *perm, *iperm, *newiperm, *newperm;
|
||||
ReduceMatType *rmats[2], nrmat;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ILUT start", globals);
|
||||
#endif
|
||||
|
||||
/* Initialize globals */
|
||||
global_maxnz = gmaxnz;
|
||||
@ -135,7 +137,9 @@ void ParILUT(DataDistType *ddist, FactorMatType *ldu,
|
||||
cinfo.incolind, cinfo.invalues,
|
||||
newperm, newiperm, vrowdist, -1);
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ParILUT done", globals);
|
||||
#endif
|
||||
}
|
||||
|
||||
|
||||
@ -160,7 +164,9 @@ void ComputeCommInfo(ReduceMatType *rmat, CommInfoType *cinfo, int *rowdist,
|
||||
MPI_Status Status ;
|
||||
MPI_Request *index_requests;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ComputeCommInfo", globals);
|
||||
#endif
|
||||
|
||||
rnz = rmat->rmat_rnz;
|
||||
|
||||
@ -316,7 +322,9 @@ int SelectSet(ReduceMatType *rmat, CommInfoType *cinfo,
|
||||
int nnz, snnbr;
|
||||
int *rcolind, *snbrind, *snbrptr, *srowind;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("SelectSet", globals);
|
||||
#endif
|
||||
|
||||
snnbr = cinfo->snnbr;
|
||||
snbrind = cinfo->snbrind;
|
||||
@ -403,7 +411,9 @@ void SendFactoredRows(FactorMatType *ldu, CommInfoType *cinfo,
|
||||
MPI_Status Status;
|
||||
MPI_Request *index_requests, *value_requests ;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("SendFactoredRows", globals);
|
||||
#endif
|
||||
|
||||
snnbr = cinfo->snnbr;
|
||||
snbrind = cinfo->snbrind;
|
||||
@ -537,7 +547,9 @@ void ComputeRmat(FactorMatType *ldu, ReduceMatType *rmat,
|
||||
double *uvalues, *nrm2s, *invalues, *rvalues, *dvalues;
|
||||
double mult, nval, rtol;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ComputeRmat", globals);
|
||||
#endif
|
||||
|
||||
usrowptr = ldu->usrowptr;
|
||||
uerowptr = ldu->uerowptr;
|
||||
@ -710,7 +722,9 @@ void FactorLocal(FactorMatType *ldu, ReduceMatType *rmat,
|
||||
double *uvalues, *nrm2s, *rvalues, *dvalues;
|
||||
double mult, nval, rtol;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("FactorLocal", globals);
|
||||
#endif
|
||||
|
||||
assert( rmat != nrmat );
|
||||
assert( perm != newperm );
|
||||
@ -1171,7 +1185,9 @@ void EraseMap(CommInfoType *cinfo, int *newperm, int nmis,
|
||||
rnbrptr = cinfo->rnbrptr;
|
||||
incolind = cinfo->incolind;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("EraseMap", globals);
|
||||
#endif
|
||||
|
||||
/* clear map of all MIS rows */
|
||||
for (i=ndone; i<ndone+nmis; i++)
|
||||
@ -1209,7 +1225,9 @@ void ParINIT( ReduceMatType *nrmat, CommInfoType *cinfo, int *rowdist,
|
||||
{
|
||||
int i;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ParINIT", globals);
|
||||
#endif
|
||||
|
||||
/* save a global copy of the row distribution */
|
||||
vrowdist = idx_malloc(npes+1, "ParINIT: vrowdist");
|
||||
|
||||
@ -82,7 +82,10 @@ int SerILUT(DataDistType *ddist, HYPRE_DistributedMatrix matrix,
|
||||
hypre_TFree( structural_union );
|
||||
|
||||
nbnd = lnrows - nlocal ;
|
||||
#ifdef HYPRE_DEBUG
|
||||
printf("nbnd = %d, lnrows=%d, nlocal=%d\n", nbnd, lnrows, nlocal );
|
||||
#endif
|
||||
|
||||
ldu->nnodes[0] = nlocal;
|
||||
|
||||
/* myprintf("Nlocal: %d, Nbnd: %d\n", nlocal, nbnd); */
|
||||
|
||||
@ -6,15 +6,16 @@
|
||||
* HYPRE_NewDistributedMatrixPilutSolver
|
||||
*--------------------------------------------------------------------------*/
|
||||
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver(
|
||||
int HYPRE_NewDistributedMatrixPilutSolver(
|
||||
MPI_Comm comm,
|
||||
HYPRE_DistributedMatrix matrix )
|
||||
HYPRE_DistributedMatrix matrix,
|
||||
HYPRE_DistributedMatrixPilutSolver *new_solver )
|
||||
/* Allocates and Initializes solver structure */
|
||||
{
|
||||
|
||||
hypre_DistributedMatrixPilutSolver *solver;
|
||||
hypre_PilutSolverGlobals *globals;
|
||||
int ierr, nprocs, myid;
|
||||
int ierr=0, nprocs, myid;
|
||||
|
||||
/* Allocate structure for holding solver data */
|
||||
solver = (hypre_DistributedMatrixPilutSolver *)
|
||||
@ -55,8 +56,9 @@ HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver(
|
||||
hypre_DistributedMatrixPilutSolverTol(solver) = 0.000001; /* Drop tolerance for factor */
|
||||
|
||||
/* Return created structure to calling routine */
|
||||
return( (HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
*new_solver = ( (HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
|
||||
return( ierr );
|
||||
}
|
||||
|
||||
/*--------------------------------------------------------------------------
|
||||
|
||||
@ -1,7 +1,7 @@
|
||||
# define P(s) s
|
||||
|
||||
/* HYPRE_DistributedMatrixPilutSolver.c */
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix ));
|
||||
int HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix, HYPRE_DistributedMatrixPilutSolver *solver ));
|
||||
int HYPRE_FreeDistributedMatrixPilutSolver P((HYPRE_DistributedMatrixPilutSolver in_ptr ));
|
||||
int HYPRE_DistributedMatrixPilutSolverInitialize P((HYPRE_DistributedMatrixPilutSolver solver ));
|
||||
int HYPRE_DistributedMatrixPilutSolverSetMatrix P((HYPRE_DistributedMatrixPilutSolver in_ptr , HYPRE_DistributedMatrix matrix ));
|
||||
|
||||
@ -62,7 +62,7 @@ CFLAGS = \
|
||||
-I../utilities\
|
||||
-I.\
|
||||
-I../CI_struct_matrix_vector\
|
||||
-I../PETSc_linear_sovlers/ParILUT\
|
||||
-I../PETSc_linear_solvers/ParILUT\
|
||||
@PETSCINCLUDE@ \
|
||||
${C_COMPILE_FLAGS}\
|
||||
${CINCLUDES}\
|
||||
@ -84,7 +84,7 @@ RANLIB = @RANLIB@
|
||||
# Main rules
|
||||
##################################################################
|
||||
|
||||
lib_HYPRE_DistributedMatrixPilutSolver.a: ${PROTOS} ${OBJS}
|
||||
libHYPRE_DistributedMatrixPilutSolver.a: ${PROTOS} ${OBJS}
|
||||
@echo "Building $@ ... "
|
||||
ar -rcu $@ ${OBJS}
|
||||
@RANLIB@ $@
|
||||
|
||||
@ -22,7 +22,9 @@ int ILUT(DataDistType *ddist, HYPRE_DistributedMatrix matrix, FactorMatType *ldu
|
||||
int dummy_row_ptr[2], *col_ind, size;
|
||||
double *values;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
printf("ILUT, maxnz = %d\n ", maxnz);
|
||||
#endif
|
||||
|
||||
/* Allocate memory for ldu */
|
||||
ldu->lsrowptr = idx_malloc(ddist->ddist_lnrows, "ILUT: ldu->lsrowptr");
|
||||
|
||||
@ -1,7 +1,7 @@
|
||||
# define P(s) s
|
||||
|
||||
/* HYPRE_DistributedMatrixPilutSolver.c */
|
||||
HYPRE_DistributedMatrixPilutSolver HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix ));
|
||||
int HYPRE_NewDistributedMatrixPilutSolver P((MPI_Comm comm , HYPRE_DistributedMatrix matrix, HYPRE_DistributedMatrixPilutSolver *solver ));
|
||||
int HYPRE_FreeDistributedMatrixPilutSolver P((HYPRE_DistributedMatrixPilutSolver in_ptr ));
|
||||
int HYPRE_DistributedMatrixPilutSolverInitialize P((HYPRE_DistributedMatrixPilutSolver solver ));
|
||||
int HYPRE_DistributedMatrixPilutSolverSetMatrix P((HYPRE_DistributedMatrixPilutSolver in_ptr , HYPRE_DistributedMatrix matrix ));
|
||||
|
||||
@ -57,7 +57,9 @@ void ParILUT(DataDistType *ddist, FactorMatType *ldu,
|
||||
int *perm, *iperm, *newiperm, *newperm;
|
||||
ReduceMatType *rmats[2], nrmat;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ILUT start", globals);
|
||||
#endif
|
||||
|
||||
/* Initialize globals */
|
||||
global_maxnz = gmaxnz;
|
||||
@ -135,7 +137,9 @@ void ParILUT(DataDistType *ddist, FactorMatType *ldu,
|
||||
cinfo.incolind, cinfo.invalues,
|
||||
newperm, newiperm, vrowdist, -1);
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ParILUT done", globals);
|
||||
#endif
|
||||
}
|
||||
|
||||
|
||||
@ -160,7 +164,9 @@ void ComputeCommInfo(ReduceMatType *rmat, CommInfoType *cinfo, int *rowdist,
|
||||
MPI_Status Status ;
|
||||
MPI_Request *index_requests;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ComputeCommInfo", globals);
|
||||
#endif
|
||||
|
||||
rnz = rmat->rmat_rnz;
|
||||
|
||||
@ -316,7 +322,9 @@ int SelectSet(ReduceMatType *rmat, CommInfoType *cinfo,
|
||||
int nnz, snnbr;
|
||||
int *rcolind, *snbrind, *snbrptr, *srowind;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("SelectSet", globals);
|
||||
#endif
|
||||
|
||||
snnbr = cinfo->snnbr;
|
||||
snbrind = cinfo->snbrind;
|
||||
@ -403,7 +411,9 @@ void SendFactoredRows(FactorMatType *ldu, CommInfoType *cinfo,
|
||||
MPI_Status Status;
|
||||
MPI_Request *index_requests, *value_requests ;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("SendFactoredRows", globals);
|
||||
#endif
|
||||
|
||||
snnbr = cinfo->snnbr;
|
||||
snbrind = cinfo->snbrind;
|
||||
@ -537,7 +547,9 @@ void ComputeRmat(FactorMatType *ldu, ReduceMatType *rmat,
|
||||
double *uvalues, *nrm2s, *invalues, *rvalues, *dvalues;
|
||||
double mult, nval, rtol;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ComputeRmat", globals);
|
||||
#endif
|
||||
|
||||
usrowptr = ldu->usrowptr;
|
||||
uerowptr = ldu->uerowptr;
|
||||
@ -710,7 +722,9 @@ void FactorLocal(FactorMatType *ldu, ReduceMatType *rmat,
|
||||
double *uvalues, *nrm2s, *rvalues, *dvalues;
|
||||
double mult, nval, rtol;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("FactorLocal", globals);
|
||||
#endif
|
||||
|
||||
assert( rmat != nrmat );
|
||||
assert( perm != newperm );
|
||||
@ -1171,7 +1185,9 @@ void EraseMap(CommInfoType *cinfo, int *newperm, int nmis,
|
||||
rnbrptr = cinfo->rnbrptr;
|
||||
incolind = cinfo->incolind;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("EraseMap", globals);
|
||||
#endif
|
||||
|
||||
/* clear map of all MIS rows */
|
||||
for (i=ndone; i<ndone+nmis; i++)
|
||||
@ -1209,7 +1225,9 @@ void ParINIT( ReduceMatType *nrmat, CommInfoType *cinfo, int *rowdist,
|
||||
{
|
||||
int i;
|
||||
|
||||
#ifdef HYPRE_DEBUG
|
||||
PrintLine("ParINIT", globals);
|
||||
#endif
|
||||
|
||||
/* save a global copy of the row distribution */
|
||||
vrowdist = idx_malloc(npes+1, "ParINIT: vrowdist");
|
||||
|
||||
@ -82,7 +82,10 @@ int SerILUT(DataDistType *ddist, HYPRE_DistributedMatrix matrix,
|
||||
hypre_TFree( structural_union );
|
||||
|
||||
nbnd = lnrows - nlocal ;
|
||||
#ifdef HYPRE_DEBUG
|
||||
printf("nbnd = %d, lnrows=%d, nlocal=%d\n", nbnd, lnrows, nlocal );
|
||||
#endif
|
||||
|
||||
ldu->nnodes[0] = nlocal;
|
||||
|
||||
/* myprintf("Nlocal: %d, Nbnd: %d\n", nlocal, nbnd); */
|
||||
|
||||
@ -91,8 +91,8 @@ link:
|
||||
lib: $(PROTOS) ${OBJS}
|
||||
@echo "Building $@ ... "
|
||||
@echo "Building ${OBJS} ... "
|
||||
@ar -rcu lib_HYPRE_DistributedMatrix.a ${OBJS}
|
||||
@ranlib lib_HYPRE_DistributedMatrix.a
|
||||
@ar -rcu libHYPRE_DistributedMatrix.a ${OBJS}
|
||||
@ranlib libHYPRE_DistributedMatrix.a
|
||||
|
||||
##################################################################
|
||||
# Targets
|
||||
|
||||
@ -72,8 +72,8 @@ RANLIB = @RANLIB@
|
||||
|
||||
lib: $(PROTOS) ${OBJS}
|
||||
@echo "Building $@ ... "
|
||||
@ar -rcu lib_HYPRE_MatrixMatrix.a ${OBJS}
|
||||
@ranlib lib_HYPRE_MatrixMatrix.a
|
||||
@ar -rcu libHYPRE_MatrixMatrix.a ${OBJS}
|
||||
@ranlib libHYPRE_MatrixMatrix.a
|
||||
|
||||
${OBJS}: ${HEADERS}
|
||||
|
||||
|
||||
@ -42,7 +42,8 @@ HYPRE_ParCSRPilutCreate( MPI_Comm comm, HYPRE_Solver *solver )
|
||||
{
|
||||
int ierr = 0;
|
||||
|
||||
*solver = (HYPRE_Solver) HYPRE_NewDistributedMatrixPilutSolver( comm, NULL);
|
||||
ierr = HYPRE_NewDistributedMatrixPilutSolver( comm, NULL,
|
||||
(HYPRE_DistributedMatrixPilutSolver *) solver);
|
||||
|
||||
ierr = HYPRE_DistributedMatrixPilutSolverInitialize(
|
||||
(HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
|
||||
@ -42,7 +42,8 @@ HYPRE_ParCSRPilutCreate( MPI_Comm comm, HYPRE_Solver *solver )
|
||||
{
|
||||
int ierr = 0;
|
||||
|
||||
*solver = (HYPRE_Solver) HYPRE_NewDistributedMatrixPilutSolver( comm, NULL);
|
||||
ierr = HYPRE_NewDistributedMatrixPilutSolver( comm, NULL,
|
||||
(HYPRE_DistributedMatrixPilutSolver *) solver);
|
||||
|
||||
ierr = HYPRE_DistributedMatrixPilutSolverInitialize(
|
||||
(HYPRE_DistributedMatrixPilutSolver) solver );
|
||||
|
||||
Loading…
Reference in New Issue
Block a user