Fixed DIAG preconditioner to use getdiag.

stopcriterion
Salvatore Filippone 17 years ago
parent a7ff60209f
commit 517604ddd7

@ -1,13 +1,13 @@
!!$ !!$
!!$ !!$
!!$ MD2P4 !!$ MLD2P4
!!$ Multilevel Domain Decomposition Parallel Preconditioner Package for PSBLAS !!$ MultiLevel Domain Decomposition Parallel Preconditioners Package
!!$ for !!$ based on PSBLAS (Parallel Sparse BLAS v.2.0)
!!$ Parallel Sparse BLAS v2.0 !!$
!!$ (C) Copyright 2006 Salvatore Filippone University of Rome Tor Vergata !!$ (C) Copyright 2006 Alfredo Buttari University of Rome Tor Vergata
!!$ Alfredo Buttari University of Rome Tor Vergata !!$ Pasqua D'Ambra ICAR-CNR, Naples
!!$ Daniela di Serafino Second University of Naples !!$ Daniela di Serafino Second University of Naples
!!$ Pasqua D'Ambra ICAR-CNR !!$ Salvatore Filippone University of Rome Tor Vergata
!!$ !!$
!!$ Redistribution and use in source and binary forms, with or without !!$ Redistribution and use in source and binary forms, with or without
!!$ modification, are permitted provided that the following conditions !!$ modification, are permitted provided that the following conditions
@ -17,14 +17,14 @@
!!$ 2. Redistributions in binary form must reproduce the above copyright !!$ 2. Redistributions in binary form must reproduce the above copyright
!!$ notice, this list of conditions, and the following disclaimer in the !!$ notice, this list of conditions, and the following disclaimer in the
!!$ documentation and/or other materials provided with the distribution. !!$ documentation and/or other materials provided with the distribution.
!!$ 3. The name of the MD2P4 group or the names of its contributors may !!$ 3. The name of the MLD2P4 group or the names of its contributors may
!!$ not be used to endorse or promote products derived from this !!$ not be used to endorse or promote products derived from this
!!$ software without specific written permission. !!$ software without specific written permission.
!!$ !!$
!!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS !!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS
!!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED !!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED
!!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR !!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
!!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MD2P4 GROUP OR ITS CONTRIBUTORS !!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MLD2P4 GROUP OR ITS CONTRIBUTORS
!!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR !!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR
!!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF !!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF
!!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS !!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS
@ -33,27 +33,48 @@
!!$ ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE !!$ ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
!!$ POSSIBILITY OF SUCH DAMAGE. !!$ POSSIBILITY OF SUCH DAMAGE.
!!$ !!$
!!$ !!$
! File: mld_ddiagsc_bld.f90.
!
! Subroutine: mld_ddiag_bld.
! Version: real.
!
! Builds the diagonal preconditioner corresponding to a given sparse matrix A.
!
! Arguments:
! a - type(<psb_dspmat_type>), input.
! The sparse matrix structure containing the local part of the
! matrix A to be preconditioned.
! desc_a - type(<psb_desc_type>), input.
! The communication descriptor associated to the sparse matrix A.
! p - type(<mld_dbaseprc_type>), input/output.
! The 'base preconditioner' data structure containing the local
! part of the diagonal preconditioner.
! info - integer, output.
! Error code.
!
subroutine mld_ddiag_bld(a,desc_a,p,upd,info) subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
use psb_base_mod use psb_base_mod
use mld_prec_mod, mld_protect_name => mld_ddiag_bld use mld_prec_mod, mld_protect_name => mld_ddiag_bld
Implicit None Implicit None
! Arguments
type(psb_dspmat_type), target :: a type(psb_dspmat_type), target :: a
type(psb_desc_type), intent(in) :: desc_a type(psb_desc_type), intent(in) :: desc_a
type(mld_dbaseprc_type),intent(inout) :: p type(mld_dbaseprc_type),intent(inout) :: p
character, intent(in) :: upd character, intent(in) :: upd
integer, intent(out) :: info integer, intent(out) :: info
! Local variables
! Local scalars Integer :: err, n_row, n_col,I,j,k,ictxt,&
Integer :: err, n_row, n_col,I,ictxt,& & me,np,mglob,lw, err_act
& me,np,mglob, err_act
real(kind(1.d0)),allocatable :: gd(:), work(:)
integer :: int_err(5) integer :: int_err(5)
character :: iupd
logical, parameter :: debug=.false. logical, parameter :: debug=.false.
integer,parameter :: iroot=0,iout=60,ilout=40 integer,parameter :: iroot=0,iout=60,ilout=40
character(len=20) :: name, ch_err character(len=20) :: name, ch_err
if(psb_get_errstatus().ne.0) return if(psb_get_errstatus().ne.0) return
info=0 info=0
@ -72,8 +93,7 @@ subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
if (debug) write(0,*) 'Preconditioner Blacs_gridinfo' if (debug) write(0,*) 'Preconditioner Blacs_gridinfo'
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (debug) write(0,*) 'Precond: Diagonal scaling' if (debug) write(0,*) 'Precond: Diagonal'
! diagonal scaling
call psb_realloc(n_col,p%d,info) call psb_realloc(n_col,p%d,info)
if (info /= 0) then if (info /= 0) then
@ -81,6 +101,9 @@ subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
goto 9999 goto 9999
end if end if
!
! Retrieve the diagonal entries of the matrix A
!
call psb_sp_getdiag(a,p%d,info) call psb_sp_getdiag(a,p%d,info)
if(info /= 0) then if(info /= 0) then
info=4010 info=4010
@ -88,7 +111,9 @@ subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
call psb_errpush(info,name,a_err=ch_err) call psb_errpush(info,name,a_err=ch_err)
goto 9999 goto 9999
end if end if
!
! Copy into p%desc_data the descriptor associated to A
!
call psb_cdcpy(desc_a,p%desc_Data,info) call psb_cdcpy(desc_a,p%desc_Data,info)
if (info /= 0) then if (info /= 0) then
call psb_errpush(4010,name,a_err='psb_cdcpy') call psb_errpush(4010,name,a_err='psb_cdcpy')
@ -96,6 +121,11 @@ subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
end if end if
if (debug) write(ilout+me,*) 'VDIAG ',n_row if (debug) write(ilout+me,*) 'VDIAG ',n_row
!
! The i-th diagonal entry of the preconditioner is set to one if the
! corresponding entry a_ii of the sparse matrix A is zero; otherwise
! it is set to one/a_ii
!
do i=1,n_row do i=1,n_row
if (p%d(i) == dzero) then if (p%d(i) == dzero) then
p%d(i) = done p%d(i) = done
@ -107,12 +137,9 @@ subroutine mld_ddiag_bld(a,desc_a,p,upd,info)
end do end do
if (a%pl(1) /= 0) then if (a%pl(1) /= 0) then
if (info /= 0) then !
info=4025 ! Apply the same row permutation as in the sparse matrix A
call psb_errpush(info,name,i_err=(/n_row,0,0,0,0/),& !
& a_err='real(kind(1.d0))')
goto 9999
end if
call psb_gelp('n',a%pl,p%d,info) call psb_gelp('n',a%pl,p%d,info)
if(info /= 0) then if(info /= 0) then
info=4010 info=4010

