[petsc-dev] Running on KNC

Mark Adams mfadams at lbl.gov
Thu Nov 6 10:17:43 CST 2014


ex52 sets SuperLU explicitly (appended) and yes I did modify the runex52
rule.  I have it running now with superlu_dist.
Thanks,
Mark

    ierr = KSPSetType(ksp,KSPPREONLY);CHKERRQ(ierr);
    PC  pc;
    Mat F;
    ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr);
    if (flg) {
      ierr = PCSetType(pc,PCLU);CHKERRQ(ierr);
    } else if (flg_ilu) {
      ierr = PCSetType(pc,PCILU);CHKERRQ(ierr);
    }
    ierr = PCFactorSetMatSolverPackage(pc,MATSOLVERSUPERLU);CHKERRQ(ierr);
    ierr = PCFactorSetUpMatSolverPackage(pc);CHKERRQ(ierr); /* call
MatGetFactor() to create F */
    ierr = PCFactorGetMatrix(pc,&F);CHKERRQ(ierr);
    ierr = MatSuperluSetILUDropTol(F,1.e-8);CHKERRQ(ierr);

On Thu, Nov 6, 2014 at 8:01 AM, Barry Smith <bsmith at mcs.anl.gov> wrote:

>
> > Matrix format mpiaij does not have a solver package superlu for LU.
>
>    SuperLU is not parallel, it does not work with mpiaij matrix.
>
>    Did you modify the runex52_superlu  rule in the makefile or something
> to run on 2 processors? In master it looks like
> runex52_superlu:
>         -@${MPIEXEC} -n 1 ./ex52 -use_superlu_ilu > ex52.tmp 2>&1;
>
>
>    If you want to run on two processors you need to use superlu_dist
>
>   Barry
>
> > On Nov 6, 2014, at 5:54 AM, Mark Adams <mfadams at lbl.gov> wrote:
> >
> > I am running on KNC and ex52 is sort of running, SuperLU runs on one
> processor, but fails with this message on 2 procs.  The error message
> suggests downloading superLU but you can see that it was downloaded.  Any
> ideas?
> >
> > Mark
> >
> > 03:19 bc0915 master ~/petsc/src/ksp/ksp/examples/tutorials$ make
> runex52_superlu PETSC_DIR=/global/homes/m/madams/petsc
> > make: Warning: File `makefile' has modification time 19 s in the future
> > [0]PETSC ERROR: --------------------- Error Message
> --------------------------------------------------------------
> > [0]PETSC ERROR: No support for this operation for this object type
> > [0]PETSC ERROR: Matrix format mpiaij does not have a solver package
> superlu for LU. Perhaps you must ./configure with --download-superlu
> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html
> for trouble shooting.
> > [0]PETSC ERROR: Petsc Development GIT revision: v3.5-25-g0ace994  GIT
> Date: 2014-07-07 14:50:15 +0200
> > [0]PETSC ERROR: ./ex52 on a arch-knc-opt named bc0915-mic0 by madams Thu
> Nov  6 03:20:04 2014
> > [0]PETSC ERROR: Configure options --known-level1-dcache-size=32768
> --known-level1-dcache-linesize=32 --known-level1-dcache-assoc=0
> --known-memcmp-ok=1 --known-sizeof-char=1 --known-sizeof-void-p=8
> --known-sizeof-short=2 --known-sizeof-int=4 --known-sizeof-long=8
> --known-sizeof-long-long=8 --known-sizeof-float=4 --known-sizeof-double=8
> --known-sizeof-size_t=8 --known-bits-per-byte=8 --known-sizeof-MPI_Comm=4
> --known-sizeof-MPI_Fint=4 --known-mpi-long-double=1 --known-mpi-int64_t=1
> --known-mpi-c-double-complex=1 --download-parmetis --download-metis
> --download-superlu_dist --download-superlu --with-batch=1 --CFLAGS="-mmic
> -mkl -fp-model precise" --CXXFLAGS="-mmic -mkl -fp-model precise"
> --FFLAGS="-mmic -mkl -fp-model precise" --with-cc=mpiicc --with-cxx=mpiicpc
> --with-fc=mpiifort --known-mpi-shared-libraries=1 --with-shared-libraries=0
> --with-x=0 --with-debugging=0 PETSC_ARCH=arch-knc-opt
> PETSC_DIR=/global/homes/m/madams/petsc
> > [0]PETSC ERROR: #1 MatGetFactor() line 3962 in
> /chos/global/u2/m/madams/petsc/src/mat/interface/matrix.c
> > [0]PETSC ERROR: #2 PCFactorSetUpMatSolverPackage_Factor() line 16 in
> /chos/global/u2/m/madams/petsc/src/ksp/pc/impls/factor/factimpl.c
> > [0]PETSC ERROR: #3 PCFactorSetUpMatSolverPackage() line 26 in
> /chos/global/u2/m/madams/petsc/src/ksp/pc/impls/factor/factor.c
> > [0]PETSC ERROR: #4 main() line 209 in
> /global/homes/m/madams/petsc/src/ksp/ksp/examples/tutorials/ex52.c
> > [0]PETSC ERROR: ----------------End of Error Message -------send entire
> error message to petsc-maint at mcs.anl.gov----------
> > application called MPI_Abort(MPI_COMM_WORLD, 56) - process 0
> > APPLICATION TERMINATED WITH THE EXIT STRING: Interrupt (signal 2)
>
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://lists.mcs.anl.gov/pipermail/petsc-dev/attachments/20141106/c26611ce/attachment.html>


More information about the petsc-dev mailing list