mld2p4: mlprec: fixed names of UMF|SLU|SLUD factor routines.

stopcriterion
Salvatore Filippone 17 years ago
parent 77b2c323a3
commit e4298217e8

@ -103,7 +103,7 @@ subroutine mld_dslu_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_dslu_factor(a%m,nzt,& call mld_dslu_fact(a%m,nzt,&
& a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slu_ptr_),info) & a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slu_ptr_),info)
if (info /= 0) then if (info /= 0) then

@ -121,11 +121,11 @@ subroutine mld_dsludist_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_dsludist_factor(mglob,nrow,nzt,ifrst,& call mld_dsludist_fact(mglob,nrow,nzt,ifrst,&
& a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slud_ptr_),& & a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slud_ptr_),&
& npr, npc, info) & npr, npc, info)
if (info /= 0) then if (info /= 0) then
ch_err='psb_slud_fact' ch_err='psb_sludist_fact'
call psb_errpush(4110,name,a_err=ch_err,i_err=(/info,0,0,0,0/)) call psb_errpush(4110,name,a_err=ch_err,i_err=(/info,0,0,0,0/))
goto 9999 goto 9999
end if end if

@ -61,7 +61,7 @@
! to be factorized. Note that a is intent(inout), and not only ! to be factorized. Note that a is intent(inout), and not only
! intent(in), since the row and column indices of the matrix ! intent(in), since the row and column indices of the matrix
! stored in a are shifted by -1, and then again by +1, by the ! stored in a are shifted by -1, and then again by +1, by the
! routine mld_dumf_factor, which is an interface to the UMFPACK ! routine mld_dumf_fact, which is an interface to the UMFPACK
! C code performing the factorization. ! C code performing the factorization.
! desc_a - type(psb_desc_type), input. ! desc_a - type(psb_desc_type), input.
! The communication descriptor associated to a. ! The communication descriptor associated to a.
@ -108,7 +108,7 @@ subroutine mld_dumf_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_dumf_factor(a%m,nzt,& call mld_dumf_fact(a%m,nzt,&
& a%aspk,a%ia1,a%ia2,& & a%aspk,a%ia1,a%ia2,&
& p%iprcparm(mld_umf_symptr_),p%iprcparm(mld_umf_numptr_),info) & p%iprcparm(mld_umf_symptr_),p%iprcparm(mld_umf_numptr_),info)