@ -1,13 +1,12 @@
!!$ !!$
!!$ !!$ MLD2P4
!!$ MD2P4 !!$ MultiLevel Domain Decomposition Parallel Preconditioners Package
!!$ Multilevel Domain Decomposition Parallel Preconditioner Package for PSBLAS !!$ based on PSBLAS (Parallel Sparse BLAS v.2.0)
!!$ for !!$
!!$ Parallel Sparse BLAS v2.0 !!$ (C) Copyright 2006 Alfredo Buttari University of Rome Tor Vergata
!!$ (C) Copyright 2006 Salvatore Filippone University of Rome Tor Vergata !!$ Pasqua D'Ambra ICAR-CNR, Naples
!!$ Alfredo Buttari University of Rome Tor Vergata !!$ Daniela di Serafino Second University of Naples
!!$ Daniela di Serafino Second University of Naples !!$ Salvatore Filippone University of Rome Tor Vergata
!!$ Pasqua D'Ambra ICAR-CNR
!!$ !!$
!!$ Redistribution and use in source and binary forms, with or without !!$ Redistribution and use in source and binary forms, with or without
!!$ modification, are permitted provided that the following conditions !!$ modification, are permitted provided that the following conditions
@ -17,14 +16,14 @@
!!$ 2. Redistributions in binary form must reproduce the above copyright !!$ 2. Redistributions in binary form must reproduce the above copyright
!!$ notice, this list of conditions, and the following disclaimer in the !!$ notice, this list of conditions, and the following disclaimer in the
!!$ documentation and/or other materials provided with the distribution. !!$ documentation and/or other materials provided with the distribution.
!!$ 3. The name of the MD2P4 group or the names of its contributors may !!$ 3. The name of the MLD2P4 group or the names of its contributors may
!!$ not be used to endorse or promote products derived from this !!$ not be used to endorse or promote products derived from this
!!$ software without specific written permission. !!$ software without specific written permission.
!!$ !!$
!!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS !!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS
!!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED !!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED
!!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR !!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
!!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MD2P4 GROUP OR ITS CONTRIBUTORS !!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MLD2P4 GROUP OR ITS CONTRIBUTORS
!!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR !!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR
!!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF !!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF
!!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS !!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS
@ -33,28 +32,84 @@
!!$ ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE !!$ ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
!!$ POSSIBILITY OF SUCH DAMAGE. !!$ POSSIBILITY OF SUCH DAMAGE.
!!$ !!$
!!$ !!$
! File: mld_dilu_fct.f90.
!
! Subroutine: mld_dilu_fct.
! Version: real.
! Contains: mld_dilu_fctint, ilu_copyin
!
! Computes either the ILU(0) or the MILU(0) factorization of the local part
! of the matrix stored into a. These factorizations are used to build the 'base
! preconditioner' (block-Jacobi preconditioner/solver, Additive Schwarz
! preconditioner) corresponding to a certain level of a multilevel preconditioner.
!
! Details on the above factorizations can be found in
! Y. Saad, Iterative Methods for Sparse Linear Systems, Second Edition,
! SIAM, 2003, Chapter 10.
!
! The local matrix to be factorized is stored into a and blck, as specified in
! the description of the arguments below. The storage must be in CSR format.
! The same format is used for the L and U factors. The diagonal of the U factor
! is stored separately.
!
! This routine copies and factors "on the fly" from a and blck into l (L factor),
! u (U factor, except its diagonal) and d (diagonal of U). This implementation of
! ILU(0) is faster than the implementation in mld_diluk_fct (the latter routine
! performs the more general ILU(n)).
!
!
! Arguments:
! ialg - integer, input.
! The type of incomplete factorization to be performed.
! The MILU(0) factorization is computed if ialg = 2 (= mld_milu_n_);
! the ILU(0) factorization otherwise.
! a - type(<psb_dspmat_type>), input.
! The sparse matrix structure containing the local matrix to be
! factorized. Note that if the 'base' Additive Schwarz preconditioner
! has overlap greater than 0 and the matrix has not been reordered
! (see mld_bjac_bld), then a contains only the 'original' local part
! of the matrix to be factorized, i.e. the rows of the matrix held
! by the calling process according to the initial data distribution.
! l - type(<psb_dspmat_type>), input/output.
! The L factor in the incomplete factorization.
! Note: its allocation is managed by the calling routine mld_ilu_bld,
! hence it cannot be only intent(out).
! u - type(<psb_dspmat_type>), input/output.
! The U factor (except its diagonal) in the incomplete factorization.
! Note: its allocation is managed by the calling routine mld_ilu_bld,
! hence it cannot be only intent(out).
! d - real(kind(1.d0)), dimension(:), input/output.
! The diagonal of the U factor in the incomplete factorization.
! Note: its allocation is managed by the calling routine mld_ilu_bld,
! hence it cannot be only intent(out).
! info - integer, output.
! Error code.
! blck - type(<psb_dspmat_type>), input, optional, target.
! The sparse matrix structure containing the remote rows of the
! matrix to be factorized, that have been retrieved by mld_asmat_bld
! to build an Additive Schwarz base preconditioner with overlap
! greater than 0. If the overlap is 0 or the matrix has been reordered
! (see mld_bjac_bld), then blck is empty.
!
subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck) subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck)
!
! This routine copies and factors "on the fly" from A and BLCK
! into L/D/U.
!
!
use psb_base_mod use psb_base_mod
use mld_prec_mod, mld_protect_name => mld_dilu_fct use mld_prec_mod, mld_protect_name => mld_dilu_fct
implicit none implicit none
! .. Scalar Arguments ..
! Arguments
integer, intent(in) :: ialg integer, intent(in) :: ialg
integer, intent(out) :: info
! .. Array Arguments ..
type(psb_dspmat_type),intent(in) :: a type(psb_dspmat_type),intent(in) :: a
type(psb_dspmat_type),intent(inout) :: l,u type(psb_dspmat_type),intent(inout) :: l,u
real(kind(1.d0)), intent(inout) :: d(:)
integer, intent(out) :: info
type(psb_dspmat_type),intent(in), optional, target :: blck type(psb_dspmat_type),intent(in), optional, target :: blck
real(kind(1.d0)), intent(inout) :: d(:)
! .. Local Scalars .. ! Local variables
integer :: l1, l2, m,err_act real(kind(1.d0)) :: dia, temp
integer :: i, j, jj, k, kk, l1, l2, ll, low1, low2,m,ma,err_act
type(psb_dspmat_type), pointer :: blck_ type(psb_dspmat_type), pointer :: blck_
character(len=20) :: name, ch_err character(len=20) :: name, ch_err
logical, parameter :: debug=.false. logical, parameter :: debug=.false.
@ -62,9 +117,10 @@ subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck)
name='mld_dilu_fct' name='mld_dilu_fct'
info = 0 info = 0
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
! .. Executable Statements ..
!
!
! Point to / allocate memory for the incomplete factorization
!
if (present(blck)) then if (present(blck)) then
blck_ => blck blck_ => blck
else else
@ -74,27 +130,33 @@ subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck)
goto 9999 goto 9999
end if end if
call psb_nullify_sp(blck_) ! Why do we need this? Who knows.... call psb_nullify_sp(blck_) ! Probably pointless.
call psb_sp_all(0,0,blck_,1,info) call psb_sp_all(0,0,blck_,1,info)
if(info.ne.0) then if(info.ne.0) then
info=4010 info=4010
ch_err='psb_sp_all' ch_err='psb_sp_all'
call psb_errpush(info,name,a_err=ch_err) call psb_errpush(info,name,a_err=ch_err)
goto 9999 goto 9999
end if end if
blck_%m=0 blck_%m=0
endif endif
!
! Compute the ILU or the MILU factorization, depending on ialg
!
call mld_dilu_fctint(ialg,m,a%m,a,blck_%m,blck_,& call mld_dilu_fctint(ialg,m,a%m,a,blck_%m,blck_,&
& d,l%aspk,l%ia1,l%ia2,u%aspk,u%ia1,u%ia2,l1,l2,info) & d,l%aspk,l%ia1,l%ia2,u%aspk,u%ia1,u%ia2,l1,l2,info)
if(info.ne.0) then if(info.ne.0) then
info=4010 info=4010
ch_err='mld_dilu_fctint' ch_err='mld_dilu_fctint'
call psb_errpush(info,name,a_err=ch_err) call psb_errpush(info,name,a_err=ch_err)
goto 9999 goto 9999
end if end if
!
! Store information on the L and U sparse matrices
!
l%infoa(1) = l1 l%infoa(1) = l1
l%fida = 'CSR' l%fida = 'CSR'
l%descra = 'TLU' l%descra = 'TLU'
@ -105,15 +167,19 @@ subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck)
l%k = m l%k = m
u%m = m u%m = m
u%k = m u%k = m
!
! Nullify pointer / deallocate memory
!
if (present(blck)) then if (present(blck)) then
blck_ => null() blck_ => null()
else else
call psb_sp_free(blck_,info) call psb_sp_free(blck_,info)
if(info.ne.0) then if(info.ne.0) then
info=4010 info=4010
ch_err='psb_sp_free' ch_err='psb_sp_free'
call psb_errpush(info,name,a_err=ch_err) call psb_errpush(info,name,a_err=ch_err)
goto 9999 goto 9999
end if end if
deallocate(blck_) deallocate(blck_)
endif endif
@ -124,23 +190,96 @@ subroutine mld_dilu_fct(ialg,a,l,u,d,info,blck)
9999 continue 9999 continue
call psb_erractionrestore(err_act) call psb_erractionrestore(err_act)
if (err_act.eq.psb_act_abort_) then if (err_act.eq.psb_act_abort_) then
call psb_error() call psb_error()
return return
end if end if
return return
contains contains
!
! Subroutine: mld_dilu_fctint.
! Version: real.
! Note: internal subroutine of mld_dilu_fct.
!
! Computes either the ILU(0) or the MILU(0) factorization of the local part
! of the matrix stored into a. These factorizations are used to build the 'base
! preconditioner' (block-Jacobi preconditioner/solver, Additive Schwarz
! preconditioner) corresponding to a certain level of a multilevel preconditioner.
!
! The local matrix to be factorized is stored into a and b, as specified in the
! description of the arguments below.The output storage format for both L and U
! factors is CSR. The diagonal of the U factor is stored separately in D.
!
! This routine copies and factors "on the fly" from the sparse matrix structures a
! and b into the arrays laspk, uaspk, d (L, U without its diagonal, diagonal of U).
!
!
! Arguments:
! ialg - integer, input.
! The type of incomplete factorization to be performed.
! The MILU(0) factorization is computed if ialg = 2 (= mld_milu_n_);
! the ILU(0) factorization otherwise.
! m - integer, output
! The total number of rows of the local matrix to be factorized,
! i.e. ma+mb.
! ma - integer, input
! The number of rows of the local submatrix stored into a.
! a - type(<psb_dspmat_type>), input.
! The sparse matrix structure containing the local matrix to be
! factorized. Note that, if the 'base' Additive Schwarz preconditioner
! has overlap greater than 0 and the matrix has not been reordered
! (see mld_bjac_bld), then a contains only the 'original' local part
! of the matrix to be factorized, i.e. the rows of the matrix held
! by the calling process according to the initial data distribution.
! mb - integer, input
! The number of rows of the local submatrix stored into b.
! b - type(<psb_dspmat_type>), input.
! The sparse matrix structure containing the remote rows of the
! matrix to be factorized, that have been retrieved by mld_asmat_bld
! to build an Additive Schwarz base preconditioner with overlap
! greater than 0. If the overlap is 0 or the matrix has been reordered
! (see mld_bjac_bld), then b does not contain any row.
! d - real(kind(1.d0)), dimension(:), output
! The diagonal of the U factor in the incomplete factorization.
! laspk - real(kind(1.d0)), dimension(:), inout
! The L factor in the incomplete factorization.
! lia1 - integer, dimension(:), inout
! The column indices of the nonzero entries of the L factor,
! according to the CSR storage format.
! lia2 - integer, dimension(:), inout
! The indices identifying the first nonzero entry of each row
! of the L factor in laspk, according to the CSR storage format.
! uaspk - real(kind(1.d0)), dimension(:), inout
! The U factor in the incomplete factorization.
! The entries of U are stored according to the CSR format.
! uia1 - integer, dimension(:), inout
! The column indices of the nonzero entries of the U factor,
! according to the CSR storage format.
! uia2 - integer, dimension(:), inout
! The indices identifying the first nonzero entry of each row
! of the U factor in uaspk, according to the CSR storage format.
! l1 - integer, output
! The number of nonzero entries in laspk.
! l2 - integer, output
! The number of nonzero entries in uaspk.
! info - integer, output.
! Error code.
!
subroutine mld_dilu_fctint(ialg,m,ma,a,mb,b,& subroutine mld_dilu_fctint(ialg,m,ma,a,mb,b,&
& d,laspk,lia1,lia2,uaspk,uia1,uia2,l1,l2,info) & d,laspk,lia1,lia2,uaspk,uia1,uia2,l1,l2,info)
implicit none implicit none
! Arguments
integer, intent(in) :: ialg integer, intent(in) :: ialg
type(psb_dspmat_type) :: a,b type(psb_dspmat_type) :: a,b
integer :: m,ma,mb,l1,l2,info integer :: m,ma,mb,l1,l2,info
integer, dimension(:) :: lia1,lia2,uia1,uia2 integer, dimension(:) :: lia1,lia2,uia1,uia2
real(kind(1.d0)), dimension(:) :: laspk,uaspk,d real(kind(1.d0)), dimension(:) :: laspk,uaspk,d
integer :: i,j,k,l,low1,low2,kk,jj,ll, ktrw,err_act ! Local variables
integer :: i,j,k,l,low1,low2,kk,jj,ll, irb, ktrw,err_act
real(kind(1.d0)) :: dia,temp real(kind(1.d0)) :: dia,temp
integer, parameter :: nrb=16 integer, parameter :: nrb=16
logical,parameter :: debug=.false. logical,parameter :: debug=.false.
@ -171,15 +310,27 @@ contains
m = ma+mb m = ma+mb
if(debug) write(0,*)'In DCSRLU Begin cycle',m,ma,mb if(debug) write(0,*)'In DCSRLU Begin cycle',m,ma,mb
!
! Cycle over the matrix rows
!
do i = 1, m do i = 1, m
if(debug) write(0,*)'LUINT: Loop index ',i,ma if(debug) write(0,*)'LUINT: Loop index ',i,ma
d(i) = dzero d(i) = dzero
if (i <= ma) then if (i <= ma) then
call ilu_copyin(i,ma,a,i,m,l1,lia1,lia2,laspk,& !
! Copy the i-th local row of the matrix, stored in a,
! into laspk/d(i)/uaspk
!
call ilu_copyin(i,ma,a,i,1,m,l1,lia1,lia2,laspk,&
& d(i),l2,uia1,uia2,uaspk,ktrw,trw) & d(i),l2,uia1,uia2,uaspk,ktrw,trw)
else else
call ilu_copyin(i-ma,mb,b,i,m,l1,lia1,lia2,laspk,& !
! Copy the i-th local row of the matrix, stored in b
! (as (i-ma)-th row), into laspk/d(i)/uaspk
!
call ilu_copyin(i-ma,mb,b,i,1,m,l1,lia1,lia2,laspk,&
& d(i),l2,uia1,uia2,uaspk,ktrw,trw) & d(i),l2,uia1,uia2,uaspk,ktrw,trw)
endif endif
@ -188,20 +339,28 @@ contains
dia = d(i) dia = d(i)
do kk = lia2(i), lia2(i+1) - 1 do kk = lia2(i), lia2(i+1) - 1
! !
! compute element alo(i,k) of incomplete factorization ! Compute entry l(i,k) (lower factor L) of the incomplete
! ! factorization
!
temp = laspk(kk) temp = laspk(kk)
k = lia1(kk) k = lia1(kk)
laspk(kk) = temp*d(k) laspk(kk) = temp*d(k)
! update the rest of row i using alo(i,k) !
! Update the rest of row i (lower and upper factors L and U)
! using l(i,k)
!
low1 = kk + 1 low1 = kk + 1
low2 = uia2(i) low2 = uia2(i)
!
updateloop: do jj = uia2(k), uia2(k+1) - 1 updateloop: do jj = uia2(k), uia2(k+1) - 1
!
j = uia1(jj) j = uia1(jj)
! !
if (j < i) then if (j < i) then
! search alo(i,*) for matching index J !
! search l(i,*) (i-th row of L) for a matching index j
!
do ll = low1, lia2(i+1) - 1 do ll = low1, lia2(i+1) - 1
l = lia1(ll) l = lia1(ll)
if (l > j) then if (l > j) then
@ -213,16 +372,18 @@ contains
cycle updateloop cycle updateloop
end if end if
enddo enddo
!
else if (j == i) then else if (j == i) then
! j=i update diagonal !
! write(0,*)'aggiorno dia',dia,'temp',temp,'jj',jj,'u%aspk',uaspk(jj) ! j=i: update the diagonal
!
dia = dia - temp*uaspk(jj) dia = dia - temp*uaspk(jj)
! write(0,*)'dia',dia,'temp',temp,'jj',jj,'aspk',uaspk(jj)
cycle updateloop cycle updateloop
! !
else if (j > i) then else if (j > i) then
! search aup(i,*) for matching index j !
! search u(i,*) (i-th row of U) for a matching index j
!
do ll = low2, uia2(i+1) - 1 do ll = low2, uia2(i+1) - 1
l = uia1(ll) l = uia1(ll)
if (l > j) then if (l > j) then
@ -236,22 +397,21 @@ contains
enddo enddo
end if end if
! !
! If we get here we missed the cycle updateloop, ! If we get here we missed the cycle updateloop, which means
! which means that this entry does not match; thus ! that this entry does not match; thus we accumulate on the
! we accumulate on the diagonal for MILU. ! diagonal for MILU.
! !
if (ialg == mld_milu_n_) then if (ialg == mld_milu_n_) then
dia = dia - temp*uaspk(jj) dia = dia - temp*uaspk(jj)
end if end if
enddo updateloop enddo updateloop
enddo enddo
!
! !
! Non singularity ! Check pivot size
! !
if (abs(dia) < epstol) then if (abs(dia) < epstol) then
! !
! Pivot too small: unstable factorization ! Too small pivot: unstable factorization
! !
info = 2 info = 2
int_err(1) = i int_err(1) = i
@ -259,11 +419,15 @@ contains
call psb_errpush(info,name,i_err=int_err,a_err=ch_err) call psb_errpush(info,name,i_err=int_err,a_err=ch_err)
goto 9999 goto 9999
else else
!
! Compute 1/pivot
!
dia = done/dia dia = done/dia
end if end if
d(i) = dia d(i) = dia
! write(6,*)'diag(',i,')=',d(i) !
! Scale row i of upper triangle ! Scale row i of upper triangle
!
do kk = uia2(i), uia2(i+1) - 1 do kk = uia2(i), uia2(i+1) - 1
uaspk(kk) = uaspk(kk)*dia uaspk(kk) = uaspk(kk)*dia
enddo enddo
@ -290,15 +454,99 @@ contains
return return
end subroutine mld_dilu_fctint end subroutine mld_dilu_fctint
subroutine ilu_copyin(i,m,a,jd,jmax,l1,lia1,lia2,laspk,& !
! Subroutine: ilu_copyin.
! Version: real.
! Note: internal subroutine of mld_dilu_fct.
!
! Copies a row of a sparse matrix A, stored into the psb_dspmat_type data
! structure a, into the arrays laspk, dia, uaspk, corresponding to the lower
! triangle, the diagonal and the upper triangle of A. The entries in the three
! arrays are stored according to the CSR format.
!
! If the sparse matrix is in CSR format, a 'straight' copy is performed;
! otherwise psb_sp_getblk is used to extract a block of rows, which is then
! copied into laspk, dia, uaspk row by row, through successive calls to
! ilu_copyin
!
! This routine is used by mld_dilu_fctin (contained into mld_dilu_fct) in the
! computation of the ILU(0) factorization of a local sparse matrix.
!
! TODO: modify the routine to allow copying into output L and U that are already
! filled with indices; this would allow computing an ILU(K) pattern, then use
! the ILU(0) internal for subsequente calls with the same pattern.
!
! Arguments:
! i - integer, input.
! The local index of the row to be extracted from the
! sparse matrix structure a.
! m - integer, input
! The number of rows of the local matrix stored into a.
! a - type(<psb_dspmat_type>), input.
! The sparse matrix structure containing the row to be copied.
! jd - integer, input
! The column index of the diagonal entry of the row to be
! copied.
! jmin - integer, input
! Minimum valid column index.
! jmax - integer, input
! Maximum valid column index.
! The output matrix will contain a clipped copy
! taken from A(1:M,JMIN:JMAX)
! l1 - integer, inout
! Pointer to the last occupied entry of the row copied in laspk.
! lia1 - integer, dimension(:), inout
! The column indices of the nonzero entries of the lower triangle
! copied in laspk row by row (see mld_dilu_fctint), according
! to the CSR storage format.
! lia2 - integer, dimension(:), inout
! The indices identifying the first nonzero entry of each row
! of the lower triangle copied in laspk row by row (see
! mld_dilu_fctint), according to the CSR storage format.
! laspk - real(kind(1.d0)), dimension(:), inout
! The array where the entries of the row corresponding to the
! lower triangle are copied.
! dia - real(kind(1.d0)), output
! The diagonal element of the copied row.
! l2 - integer, inout
! Pointer to the last occupied entry of the row copied in uaspk.
! uia1 - integer, dimension(:), inout
! The column indices of the nonzero entries of the upper triangle
! copied in uaspk row by row (see mld_dilu_fctint), according
! to the CSR storage format.
! uia2 - integer, dimension(:), inout
! The indices identifying the first nonzero entry of each row
! of the upper triangle copied in uaspk row by row (see
! mld_dilu_fctint), according to the CSR storage format.
! uaspk - real(kind(1.d0)), dimension(:), inout
! The array where the entries of the row corresponding to the
! upper triangle are copied.
! ktrw - integer, inout
! The index identifying the last entry taken from the
! staging buffer trw. See below.
! trw - type(psb_dspmat_type), inout
! A staging buffer. If the matrix A is not in CSR format, we use
! the psb_sp_getblk routine and store its output in trw; when we
! need to call getblk we do it for a block of rows, and then we consume
! them from trw in successive calls to this routine, until we empty the
! buffer. Thus we will make a call to geblk every NB calls to copyin.
! If A is in CSR format it is unused.
!
subroutine ilu_copyin(i,m,a,jd,jmin,jmax,l1,lia1,lia2,laspk,&
& dia,l2,uia1,uia2,uaspk,ktrw,trw) & dia,l2,uia1,uia2,uaspk,ktrw,trw)
use psb_base_mod use psb_base_mod
implicit none
implicit none
! Arguments
type(psb_dspmat_type) :: a,trw type(psb_dspmat_type) :: a,trw
integer :: i,m,ktrw,jd,jmax,l1,l2 integer :: i,m,ktrw,jd,jmin,jmax,l1,l2
integer :: lia1(:),lia2(:),uia1(:),uia2(:) integer :: lia1(:),lia2(:),uia1(:),uia2(:)
real(kind(1.d0)) :: laspk(:), uaspk(:), dia real(kind(1.d0)) :: laspk(:), uaspk(:), dia
! Local variables
type(psb_int_heap) :: heap
integer :: k,j,info,irb integer :: k,j,info,irb
integer, parameter :: nrb=16 integer, parameter :: nrb=16
character(len=20), parameter :: name='mld_dilu_fctint' character(len=20), parameter :: name='mld_dilu_fctint'
@ -307,18 +555,17 @@ contains
if (psb_get_errstatus() /= 0) return if (psb_get_errstatus() /= 0) return
info=0 info=0
call psb_erractionsave(err_act) call psb_erractionsave(err_act)
!
! Here we take a fast shortcut if possible, otherwise
! use spgtblk, slower but able (in principle) of
! handling anything.
!
if (toupper(a%fida)=='CSR') then if (toupper(a%fida)=='CSR') then
!
! Take a fast shortcut if the matrix is stored in CSR format
!
do j = a%ia2(i), a%ia2(i+1) - 1 do j = a%ia2(i), a%ia2(i+1) - 1
k = a%ia1(j) k = a%ia1(j)
! write(0,*)'KKKKK',k ! write(0,*)'KKKKK',k
if ((k < jd).and.(k >= 1)) then if ((k < jd).and.(k >= jmin)) then
l1 = l1 + 1 l1 = l1 + 1
laspk(l1) = a%aspk(j) laspk(l1) = a%aspk(j)
lia1(l1) = k lia1(l1) = k
@ -332,7 +579,15 @@ contains
enddo enddo
else else
!
! Otherwise use psb_sp_getblk, slower but able (in principle) of
! handling any format. In this case, a block of rows is extracted
! instead of a single row, for performance reasons, and these
! rows are copied one by one into laspk, dia, uaspk, through
! successive calls to ilu_copyin
!
if ((mod(i,nrb) == 1).or.(nrb==1)) then if ((mod(i,nrb) == 1).or.(nrb==1)) then
irb = min(m-i+1,nrb) irb = min(m-i+1,nrb)
call psb_sp_getblk(i,a,trw,info,lrw=i+irb-1) call psb_sp_getblk(i,a,trw,info,lrw=i+irb-1)
@ -344,12 +599,12 @@ contains
end if end if
ktrw=1 ktrw=1
end if end if
do do
if (ktrw > trw%infoa(psb_nnz_)) exit if (ktrw > trw%infoa(psb_nnz_)) exit
if (trw%ia1(ktrw) > i) exit if (trw%ia1(ktrw) > i) exit
k = trw%ia2(ktrw) k = trw%ia2(ktrw)
if ((k < jd).and.(k >= 1)) then if ((k < jd).and.(k >= jmin)) then
l1 = l1 + 1 l1 = l1 + 1
laspk(l1) = trw%aspk(ktrw) laspk(l1) = trw%aspk(ktrw)
lia1(l1) = k lia1(l1) = k
@ -362,7 +617,7 @@ contains
end if end if
ktrw = ktrw + 1 ktrw = ktrw + 1
enddo enddo
end if end if
call psb_erractionrestore(err_act) call psb_erractionrestore(err_act)