@ -36,7 +36,7 @@
* *
* File: mld_slu_impl.c * File: mld_slu_impl.c
* *
* Functions: mld_dslu_factor_, mld_dslu_solve_, mld_dslu_free_. * Functions: mld_dslu_fact_, mld_dslu_solve_, mld_dslu_free_.
* *
* This file is an interface to the SuperLU routines for sparse factorization and * This file is an interface to the SuperLU routines for sparse factorization and
* solve. It was obtained by modifying the c_fortran_dgssv.c file from the SuperLU * solve. It was obtained by modifying the c_fortran_dgssv.c file from the SuperLU
@ -115,17 +115,17 @@ typedef struct {
#ifdef Add_ #ifdef Add_
#define mld_dslu_factor_ mld_dslu_factor_ #define mld_dslu_fact_ mld_dslu_fact_
#define mld_dslu_solve_ mld_dslu_solve_ #define mld_dslu_solve_ mld_dslu_solve_
#define mld_dslu_free_ mld_dslu_free_ #define mld_dslu_free_ mld_dslu_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_dslu_factor_ mld_dslu_factor__ #define mld_dslu_fact_ mld_dslu_fact__
#define mld_dslu_solve_ mld_dslu_solve__ #define mld_dslu_solve_ mld_dslu_solve__
#define mld_dslu_free_ mld_dslu_free__ #define mld_dslu_free_ mld_dslu_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_dslu_factor_ mld_dslu_factor #define mld_dslu_fact_ mld_dslu_fact
#define mld_dslu_solve_ mld_dslu_solve #define mld_dslu_solve_ mld_dslu_solve
#define mld_dslu_free_ mld_dslu_free #define mld_dslu_free_ mld_dslu_free
#endif #endif
@ -134,7 +134,7 @@ typedef struct {
void void
mld_dslu_factor_(int *n, int *nnz, mld_dslu_fact_(int *n, int *nnz,
double *values, int *rowptr, int *colind, double *values, int *rowptr, int *colind,
#ifdef Have_SLU_ #ifdef Have_SLU_
fptr *f_factors, /* a handle containing the address fptr *f_factors, /* a handle containing the address

@ -36,7 +36,7 @@
* *
* File: mld_slud_impl.c * File: mld_slud_impl.c
* *
* Functions: mld_dsludist_factor_, mld_dsludist_solve_, mld_dsludist_free_. * Functions: mld_dsludist_fact_, mld_dsludist_solve_, mld_dsludist_free_.
* *
* This file is an interface to the SuperLU_dist routines for sparse factorization and * This file is an interface to the SuperLU_dist routines for sparse factorization and
* solve. It was obtained by modifying the c_fortran_dgssv.c file from the SuperLU_dist * solve. It was obtained by modifying the c_fortran_dgssv.c file from the SuperLU_dist
@ -114,17 +114,17 @@ typedef struct {
#ifdef Add_ #ifdef Add_
#define mld_dsludist_factor_ mld_dsludist_factor_ #define mld_dsludist_fact_ mld_dsludist_fact_
#define mld_dsludist_solve_ mld_dsludist_solve_ #define mld_dsludist_solve_ mld_dsludist_solve_
#define mld_dsludist_free_ mld_dsludist_free_ #define mld_dsludist_free_ mld_dsludist_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_dsludist_factor_ mld_dsludist_factor__ #define mld_dsludist_fact_ mld_dsludist_fact__
#define mld_dsludist_solve_ mld_dsludist_solve__ #define mld_dsludist_solve_ mld_dsludist_solve__
#define mld_dsludist_free_ mld_dsludist_free__ #define mld_dsludist_free_ mld_dsludist_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_dsludist_factor_ mld_dsludist_factor #define mld_dsludist_fact_ mld_dsludist_fact
#define mld_dsludist_solve_ mld_dsludist_solve #define mld_dsludist_solve_ mld_dsludist_solve
#define mld_dsludist_free_ mld_dsludist_free #define mld_dsludist_free_ mld_dsludist_free
#endif #endif
@ -133,7 +133,7 @@ typedef struct {
void void
mld_dsludist_factor_(int *n, int *nl, int *nnzl, int *ffstr, mld_dsludist_fact_(int *n, int *nl, int *nnzl, int *ffstr,
double *values, int *rowptr, int *colind, double *values, int *rowptr, int *colind,
#ifdef Have_SLUDist_ #ifdef Have_SLUDist_
fptr *f_factors, /* a handle containing the address fptr *f_factors, /* a handle containing the address
@ -174,7 +174,7 @@ mld_dsludist_factor_(int *n, int *nl, int *nnzl, int *ffstr,
double *ival; double *ival;
trans = NOTRANS; trans = NOTRANS;
/* fprintf(stderr,"Entry to sludist_factor\n"); */ /* fprintf(stderr,"Entry to sludist_fact\n"); */
grid = (gridinfo_t *) SUPERLU_MALLOC(sizeof(gridinfo_t)); grid = (gridinfo_t *) SUPERLU_MALLOC(sizeof(gridinfo_t));
superlu_gridinit(MPI_COMM_WORLD, *nprow, *npcol, grid); superlu_gridinit(MPI_COMM_WORLD, *nprow, *npcol, grid);
/* Initialize the statistics variables. */ /* Initialize the statistics variables. */

@ -36,7 +36,7 @@
* *
* File: mld_umf_impl.c * File: mld_umf_impl.c
* *
* Functions: mld_dumf_factor_, mld_dumf_solve_, mld_umf_free_. * Functions: mld_dumf_fact_, mld_dumf_solve_, mld_umf_free_.
* *
* This file is an interface to the UMFPACK routines for sparse factorization and * This file is an interface to the UMFPACK routines for sparse factorization and
* solve. It was obtained by adapting umfpack_di_demo under the original UMFPACK * solve. It was obtained by adapting umfpack_di_demo under the original UMFPACK
@ -76,17 +76,17 @@ Availability:
#ifdef Add_ #ifdef Add_
#define mld_dumf_factor_ mld_dumf_factor_ #define mld_dumf_fact_ mld_dumf_fact_
#define mld_dumf_solve_ mld_dumf_solve_ #define mld_dumf_solve_ mld_dumf_solve_
#define mld_dumf_free_ mld_dumf_free_ #define mld_dumf_free_ mld_dumf_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_dumf_factor_ mld_dumf_factor__ #define mld_dumf_fact_ mld_dumf_fact__
#define mld_dumf_solve_ mld_dumf_solve__ #define mld_dumf_solve_ mld_dumf_solve__
#define mld_dumf_free_ mld_dumf_free__ #define mld_dumf_free_ mld_dumf_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_dumf_factor_ mld_dumf_factor #define mld_dumf_fact_ mld_dumf_fact
#define mld_dumf_solve_ mld_dumf_solve #define mld_dumf_solve_ mld_dumf_solve
#define mld_dumf_free_ mld_dumf_free #define mld_dumf_free_ mld_dumf_free
#endif #endif
@ -104,7 +104,7 @@ typedef int fptr; /* 32-bit by default */
#endif #endif
void void
mld_dumf_factor_(int *n, int *nnz, mld_dumf_fact_(int *n, int *nnz,
double *values, int *rowind, int *colptr, double *values, int *rowind, int *colptr,
#ifdef Have_UMF_ #ifdef Have_UMF_
fptr *symptr, fptr *symptr,

@ -103,7 +103,7 @@ subroutine mld_zslu_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_zslu_factor(a%m,nzt,& call mld_zslu_fact(a%m,nzt,&
& a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slu_ptr_),info) & a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slu_ptr_),info)
if (info /= 0) then if (info /= 0) then

@ -36,7 +36,7 @@
* *
* File: mld_zslu_impl.c * File: mld_zslu_impl.c
* *
* Functions: mld_zslu_factor_, mld_zslu_solve_, mld_zslu_free_. * Functions: mld_zslu_fact_, mld_zslu_solve_, mld_zslu_free_.
* *
* This file is an interface to the SuperLU routines for sparse factorization and * This file is an interface to the SuperLU routines for sparse factorization and
* solve. It was obtained by modifying the c_fortran_zgssv.c file from the SuperLU * solve. It was obtained by modifying the c_fortran_zgssv.c file from the SuperLU
@ -114,17 +114,17 @@ typedef struct {
#ifdef Add_ #ifdef Add_
#define mld_zslu_factor_ mld_zslu_factor_ #define mld_zslu_fact_ mld_zslu_fact_
#define mld_zslu_solve_ mld_zslu_solve_ #define mld_zslu_solve_ mld_zslu_solve_
#define mld_zslu_free_ mld_zslu_free_ #define mld_zslu_free_ mld_zslu_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_zslu_factor_ mld_zslu_factor__ #define mld_zslu_fact_ mld_zslu_fact__
#define mld_zslu_solve_ mld_zslu_solve__ #define mld_zslu_solve_ mld_zslu_solve__
#define mld_zslu_free_ mld_zslu_free__ #define mld_zslu_free_ mld_zslu_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_zslu_factor_ mld_zslu_factor #define mld_zslu_fact_ mld_zslu_fact
#define mld_zslu_solve_ mld_zslu_solve #define mld_zslu_solve_ mld_zslu_solve
#define mld_zslu_free_ mld_zslu_free #define mld_zslu_free_ mld_zslu_free
#endif #endif
@ -133,7 +133,7 @@ typedef struct {
void void
mld_zslu_factor_(int *n, int *nnz, mld_zslu_fact_(int *n, int *nnz,
#ifdef Have_SLU_ #ifdef Have_SLU_
doublecomplex *values, int *colind, int *rowptr, doublecomplex *values, int *colind, int *rowptr,
fptr *f_factors, /* a handle containing the address fptr *f_factors, /* a handle containing the address

@ -121,11 +121,11 @@ subroutine mld_zsludist_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_zsludist_factor(mglob,nrow,nzt,ifrst,& call mld_zsludist_fact(mglob,nrow,nzt,ifrst,&
& a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slud_ptr_),& & a%aspk,a%ia2,a%ia1,p%iprcparm(mld_slud_ptr_),&
& npr, npc, info) & npr, npc, info)
if (info /= 0) then if (info /= 0) then
ch_err='psb_slud_fact' ch_err='psb_sludist_fact'
call psb_errpush(4110,name,a_err=ch_err,i_err=(/info,0,0,0,0/)) call psb_errpush(4110,name,a_err=ch_err,i_err=(/info,0,0,0,0/))
goto 9999 goto 9999
end if end if

@ -36,7 +36,7 @@
* *
* File: mld_zslud_impl.c * File: mld_zslud_impl.c
* *
* Functions: mld_zsludist_factor_, mld_zsludist_solve_, mld_zsludist_free_. * Functions: mld_zsludist_fact_, mld_zsludist_solve_, mld_zsludist_free_.
* *
* This file is an interface to the SuperLU_dist routines for sparse factorization and * This file is an interface to the SuperLU_dist routines for sparse factorization and
* solve. It was obtained by modifying the c_fortran_zgssv.c file from the SuperLU_dist * solve. It was obtained by modifying the c_fortran_zgssv.c file from the SuperLU_dist
@ -114,17 +114,17 @@ typedef struct {
#ifdef Add_ #ifdef Add_
#define mld_zsludist_factor_ mld_zsludist_factor_ #define mld_zsludist_fact_ mld_zsludist_fact_
#define mld_zsludist_solve_ mld_zsludist_solve_ #define mld_zsludist_solve_ mld_zsludist_solve_
#define mld_zsludist_free_ mld_zsludist_free_ #define mld_zsludist_free_ mld_zsludist_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_zsludist_factor_ mld_zsludist_factor__ #define mld_zsludist_fact_ mld_zsludist_fact__
#define mld_zsludist_solve_ mld_zsludist_solve__ #define mld_zsludist_solve_ mld_zsludist_solve__
#define mld_zsludist_free_ mld_zsludist_free__ #define mld_zsludist_free_ mld_zsludist_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_zsludist_factor_ mld_zsludist_factor #define mld_zsludist_fact_ mld_zsludist_fact
#define mld_zsludist_solve_ mld_zsludist_solve #define mld_zsludist_solve_ mld_zsludist_solve
#define mld_zsludist_free_ mld_zsludist_free #define mld_zsludist_free_ mld_zsludist_free
#endif #endif
@ -133,7 +133,7 @@ typedef struct {
void void
mld_zsludist_factor_(int *n, int *nl, int *nnzl, int *ffstr, mld_zsludist_fact_(int *n, int *nl, int *nnzl, int *ffstr,
#ifdef Have_SLUDist_ #ifdef Have_SLUDist_
doublecomplex *values, int *rowptr, int *colind, doublecomplex *values, int *rowptr, int *colind,
fptr *f_factors, /* a handle containing the address fptr *f_factors, /* a handle containing the address

@ -61,7 +61,7 @@
! to be factorized. Note that a is intent(inout), and not only ! to be factorized. Note that a is intent(inout), and not only
! intent(in), since the row and column indices of the matrix ! intent(in), since the row and column indices of the matrix
! stored in a are shifted by -1, and then again by +1, by the ! stored in a are shifted by -1, and then again by +1, by the
! routine mld_zumf_factor, which is an interface to the UMFPACK ! routine mld_zumf_fact, which is an interface to the UMFPACK
! C code performing the factorization. ! C code performing the factorization.
! desc_a - type(psb_desc_type), input. ! desc_a - type(psb_desc_type), input.
! The communication descriptor associated to a. ! The communication descriptor associated to a.
@ -108,7 +108,7 @@ subroutine mld_zumf_bld(a,desc_a,p,info)
! !
! Compute the LU factorization ! Compute the LU factorization
! !
call mld_zumf_factor(a%m,nzt,& call mld_zumf_fact(a%m,nzt,&
& a%aspk,a%ia1,a%ia2,& & a%aspk,a%ia1,a%ia2,&
& p%iprcparm(mld_umf_symptr_),p%iprcparm(mld_umf_numptr_),info) & p%iprcparm(mld_umf_symptr_),p%iprcparm(mld_umf_numptr_),info)

@ -36,7 +36,7 @@
* *
* File: mld_zumf_impl.c * File: mld_zumf_impl.c
* *
* Functions: mld_zumf_factor_, mld_zumf_solve_, mld_zumf_free_. * Functions: mld_zumf_fact_, mld_zumf_solve_, mld_zumf_free_.
* *
* This file is an interface to the UMFPACK routines for sparse factorization and * This file is an interface to the UMFPACK routines for sparse factorization and
* solve. It was obtained by adapting umfpack_zi_demo under the original UMFPACK * solve. It was obtained by adapting umfpack_zi_demo under the original UMFPACK
@ -76,17 +76,17 @@ Availability:
#ifdef Add_ #ifdef Add_
#define mld_zumf_factor_ mld_zumf_factor_ #define mld_zumf_fact_ mld_zumf_fact_
#define mld_zumf_solve_ mld_zumf_solve_ #define mld_zumf_solve_ mld_zumf_solve_
#define mld_zumf_free_ mld_zumf_free_ #define mld_zumf_free_ mld_zumf_free_
#endif #endif
#ifdef AddDouble_ #ifdef AddDouble_
#define mld_zumf_factor_ mld_zumf_factor__ #define mld_zumf_fact_ mld_zumf_fact__
#define mld_zumf_solve_ mld_zumf_solve__ #define mld_zumf_solve_ mld_zumf_solve__
#define mld_zumf_free_ mld_zumf_free__ #define mld_zumf_free_ mld_zumf_free__
#endif #endif
#ifdef NoChange #ifdef NoChange
#define mld_zumf_factor_ mld_zumf_factor #define mld_zumf_fact_ mld_zumf_fact
#define mld_zumf_solve_ mld_zumf_solve #define mld_zumf_solve_ mld_zumf_solve
#define mld_zumf_free_ mld_zumf_free #define mld_zumf_free_ mld_zumf_free
#endif #endif
@ -104,7 +104,7 @@ typedef int fptr; /* 32-bit by default */
#endif #endif
void void
mld_zumf_factor_(int *n, int *nnz, mld_zumf_fact_(int *n, int *nnz,
double *values, int *rowind, int *colptr, double *values, int *rowind, int *colptr,
#ifdef Have_UMF_ #ifdef Have_UMF_
fptr *symptr, fptr *symptr,

Loading…
Cancel
Save