@ -1,13 +1,13 @@
!!$ !!$
!!$ !!$
!!$ MD2P4 !!$ MLD2P4
!!$ Multilevel Domain Decomposition Parallel Preconditioner Package for PSBLAS !!$ MultiLevel Domain Decomposition Parallel Preconditioners Package
!!$ for !!$ based on PSBLAS (Parallel Sparse BLAS v.2.0)
!!$ Parallel Sparse BLAS v2.0 !!$
!!$ (C) Copyright 2006 Salvatore Filippone University of Rome Tor Vergata !!$ (C) Copyright 2006 Alfredo Buttari University of Rome Tor Vergata
!!$ Alfredo Buttari University of Rome Tor Vergata !!$ Pasqua D'Ambra ICAR-CNR, Naples
!!$ Daniela di Serafino Second University of Naples !!$ Daniela di Serafino Second University of Naples
!!$ Pasqua D'Ambra ICAR-CNR !!$ Salvatore Filippone University of Rome Tor Vergata
!!$ !!$
!!$ Redistribution and use in source and binary forms, with or without !!$ Redistribution and use in source and binary forms, with or without
!!$ modification, are permitted provided that the following conditions !!$ modification, are permitted provided that the following conditions
@ -17,14 +17,14 @@
!!$ 2. Redistributions in binary form must reproduce the above copyright !!$ 2. Redistributions in binary form must reproduce the above copyright
!!$ notice, this list of conditions, and the following disclaimer in the !!$ notice, this list of conditions, and the following disclaimer in the
!!$ documentation and/or other materials provided with the distribution. !!$ documentation and/or other materials provided with the distribution.
!!$ 3. The name of the MD2P4 group or the names of its contributors may !!$ 3. The name of the MLD2P4 group or the names of its contributors may
!!$ not be used to endorse or promote products derived from this !!$ not be used to endorse or promote products derived from this
!!$ software without specific written permission. !!$ software without specific written permission.
!!$ !!$
!!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS !!$ THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS
!!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED !!$ ``AS IS'' AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED
!!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR !!$ TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
!!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MD2P4 GROUP OR ITS CONTRIBUTORS !!$ PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE MLD2P4 GROUP OR ITS CONTRIBUTORS
!!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR !!$ BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR
!!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF !!$ CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF
!!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS !!$ SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS
@ -34,6 +34,25 @@
!!$ POSSIBILITY OF SUCH DAMAGE. !!$ POSSIBILITY OF SUCH DAMAGE.
!!$ !!$
!!$ !!$
! File: mld_ddiagsc_bld.f90.
!
! Subroutine: mld_ddiag_bld.
! Version: complex.
!
! Builds the diagonal preconditioner corresponding to a given sparse matrix A.
!
! Arguments:
! a - type(<psb_zspmat_type>), input.
! The sparse matrix structure containing the local part of the
! matrix A to be preconditioned.
! desc_a - type(<psb_desc_type>), input.
! The communication descriptor associated to the sparse matrix A.
! p - type(<mld_zbaseprc_type>), input/output.
! The 'base preconditioner' data structure containing the local
! part of the diagonal preconditioner.
! info - integer, output.
! Error code.
!
subroutine mld_zdiag_bld(a,desc_a,p,upd,info) subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
use psb_base_mod use psb_base_mod
@ -47,11 +66,9 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
character, intent(in) :: upd character, intent(in) :: upd
integer, intent(out) :: info integer, intent(out) :: info
! Local variables
! Local scalars Integer :: err, n_row, n_col,I,j,k,ictxt,&
Integer :: err, n_row, n_col,I,ictxt,& & me,np,mglob,lw, err_act
& me,np,mglob, err_act
complex(kind(1.d0)),pointer :: gd(:), work(:)
integer :: int_err(5) integer :: int_err(5)
logical, parameter :: debug=.false. logical, parameter :: debug=.false.
@ -75,8 +92,7 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
if (debug) write(0,*) 'Preconditioner Blacs_gridinfo' if (debug) write(0,*) 'Preconditioner Blacs_gridinfo'
call psb_info(ictxt, me, np) call psb_info(ictxt, me, np)
if (debug) write(0,*) 'Precond: Diagonal scaling' if (debug) write(0,*) 'Precond: Diagonal'
! diagonal scaling
call psb_realloc(n_col,p%d,info) call psb_realloc(n_col,p%d,info)
if (info /= 0) then if (info /= 0) then
@ -84,6 +100,9 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
goto 9999 goto 9999
end if end if
!
! Retrieve the diagonal entries of the matrix A
!
call psb_sp_getdiag(a,p%d,info) call psb_sp_getdiag(a,p%d,info)
if(info /= 0) then if(info /= 0) then
info=4010 info=4010
@ -91,7 +110,9 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
call psb_errpush(info,name,a_err=ch_err) call psb_errpush(info,name,a_err=ch_err)
goto 9999 goto 9999
end if end if
!
! Copy into p%desc_data the descriptor associated to A
!
call psb_cdcpy(desc_a,p%desc_Data,info) call psb_cdcpy(desc_a,p%desc_Data,info)
if (info /= 0) then if (info /= 0) then
call psb_errpush(4010,name,a_err='psb_cdcpy') call psb_errpush(4010,name,a_err='psb_cdcpy')
@ -99,6 +120,11 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
end if end if
if (debug) write(ilout+me,*) 'VDIAG ',n_row if (debug) write(ilout+me,*) 'VDIAG ',n_row
!
! The i-th diagonal entry of the preconditioner is set to one if the
! corresponding entry a_ii of the sparse matrix A is zero; otherwise
! it is set to one/a_ii
!
do i=1,n_row do i=1,n_row
if (p%d(i) == zzero) then if (p%d(i) == zzero) then
p%d(i) = zone p%d(i) = zone
@ -110,12 +136,9 @@ subroutine mld_zdiag_bld(a,desc_a,p,upd,info)
end do end do
if (a%pl(1) /= 0) then if (a%pl(1) /= 0) then
if (info /= 0) then !
info=4025 ! Apply the same row permutation as in the sparse matrix A
call psb_errpush(info,name,i_err=(/n_row,0,0,0,0/),& !
& a_err='complex(kind(1.d0))')
goto 9999
end if
call psb_gelp('n',a%pl,p%d,info) call psb_gelp('n',a%pl,p%d,info)
if(info /= 0) then if(info /= 0) then
info=4010 info=4010

Loading…
Cancel
Save