From james.mbewu at cs.ox.ac.uk Fri Aug 1 04:50:26 2014 From: james.mbewu at cs.ox.ac.uk (James MBewu) Date: Fri, 1 Aug 2014 10:50:26 +0100 Subject: [petsc-users] parmetis error when using more than one block per processor in asm Message-ID: Hi all, I'm solving a Navier Stokes system. I am having a problem whereby when I try to use asm as a preconditioner and make the number of blocks more than one per mpi proc I get an error from within parmetis (when I attempt the same with bjacobi I don't get an error). Also when I run with exactly one block per processor there are no issues. Any tips? Error message below. Cheers, James PARMETIS ERROR: The sum of tpwgts for constraint #0 is not 1.0 PARMETIS ERROR: The sum of tpwgts for constraint #0 is not 1.0 -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD with errorcode 76. NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. You may or may not see output from other processes, depending on exactly when Open MPI kills them. -------------------------------------------------------------------------- [0]PETSC ERROR: --------------------- Error Message ------------------------------------ [1]PETSC ERROR: --------------------- Error Message ------------------------------------ [1]PETSC ERROR: Error in external library! [1]PETSC ERROR: ParMETIS general error in ParMETIS_V3_PartKway! [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Petsc Release Version 3.4.2, Jul, 02, 2013 [1]PETSC ERROR: See docs/changes/index.html for recent updates. [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [1]PETSC ERROR: See docs/index.html for manual pages. [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: /home/james/libmesh-0.9.3/examples/fem_system/fem_system_ex1/.libs/lt-example-opt on a linux-opt named james-SATELLITE-C855-18D by james Fri Aug 1 10:45:36 2014 [1]PETSC ERROR: Libraries linked from /home/james/petsc-3.4.2/linux-opt/lib [1]PETSC ERROR: Configure run at Wed Jul 9 14:22:40 2014 [1]PETSC ERROR: Configure options ./configure --with-mpi=1 --with-x=0 --download-scalapack=1 --download-metis=1 --download-parmetis=1 --download-mumps=1 --download-hypre=1 --download-f-blas-lapack=1 --download-ml=1 --download-superlu_dist=1 --download-superlu=1 --download-umfpack=1 --download-ptscotch=1 --download-gamg=1 --download-pastix=1 --with-debugging=0 [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: MatPartitioningApply_Parmetis() line 104 in /home/james/petsc-3.4.2/src/mat/partition/impls/pmetis/pmetis.c [0]PETSC ERROR: Error in external library! [0]PETSC ERROR: ParMETIS general error in ParMETIS_V3_PartKway! [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Petsc Release Version 3.4.2, Jul, 02, 2013 [0]PETSC ERROR: See docs/changes/index.html for recent updates. [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [0]PETSC ERROR: See docs/index.html for manual pages. [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: /home/james/libmesh-0.9.3/examples/fem_system/fem_system_ex1/.libs/lt-example-opt on a linux-opt named james-SATELLITE-C855-18D by james Fri Aug 1 10:45:36 2014 [0]PETSC ERROR: Libraries linked from /home/james/petsc-3.4.2/linux-opt/lib [0]PETSC ERROR: Configure run at Wed Jul 9 14:22:40 2014 [0]PETSC ERROR: Configure options ./configure --with-mpi=1 --with-x=0 --download-scalapack=1 --download-metis=1 --download-parmetis=1 --download-mumps=1 --download-hypre=1 --download-f-blas-lapack=1 --download-ml=1 --download-superlu_dist=1 --download-superlu=1 --download-umfpack=1 --download-ptscotch=1 --download-gamg=1 --download-pastix=1 --with-debugging=0 [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: MatPartitioningApply_Parmetis() line 104 in /home/james/petsc-3.4.2/src/mat/partition/impls/pmetis/pmetis.c [0]PETSC ERROR: MatPartitioningApply() line 225 in /home/james/petsc-3.4.2/src/mat/partition/partition.c [0]PETSC ERROR: PCASMCreateSubdomains() line 1210 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [0]PETSC ERROR: PCSetUp_ASM() line 232 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [0]PETSC ERROR: PCSetUp() line 890 in /home/james/petsc-3.4.2/src/ksp/pc/interface/precon.c [0]PETSC ERROR: KSPSetUp() line 278 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: KSPSolve() line 399 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: solve() line 763 in "unknowndirectory/"src/solvers/petsc_linear_solver.C [1]PETSC ERROR: MatPartitioningApply() line 225 in /home/james/petsc-3.4.2/src/mat/partition/partition.c [1]PETSC ERROR: PCASMCreateSubdomains() line 1210 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [1]PETSC ERROR: PCSetUp_ASM() line 232 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [1]PETSC ERROR: PCSetUp() line 890 in /home/james/petsc-3.4.2/src/ksp/pc/interface/precon.c [1]PETSC ERROR: KSPSetUp() line 278 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: KSPSolve() line 399 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: solve() line 763 in "unknowndirectory/"src/solvers/petsc_linear_solver.C -------------------------------------------------------------------------- mpirun has exited due to process rank 1 with PID 5356 on node james-SATELLITE-C855-18D exiting without calling "finalize". This may have caused other processes in the application to be terminated by signals sent by mpirun (as reported hPARMETIS ERROR: The sum of tpwgts for constraint #0 is not 1.0 PARMETIS ERROR: The sum of tpwgts for constraint #0 is not 1.0 -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD with errorcode 76. NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. You may or may not see output from other processes, depending on exactly when Open MPI kills them. -------------------------------------------------------------------------- [0]PETSC ERROR: --------------------- Error Message ------------------------------------ [1]PETSC ERROR: --------------------- Error Message ------------------------------------ [1]PETSC ERROR: Error in external library! [1]PETSC ERROR: ParMETIS general error in ParMETIS_V3_PartKway! [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Petsc Release Version 3.4.2, Jul, 02, 2013 [1]PETSC ERROR: See docs/changes/index.html for recent updates. [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [1]PETSC ERROR: See docs/index.html for manual pages. [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: /home/james/libmesh-0.9.3/examples/fem_system/fem_system_ex1/.libs/lt-example-opt on a linux-opt named james-SATELLITE-C855-18D by james Fri Aug 1 10:45:36 2014 [1]PETSC ERROR: Libraries linked from /home/james/petsc-3.4.2/linux-opt/lib [1]PETSC ERROR: Configure run at Wed Jul 9 14:22:40 2014 [1]PETSC ERROR: Configure options ./configure --with-mpi=1 --with-x=0 --download-scalapack=1 --download-metis=1 --download-parmetis=1 --download-mumps=1 --download-hypre=1 --download-f-blas-lapack=1 --download-ml=1 --download-superlu_dist=1 --download-superlu=1 --download-umfpack=1 --download-ptscotch=1 --download-gamg=1 --download-pastix=1 --with-debugging=0 [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: MatPartitioningApply_Parmetis() line 104 in /home/james/petsc-3.4.2/src/mat/partition/impls/pmetis/pmetis.c [0]PETSC ERROR: Error in external library! [0]PETSC ERROR: ParMETIS general error in ParMETIS_V3_PartKway! [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Petsc Release Version 3.4.2, Jul, 02, 2013 [0]PETSC ERROR: See docs/changes/index.html for recent updates. [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [0]PETSC ERROR: See docs/index.html for manual pages. [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: /home/james/libmesh-0.9.3/examples/fem_system/fem_system_ex1/.libs/lt-example-opt on a linux-opt named james-SATELLITE-C855-18D by james Fri Aug 1 10:45:36 2014 [0]PETSC ERROR: Libraries linked from /home/james/petsc-3.4.2/linux-opt/lib [0]PETSC ERROR: Configure run at Wed Jul 9 14:22:40 2014 [0]PETSC ERROR: Configure options ./configure --with-mpi=1 --with-x=0 --download-scalapack=1 --download-metis=1 --download-parmetis=1 --download-mumps=1 --download-hypre=1 --download-f-blas-lapack=1 --download-ml=1 --download-superlu_dist=1 --download-superlu=1 --download-umfpack=1 --download-ptscotch=1 --download-gamg=1 --download-pastix=1 --with-debugging=0 [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: MatPartitioningApply_Parmetis() line 104 in /home/james/petsc-3.4.2/src/mat/partition/impls/pmetis/pmetis.c [0]PETSC ERROR: MatPartitioningApply() line 225 in /home/james/petsc-3.4.2/src/mat/partition/partition.c [0]PETSC ERROR: PCASMCreateSubdomains() line 1210 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [0]PETSC ERROR: PCSetUp_ASM() line 232 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [0]PETSC ERROR: PCSetUp() line 890 in /home/james/petsc-3.4.2/src/ksp/pc/interface/precon.c [0]PETSC ERROR: KSPSetUp() line 278 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: KSPSolve() line 399 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: solve() line 763 in "unknowndirectory/"src/solvers/petsc_linear_solver.C [1]PETSC ERROR: MatPartitioningApply() line 225 in /home/james/petsc-3.4.2/src/mat/partition/partition.c [1]PETSC ERROR: PCASMCreateSubdomains() line 1210 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [1]PETSC ERROR: PCSetUp_ASM() line 232 in /home/james/petsc-3.4.2/src/ksp/pc/impls/asm/asm.c [1]PETSC ERROR: PCSetUp() line 890 in /home/james/petsc-3.4.2/src/ksp/pc/interface/precon.c [1]PETSC ERROR: KSPSetUp() line 278 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: KSPSolve() line 399 in /home/james/petsc-3.4.2/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: solve() line 763 in "unknowndirectory/"src/solvers/petsc_linear_solver.C -------------------------------------------------------------------------- mpirun has exited due to process rank 1 with PID 5356 on node james-SATELLITE-C855-18D exiting without calling "finalize". This may have caused other processes in the application to be terminated by signals sent by mpirun (as reported here). -------------------------------------------------------------------------- [james-SATELLITE-C855-18D:05354] 1 more process has sent help message help-mpi-api.txt / mpi-abort [james-SATELLITE-C855-18D:05354] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages ere). -------------------------------------------------------------------------- [james-SATELLITE-C855-18D:05354] 1 more process has sent help message help-mpi-api.txt / mpi-abort [james-SATELLITE-C855-18D:05354] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 1 08:26:51 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 1 Aug 2014 08:26:51 -0500 Subject: [petsc-users] DMPlex and Tao In-Reply-To: References: Message-ID: On Wed, Jul 30, 2014 at 5:01 PM, Justin Chang wrote: > That's good to know thanks. I have another question somewhat related. > > In that quadratic programming problem I have shown earlier, my K matrix is > of global size *Ndof* by *Ndof* where *Ndof* is number of free dofs (for > instance, if I have a 2x2 quadrilateral mesh and want to evaluate > concentration at all the verticies, I will have nine total dofs but if I > have Dirichlet constraints all along the boundary, only my center vertex is > free so *Ndof* = 1. Thus when I simply call DMCreateMatrix(...) it would > give me a 1x1 matrix.) > > However, I want my M constraint matrix to be of size *Nele* by *Ndof* > where *Nele* is the total number of elements. How would I create this > matrix? Because ultimately, I am subjecting all of my free u's to *Nele* > number of equality constraints, and if possible I want this M matrix to be > compatible with the layout from Vec u. > This is not hard in principle. I used to have code that did this, but I took it out during the rewrite because no one was using it and it was complicated. It just generalizes the code in DMPlexPreallocateOperator() to take two PetscSections instead of one. Are you sure that this does not belong inside a large square matrix for the entire problem? Thanks, Matt > > On Wed, Jul 30, 2014 at 2:03 PM, Matthew Knepley > wrote: > >> On Wed, Jul 30, 2014 at 2:53 PM, Justin Chang >> wrote: >> >>> Hi, >>> >>> This might be a silly question, but I am developing a finite element >>> code to solve the non-negative diffusion equation. I am using the DMPlex >>> structure and plan on subjecting the problem to a bounded constraint >>> optimization to ensure non-negative concentrations. Say for instance, I >>> want to solve: >>> >>> min || K*u - F ||^2 >>> subject to u >= 0 >>> M*u = 0 >>> >>> Where K is the Jacobian, F the residual, u the concentration, and M some >>> equality constraint matrix. I know how to do this via Tao, but my question >>> is can Tao handle Mats and Vecs created via DMPlex? Because from the SNES >>> and TS examples I have seen in ex12, ex62, and ex11, it seems there are >>> solvers tailored to handle DMPlex created data structures. >>> >> >> Yes, TAO can handle objects created by DMPlex since they are just Vec and >> Mat structures. The additions >> to ex12, ex62, and ex11 concern the callbacks from the solver to the >> constructions routines for residual and >> Jacobian. Right now, none of the callbacks are automatic for TAO so you >> would have to code them yourself, >> probably by just calling the routines from SNES or TS so it should not be >> that hard. We are working to get >> everything integrated as it is in the other solvers. >> >> Thanks, >> >> Matt >> >> >>> Thanks, >>> Justin >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jychang48 at gmail.com Fri Aug 1 14:38:09 2014 From: jychang48 at gmail.com (Justin Chang) Date: Fri, 1 Aug 2014 13:38:09 -0600 Subject: [petsc-users] DMPlex and Tao In-Reply-To: References: Message-ID: As far as I know this equality constraint should exist outside of the large square matrix. What I was thinking of doing is manually creating an *Nele* by *Ndof* matrix, each row will have the same number of non-zeros. Since the size of *Ndof* is simply the global number of free dofs formulated by the PetscSection, I want to know what's the best way to map the free dofs into the global column indices [0 *Ndof*) For example, in src/dm/impls/plex/examples/tutorials/ex1.c where a box mesh with three fields is created, there are a total of 41 dofs to which 8 of them are constrained. If no constraints were set, then the size of u (i.e. *Ndof*) would be 41, but with constraints set it is 33. When you view the constrained global vector u, it lists all the dofs in the order as specified by the PetscSection but skips all the constrained ones. Would I have to use something like DMSet/GetDefaultGlobalSection to do the mapping? Thanks, Justin On Fri, Aug 1, 2014 at 7:26 AM, Matthew Knepley wrote: > On Wed, Jul 30, 2014 at 5:01 PM, Justin Chang wrote: > >> That's good to know thanks. I have another question somewhat related. >> >> In that quadratic programming problem I have shown earlier, my K matrix >> is of global size *Ndof* by *Ndof* where *Ndof* is number of free dofs >> (for instance, if I have a 2x2 quadrilateral mesh and want to evaluate >> concentration at all the verticies, I will have nine total dofs but if I >> have Dirichlet constraints all along the boundary, only my center vertex is >> free so *Ndof* = 1. Thus when I simply call DMCreateMatrix(...) it would >> give me a 1x1 matrix.) >> >> However, I want my M constraint matrix to be of size *Nele* by *Ndof* >> where *Nele* is the total number of elements. How would I create this >> matrix? Because ultimately, I am subjecting all of my free u's to *Nele* >> number of equality constraints, and if possible I want this M matrix to be >> compatible with the layout from Vec u. >> > > This is not hard in principle. I used to have code that did this, but I > took it out during the rewrite because no one > was using it and it was complicated. It just generalizes the code in > DMPlexPreallocateOperator() to take two > PetscSections instead of one. > > Are you sure that this does not belong inside a large square matrix for > the entire problem? > > Thanks, > > Matt > > >> >> On Wed, Jul 30, 2014 at 2:03 PM, Matthew Knepley >> wrote: >> >>> On Wed, Jul 30, 2014 at 2:53 PM, Justin Chang >>> wrote: >>> >>>> Hi, >>>> >>>> This might be a silly question, but I am developing a finite element >>>> code to solve the non-negative diffusion equation. I am using the DMPlex >>>> structure and plan on subjecting the problem to a bounded constraint >>>> optimization to ensure non-negative concentrations. Say for instance, I >>>> want to solve: >>>> >>>> min || K*u - F ||^2 >>>> subject to u >= 0 >>>> M*u = 0 >>>> >>>> Where K is the Jacobian, F the residual, u the concentration, and M >>>> some equality constraint matrix. I know how to do this via Tao, but my >>>> question is can Tao handle Mats and Vecs created via DMPlex? Because from >>>> the SNES and TS examples I have seen in ex12, ex62, and ex11, it seems >>>> there are solvers tailored to handle DMPlex created data structures. >>>> >>> >>> Yes, TAO can handle objects created by DMPlex since they are just Vec >>> and Mat structures. The additions >>> to ex12, ex62, and ex11 concern the callbacks from the solver to the >>> constructions routines for residual and >>> Jacobian. Right now, none of the callbacks are automatic for TAO so you >>> would have to code them yourself, >>> probably by just calling the routines from SNES or TS so it should not >>> be that hard. We are working to get >>> everything integrated as it is in the other solvers. >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> Thanks, >>>> Justin >>>> >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 1 14:40:00 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 1 Aug 2014 14:40:00 -0500 Subject: [petsc-users] DMPlex and Tao In-Reply-To: References: Message-ID: On Fri, Aug 1, 2014 at 2:38 PM, Justin Chang wrote: > As far as I know this equality constraint should exist outside of the > large square matrix. > > What I was thinking of doing is manually creating an *Nele* by *Ndof* > matrix, each row will have the same number of non-zeros. Since the size of > *Ndof* is simply the global number of free dofs formulated by the > PetscSection, I want to know what's the best way to map the free dofs into > the global column indices [0 *Ndof*) > > For example, in src/dm/impls/plex/examples/tutorials/ex1.c where a box > mesh with three fields is created, there are a total of 41 dofs to which 8 > of them are constrained. If no constraints were set, then the size of u > (i.e. *Ndof*) would be 41, but with constraints set it is 33. When you > view the constrained global vector u, it lists all the dofs in the order as > specified by the PetscSection but skips all the constrained ones. Would I > have to use something like DMSet/GetDefaultGlobalSection to do the mapping? > I do not understand what you are asking. However, you can just use the PetscSection for the Ndof field to give you the local sizes for your matrix. Matt > Thanks, > Justin > > > On Fri, Aug 1, 2014 at 7:26 AM, Matthew Knepley wrote: > >> On Wed, Jul 30, 2014 at 5:01 PM, Justin Chang >> wrote: >> >>> That's good to know thanks. I have another question somewhat related. >>> >>> In that quadratic programming problem I have shown earlier, my K matrix >>> is of global size *Ndof* by *Ndof* where *Ndof* is number of free dofs >>> (for instance, if I have a 2x2 quadrilateral mesh and want to evaluate >>> concentration at all the verticies, I will have nine total dofs but if I >>> have Dirichlet constraints all along the boundary, only my center vertex is >>> free so *Ndof* = 1. Thus when I simply call DMCreateMatrix(...) it >>> would give me a 1x1 matrix.) >>> >>> However, I want my M constraint matrix to be of size *Nele* by *Ndof* >>> where *Nele* is the total number of elements. How would I create this >>> matrix? Because ultimately, I am subjecting all of my free u's to *Nele* >>> number of equality constraints, and if possible I want this M matrix to be >>> compatible with the layout from Vec u. >>> >> >> This is not hard in principle. I used to have code that did this, but I >> took it out during the rewrite because no one >> was using it and it was complicated. It just generalizes the code in >> DMPlexPreallocateOperator() to take two >> PetscSections instead of one. >> >> Are you sure that this does not belong inside a large square matrix for >> the entire problem? >> >> Thanks, >> >> Matt >> >> >>> >>> On Wed, Jul 30, 2014 at 2:03 PM, Matthew Knepley >>> wrote: >>> >>>> On Wed, Jul 30, 2014 at 2:53 PM, Justin Chang >>>> wrote: >>>> >>>>> Hi, >>>>> >>>>> This might be a silly question, but I am developing a finite element >>>>> code to solve the non-negative diffusion equation. I am using the DMPlex >>>>> structure and plan on subjecting the problem to a bounded constraint >>>>> optimization to ensure non-negative concentrations. Say for instance, I >>>>> want to solve: >>>>> >>>>> min || K*u - F ||^2 >>>>> subject to u >= 0 >>>>> M*u = 0 >>>>> >>>>> Where K is the Jacobian, F the residual, u the concentration, and M >>>>> some equality constraint matrix. I know how to do this via Tao, but my >>>>> question is can Tao handle Mats and Vecs created via DMPlex? Because from >>>>> the SNES and TS examples I have seen in ex12, ex62, and ex11, it seems >>>>> there are solvers tailored to handle DMPlex created data structures. >>>>> >>>> >>>> Yes, TAO can handle objects created by DMPlex since they are just Vec >>>> and Mat structures. The additions >>>> to ex12, ex62, and ex11 concern the callbacks from the solver to the >>>> constructions routines for residual and >>>> Jacobian. Right now, none of the callbacks are automatic for TAO so you >>>> would have to code them yourself, >>>> probably by just calling the routines from SNES or TS so it should not >>>> be that hard. We are working to get >>>> everything integrated as it is in the other solvers. >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> >>>>> Thanks, >>>>> Justin >>>>> >>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their >>>> experiments is infinitely more interesting than any results to which their >>>> experiments lead. >>>> -- Norbert Wiener >>>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 1 16:59:32 2014 From: jed at jedbrown.org (Jed Brown) Date: Fri, 01 Aug 2014 15:59:32 -0600 Subject: [petsc-users] parmetis error when using more than one block per processor in asm In-Reply-To: References: Message-ID: <87silfooqj.fsf@jedbrown.org> Can you turn on debugging (it does more input validation) and attempt to reproduce with a PETSc example or a short test case that you can share with us? -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jychang48 at gmail.com Fri Aug 1 18:01:15 2014 From: jychang48 at gmail.com (Justin Chang) Date: Fri, 1 Aug 2014 17:01:15 -0600 Subject: [petsc-users] DMPlex and Tao In-Reply-To: References: Message-ID: Never mind, I sort of figured it out. What I was kind of looking for was within the DMPlexMatSetClosure(...) function (plex.c). Specifically, these lines and the private functions within: 5383: DMGetWorkArray (dm, numIndices, PETSC_INT, &indices);5384: if (numFields) {5385: for (p = 0; p < numPoints*2; p += 2) {5386: PetscInt o = points[p+1];5387: PetscSectionGetOffset (globalSection, points[p], &globalOff);5388: indicesPointFields_private(section, points[p], globalOff < 0 ? -(globalOff+1) : globalOff, offsets, PETSC_FALSE , o, indices);5389: }5390: } else {5391: for (p = 0, off = 0; p < numPoints*2; p += 2) {5392: PetscInt o = points[p+1];5393: PetscSectionGetOffset (globalSection, points[p], &globalOff);5394: indicesPoint_private(section, points[p], globalOff < 0 ? -(globalOff+1) : globalOff, &off, PETSC_FALSE , o, indices);5395: }5396: } If I understand this part of the code correctly, it returns the global indices based on the global offsets; if a certain global dof happens to be constrained the indices will be negative. All I want is the ability to extract global column indices because each row of my equality constraint matrix will be element specific. Is there an existing function that does something like this, or do I have to write it myself? On Fri, Aug 1, 2014 at 1:40 PM, Matthew Knepley wrote: > On Fri, Aug 1, 2014 at 2:38 PM, Justin Chang wrote: > >> As far as I know this equality constraint should exist outside of the >> large square matrix. >> >> What I was thinking of doing is manually creating an *Nele* by *Ndof* >> matrix, each row will have the same number of non-zeros. Since the size of >> *Ndof* is simply the global number of free dofs formulated by the >> PetscSection, I want to know what's the best way to map the free dofs into >> the global column indices [0 *Ndof*) >> >> For example, in src/dm/impls/plex/examples/tutorials/ex1.c where a box >> mesh with three fields is created, there are a total of 41 dofs to which 8 >> of them are constrained. If no constraints were set, then the size of u >> (i.e. *Ndof*) would be 41, but with constraints set it is 33. When you >> view the constrained global vector u, it lists all the dofs in the order as >> specified by the PetscSection but skips all the constrained ones. Would I >> have to use something like DMSet/GetDefaultGlobalSection to do the mapping? >> > > I do not understand what you are asking. However, you can just use the > PetscSection for the Ndof field to give you > the local sizes for your matrix. > > Matt > > >> Thanks, >> Justin >> >> >> On Fri, Aug 1, 2014 at 7:26 AM, Matthew Knepley >> wrote: >> >>> On Wed, Jul 30, 2014 at 5:01 PM, Justin Chang >>> wrote: >>> >>>> That's good to know thanks. I have another question somewhat related. >>>> >>>> In that quadratic programming problem I have shown earlier, my K matrix >>>> is of global size *Ndof* by *Ndof* where *Ndof* is number of free dofs >>>> (for instance, if I have a 2x2 quadrilateral mesh and want to evaluate >>>> concentration at all the verticies, I will have nine total dofs but if I >>>> have Dirichlet constraints all along the boundary, only my center vertex is >>>> free so *Ndof* = 1. Thus when I simply call DMCreateMatrix(...) it >>>> would give me a 1x1 matrix.) >>>> >>>> However, I want my M constraint matrix to be of size *Nele* by *Ndof* >>>> where *Nele* is the total number of elements. How would I create this >>>> matrix? Because ultimately, I am subjecting all of my free u's to >>>> *Nele* number of equality constraints, and if possible I want this M >>>> matrix to be compatible with the layout from Vec u. >>>> >>> >>> This is not hard in principle. I used to have code that did this, but I >>> took it out during the rewrite because no one >>> was using it and it was complicated. It just generalizes the code in >>> DMPlexPreallocateOperator() to take two >>> PetscSections instead of one. >>> >>> Are you sure that this does not belong inside a large square matrix for >>> the entire problem? >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> >>>> On Wed, Jul 30, 2014 at 2:03 PM, Matthew Knepley >>>> wrote: >>>> >>>>> On Wed, Jul 30, 2014 at 2:53 PM, Justin Chang >>>>> wrote: >>>>> >>>>>> Hi, >>>>>> >>>>>> This might be a silly question, but I am developing a finite element >>>>>> code to solve the non-negative diffusion equation. I am using the DMPlex >>>>>> structure and plan on subjecting the problem to a bounded constraint >>>>>> optimization to ensure non-negative concentrations. Say for instance, I >>>>>> want to solve: >>>>>> >>>>>> min || K*u - F ||^2 >>>>>> subject to u >= 0 >>>>>> M*u = 0 >>>>>> >>>>>> Where K is the Jacobian, F the residual, u the concentration, and M >>>>>> some equality constraint matrix. I know how to do this via Tao, but my >>>>>> question is can Tao handle Mats and Vecs created via DMPlex? Because from >>>>>> the SNES and TS examples I have seen in ex12, ex62, and ex11, it seems >>>>>> there are solvers tailored to handle DMPlex created data structures. >>>>>> >>>>> >>>>> Yes, TAO can handle objects created by DMPlex since they are just Vec >>>>> and Mat structures. The additions >>>>> to ex12, ex62, and ex11 concern the callbacks from the solver to the >>>>> constructions routines for residual and >>>>> Jacobian. Right now, none of the callbacks are automatic for TAO so >>>>> you would have to code them yourself, >>>>> probably by just calling the routines from SNES or TS so it should not >>>>> be that hard. We are working to get >>>>> everything integrated as it is in the other solvers. >>>>> >>>>> Thanks, >>>>> >>>>> Matt >>>>> >>>>> >>>>>> Thanks, >>>>>> Justin >>>>>> >>>>> >>>>> >>>>> >>>>> -- >>>>> What most experimenters take for granted before they begin their >>>>> experiments is infinitely more interesting than any results to which their >>>>> experiments lead. >>>>> -- Norbert Wiener >>>>> >>>> >>>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 1 20:37:54 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 1 Aug 2014 20:37:54 -0500 Subject: [petsc-users] DMPlex and Tao In-Reply-To: References: Message-ID: On Fri, Aug 1, 2014 at 6:01 PM, Justin Chang wrote: > Never mind, I sort of figured it out. What I was kind of looking for was > within the DMPlexMatSetClosure(...) function (plex.c). Specifically, these > lines and the private functions within: > > 5383: DMGetWorkArray (dm, numIndices, PETSC_INT, &indices);5384: if (numFields) {5385: for (p = 0; p < numPoints*2; p += 2) {5386: PetscInt o = points[p+1];5387: PetscSectionGetOffset (globalSection, points[p], &globalOff);5388: indicesPointFields_private(section, points[p], globalOff < 0 ? -(globalOff+1) : globalOff, offsets, PETSC_FALSE , o, indices);5389: }5390: } else {5391: for (p = 0, off = 0; p < numPoints*2; p += 2) {5392: PetscInt o = points[p+1];5393: PetscSectionGetOffset (globalSection, points[p], &globalOff);5394: indicesPoint_private(section, points[p], globalOff < 0 ? -(globalOff+1) : globalOff, &off, PETSC_FALSE , o, indices);5395: }5396: } > > If I understand this part of the code correctly, it returns the global indices based on the global offsets; if a certain global dof happens to be constrained the indices will be negative. All I want is the ability to extract global column indices because each row of my equality constraint matrix will be element specific. Is there an existing function that does something like this, or do I have to write it myself? > > I think you have to write that one yourself. The closest function is probably PetscErrorCode DMPlexMatGetClosureIndicesRefined(DM dmf, PetscSection fsection, PetscSection globalFSection, DM dmc, PetscSection csection, PetscSection globalCSection, PetscInt point, PetscInt cindices[], PetscInt findices[]) Matt > On Fri, Aug 1, 2014 at 1:40 PM, Matthew Knepley wrote: > >> On Fri, Aug 1, 2014 at 2:38 PM, Justin Chang wrote: >> >>> As far as I know this equality constraint should exist outside of the >>> large square matrix. >>> >>> What I was thinking of doing is manually creating an *Nele* by *Ndof* >>> matrix, each row will have the same number of non-zeros. Since the size of >>> *Ndof* is simply the global number of free dofs formulated by the >>> PetscSection, I want to know what's the best way to map the free dofs into >>> the global column indices [0 *Ndof*) >>> >>> For example, in src/dm/impls/plex/examples/tutorials/ex1.c where a box >>> mesh with three fields is created, there are a total of 41 dofs to which 8 >>> of them are constrained. If no constraints were set, then the size of u >>> (i.e. *Ndof*) would be 41, but with constraints set it is 33. When you >>> view the constrained global vector u, it lists all the dofs in the order as >>> specified by the PetscSection but skips all the constrained ones. Would I >>> have to use something like DMSet/GetDefaultGlobalSection to do the mapping? >>> >> >> I do not understand what you are asking. However, you can just use the >> PetscSection for the Ndof field to give you >> the local sizes for your matrix. >> >> Matt >> >> >>> Thanks, >>> Justin >>> >>> >>> On Fri, Aug 1, 2014 at 7:26 AM, Matthew Knepley >>> wrote: >>> >>>> On Wed, Jul 30, 2014 at 5:01 PM, Justin Chang >>>> wrote: >>>> >>>>> That's good to know thanks. I have another question somewhat related. >>>>> >>>>> In that quadratic programming problem I have shown earlier, my K >>>>> matrix is of global size *Ndof* by *Ndof* where *Ndof* is number of >>>>> free dofs (for instance, if I have a 2x2 quadrilateral mesh and want to >>>>> evaluate concentration at all the verticies, I will have nine total dofs >>>>> but if I have Dirichlet constraints all along the boundary, only my center >>>>> vertex is free so *Ndof* = 1. Thus when I simply call >>>>> DMCreateMatrix(...) it would give me a 1x1 matrix.) >>>>> >>>>> However, I want my M constraint matrix to be of size *Nele* by *Ndof* >>>>> where *Nele* is the total number of elements. How would I create this >>>>> matrix? Because ultimately, I am subjecting all of my free u's to >>>>> *Nele* number of equality constraints, and if possible I want this M >>>>> matrix to be compatible with the layout from Vec u. >>>>> >>>> >>>> This is not hard in principle. I used to have code that did this, but I >>>> took it out during the rewrite because no one >>>> was using it and it was complicated. It just generalizes the code in >>>> DMPlexPreallocateOperator() to take two >>>> PetscSections instead of one. >>>> >>>> Are you sure that this does not belong inside a large square matrix for >>>> the entire problem? >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> >>>>> >>>>> On Wed, Jul 30, 2014 at 2:03 PM, Matthew Knepley >>>>> wrote: >>>>> >>>>>> On Wed, Jul 30, 2014 at 2:53 PM, Justin Chang >>>>>> wrote: >>>>>> >>>>>>> Hi, >>>>>>> >>>>>>> This might be a silly question, but I am developing a finite element >>>>>>> code to solve the non-negative diffusion equation. I am using the DMPlex >>>>>>> structure and plan on subjecting the problem to a bounded constraint >>>>>>> optimization to ensure non-negative concentrations. Say for instance, I >>>>>>> want to solve: >>>>>>> >>>>>>> min || K*u - F ||^2 >>>>>>> subject to u >= 0 >>>>>>> M*u = 0 >>>>>>> >>>>>>> Where K is the Jacobian, F the residual, u the concentration, and M >>>>>>> some equality constraint matrix. I know how to do this via Tao, but my >>>>>>> question is can Tao handle Mats and Vecs created via DMPlex? Because from >>>>>>> the SNES and TS examples I have seen in ex12, ex62, and ex11, it seems >>>>>>> there are solvers tailored to handle DMPlex created data structures. >>>>>>> >>>>>> >>>>>> Yes, TAO can handle objects created by DMPlex since they are just Vec >>>>>> and Mat structures. The additions >>>>>> to ex12, ex62, and ex11 concern the callbacks from the solver to the >>>>>> constructions routines for residual and >>>>>> Jacobian. Right now, none of the callbacks are automatic for TAO so >>>>>> you would have to code them yourself, >>>>>> probably by just calling the routines from SNES or TS so it should >>>>>> not be that hard. We are working to get >>>>>> everything integrated as it is in the other solvers. >>>>>> >>>>>> Thanks, >>>>>> >>>>>> Matt >>>>>> >>>>>> >>>>>>> Thanks, >>>>>>> Justin >>>>>>> >>>>>> >>>>>> >>>>>> >>>>>> -- >>>>>> What most experimenters take for granted before they begin their >>>>>> experiments is infinitely more interesting than any results to which their >>>>>> experiments lead. >>>>>> -- Norbert Wiener >>>>>> >>>>> >>>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their >>>> experiments is infinitely more interesting than any results to which their >>>> experiments lead. >>>> -- Norbert Wiener >>>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From hus003 at ucsd.edu Sat Aug 2 01:03:29 2014 From: hus003 at ucsd.edu (Sun, Hui) Date: Sat, 2 Aug 2014 06:03:29 +0000 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? Message-ID: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> Hello, The PETSC_VIEWER_BINARY_ command is supposed to create a binary Petsc Viewer, then MatView VecView suppose to add matrices and vectors to the binary output file. However, it seems that the viewer gives different output if you use different number of processors. Below is a more detailed description of the problem from an example. In test example snes/examples/tutorial/ex70.c, I add the following command to the StokesWriteSolution function: PetscViewer viewer = PETSC_VIEWER_BINARY_(PETSC_COMM_WORLD); MatView(s->subA[0],viewer); MatView(s->subA[1],viewer); MatView(s->subA[2],viewer); MatView(s->subA[3],viewer); VecView(s->x,viewer); VecView(s->b,viewer); VecView(s->y,viewer); Now I run make ex70 to compile the code, and run the code with the options -@${MPIEXEC} -n 4 ./ex70 -nx 100 -ny 100 -pc_type fieldsplit -fieldsplit_0_pc_type jacobi -fieldsplit_1_pc_type jacobi -pc_fieldsplit_type SCHUR -ksp_monitor_short -ksp_converged_reason -ksp_rtol 1e1 -fieldsplit_1_ksp_rtol 1e-2 -fieldsplit_0_ksp_rtol 1e-4 -fieldsplit_1_ksp_max_it 100 -fieldsplit_0_ksp_max_it 1000 -ksp_type fgmres Here you can see I have 4 processors running at the same time. I read in the output from MATLAB using the command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). And I visualize the variable y by the commands: mesh(reshape(y(20001:30000),100,100)) mesh(reshape(y(10001:20000),100,100)) mesh(reshape(y(1:10000),100,100)) The output plots are different from what I get if I use 1 processor. Best, Hui -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sat Aug 2 01:15:10 2014 From: jed at jedbrown.org (Jed Brown) Date: Sat, 02 Aug 2014 00:15:10 -0600 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> Message-ID: <871tszo1sh.fsf@jedbrown.org> "Sun, Hui" writes: > Here you can see I have 4 processors running at the same time. I read in the output from MATLAB using the > > command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). > > > And I visualize the variable y by the commands: > > mesh(reshape(y(20001:30000),100,100)) > > mesh(reshape(y(10001:20000),100,100)) > > mesh(reshape(y(1:10000),100,100)) > > > The output plots are different from what I get if I use 1 processor. This example uses a simple decomposition, not what you use above. Note that this example was contributed and we do not endorse it as recommended practice. If your code is already set up very much like this, it may be worth looking at, but don't write new code in this way because it is algorithmically constraining. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From hus003 at ucsd.edu Sat Aug 2 11:17:23 2014 From: hus003 at ucsd.edu (Sun, Hui) Date: Sat, 2 Aug 2014 16:17:23 +0000 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: <871tszo1sh.fsf@jedbrown.org> References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU>, <871tszo1sh.fsf@jedbrown.org> Message-ID: <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU> I do have my code set up based on ex70. The reason I do this is that I need to use fieldsplit and schur complement. I can't find other examples doing that, except ex55 and ex70, however I have a hard time get ex55 running. I don't understand what you said about "This example uses a simple decomposition, not what you use above". What do you mean by "simple decomposition"? ________________________________________ From: Jed Brown [jed at jedbrown.org] Sent: Friday, August 01, 2014 11:15 PM To: Sun, Hui; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? "Sun, Hui" writes: > Here you can see I have 4 processors running at the same time. I read in the output from MATLAB using the > > command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). > > > And I visualize the variable y by the commands: > > mesh(reshape(y(20001:30000),100,100)) > > mesh(reshape(y(10001:20000),100,100)) > > mesh(reshape(y(1:10000),100,100)) > > > The output plots are different from what I get if I use 1 processor. This example uses a simple decomposition, not what you use above. Note that this example was contributed and we do not endorse it as recommended practice. If your code is already set up very much like this, it may be worth looking at, but don't write new code in this way because it is algorithmically constraining. From knepley at gmail.com Sat Aug 2 11:51:47 2014 From: knepley at gmail.com (Matthew Knepley) Date: Sat, 2 Aug 2014 11:51:47 -0500 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU> References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> <871tszo1sh.fsf@jedbrown.org> <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU> Message-ID: On Sat, Aug 2, 2014 at 11:17 AM, Sun, Hui wrote: > I do have my code set up based on ex70. The reason I do this is that I > need to use fieldsplit and schur complement. I can't find other examples > doing that, except ex55 and ex70, however I have a hard time get ex55 > running. > > I don't understand what you said about "This example uses a simple > decomposition, not what you use above". What do you mean by "simple > decomposition"? > I use FieldSplit and schur on SNES ex62. Matt > ________________________________________ > From: Jed Brown [jed at jedbrown.org] > Sent: Friday, August 01, 2014 11:15 PM > To: Sun, Hui; petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? > > "Sun, Hui" writes: > > Here you can see I have 4 processors running at the same time. I read in > the output from MATLAB using the > > > > command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). > > > > > > And I visualize the variable y by the commands: > > > > mesh(reshape(y(20001:30000),100,100)) > > > > mesh(reshape(y(10001:20000),100,100)) > > > > mesh(reshape(y(1:10000),100,100)) > > > > > > The output plots are different from what I get if I use 1 processor. > > This example uses a simple decomposition, not what you use above. > > Note that this example was contributed and we do not endorse it as > recommended practice. If your code is already set up very much like > this, it may be worth looking at, but don't write new code in this way > because it is algorithmically constraining. > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From hus003 at ucsd.edu Sat Aug 2 11:56:41 2014 From: hus003 at ucsd.edu (Sun, Hui) Date: Sat, 2 Aug 2014 16:56:41 +0000 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> <871tszo1sh.fsf@jedbrown.org> <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU>, Message-ID: <7501CC2B7BBCC44A92ECEEC316170ECB6CD50F@XMAIL-MBX-BH1.AD.UCSD.EDU> That's true. But I'm using finite difference. Best, Hui ________________________________ From: Matthew Knepley [knepley at gmail.com] Sent: Saturday, August 02, 2014 9:51 AM To: Sun, Hui Cc: Jed Brown; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? On Sat, Aug 2, 2014 at 11:17 AM, Sun, Hui > wrote: I do have my code set up based on ex70. The reason I do this is that I need to use fieldsplit and schur complement. I can't find other examples doing that, except ex55 and ex70, however I have a hard time get ex55 running. I don't understand what you said about "This example uses a simple decomposition, not what you use above". What do you mean by "simple decomposition"? I use FieldSplit and schur on SNES ex62. Matt ________________________________________ From: Jed Brown [jed at jedbrown.org] Sent: Friday, August 01, 2014 11:15 PM To: Sun, Hui; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? "Sun, Hui" > writes: > Here you can see I have 4 processors running at the same time. I read in the output from MATLAB using the > > command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). > > > And I visualize the variable y by the commands: > > mesh(reshape(y(20001:30000),100,100)) > > mesh(reshape(y(10001:20000),100,100)) > > mesh(reshape(y(1:10000),100,100)) > > > The output plots are different from what I get if I use 1 processor. This example uses a simple decomposition, not what you use above. Note that this example was contributed and we do not endorse it as recommended practice. If your code is already set up very much like this, it may be worth looking at, but don't write new code in this way because it is algorithmically constraining. -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From hus003 at ucsd.edu Sat Aug 2 12:33:55 2014 From: hus003 at ucsd.edu (Sun, Hui) Date: Sat, 2 Aug 2014 17:33:55 +0000 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: <7501CC2B7BBCC44A92ECEEC316170ECB6CD50F@XMAIL-MBX-BH1.AD.UCSD.EDU> References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> <871tszo1sh.fsf@jedbrown.org> <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU>, , <7501CC2B7BBCC44A92ECEEC316170ECB6CD50F@XMAIL-MBX-BH1.AD.UCSD.EDU> Message-ID: <7501CC2B7BBCC44A92ECEEC316170ECB6CD520@XMAIL-MBX-BH1.AD.UCSD.EDU> I have just tested the PETSC_VIEW_BINARY_ on other test codes, they all work pretty well with multiple processors. Maybe I shouldn't be using ex70.c as a template any more. Best, Hui ________________________________ From: Sun, Hui Sent: Saturday, August 02, 2014 9:56 AM To: Matthew Knepley Cc: Jed Brown; petsc-users at mcs.anl.gov Subject: RE: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? That's true. But I'm using finite difference. Best, Hui ________________________________ From: Matthew Knepley [knepley at gmail.com] Sent: Saturday, August 02, 2014 9:51 AM To: Sun, Hui Cc: Jed Brown; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? On Sat, Aug 2, 2014 at 11:17 AM, Sun, Hui > wrote: I do have my code set up based on ex70. The reason I do this is that I need to use fieldsplit and schur complement. I can't find other examples doing that, except ex55 and ex70, however I have a hard time get ex55 running. I don't understand what you said about "This example uses a simple decomposition, not what you use above". What do you mean by "simple decomposition"? I use FieldSplit and schur on SNES ex62. Matt ________________________________________ From: Jed Brown [jed at jedbrown.org] Sent: Friday, August 01, 2014 11:15 PM To: Sun, Hui; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? "Sun, Hui" > writes: > Here you can see I have 4 processors running at the same time. I read in the output from MATLAB using the > > command [A,B,C,D,x,b,y] = PetscBinaryRead('binaryoutput'). > > > And I visualize the variable y by the commands: > > mesh(reshape(y(20001:30000),100,100)) > > mesh(reshape(y(10001:20000),100,100)) > > mesh(reshape(y(1:10000),100,100)) > > > The output plots are different from what I get if I use 1 processor. This example uses a simple decomposition, not what you use above. Note that this example was contributed and we do not endorse it as recommended practice. If your code is already set up very much like this, it may be worth looking at, but don't write new code in this way because it is algorithmically constraining. -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sat Aug 2 12:59:17 2014 From: jed at jedbrown.org (Jed Brown) Date: Sat, 02 Aug 2014 11:59:17 -0600 Subject: [petsc-users] Some possible bugs with PETSC_VIEWER_BINARY_? In-Reply-To: <7501CC2B7BBCC44A92ECEEC316170ECB6CD520@XMAIL-MBX-BH1.AD.UCSD.EDU> References: <7501CC2B7BBCC44A92ECEEC316170ECB6CC4CF@XMAIL-MBX-BH1.AD.UCSD.EDU> <871tszo1sh.fsf@jedbrown.org> <7501CC2B7BBCC44A92ECEEC316170ECB6CD4FD@XMAIL-MBX-BH1.AD.UCSD.EDU> <7501CC2B7BBCC44A92ECEEC316170ECB6CD50F@XMAIL-MBX-BH1.AD.UCSD.EDU> <7501CC2B7BBCC44A92ECEEC316170ECB6CD520@XMAIL-MBX-BH1.AD.UCSD.EDU> Message-ID: <87k36qn56y.fsf@jedbrown.org> "Sun, Hui" writes: > I have just tested the PETSC_VIEW_BINARY_ on other test codes, they > all work pretty well with multiple processors. Maybe I shouldn't be > using ex70.c as a template any more. I strongly suggest not using it as a template for decomposition or for assembling solvers. If you want to assemble in "blocks", look at src/snes/examples/tests/ex28.c. Also, if you want a structured grid, do consider using DMDA instead of rolling your own spatial decomposition (it will be simpler code, more flexible, and easier to debug because orderings like you mention will work as expected). -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From rlmackie862 at gmail.com Sat Aug 2 14:20:44 2014 From: rlmackie862 at gmail.com (Randall Mackie) Date: Sat, 2 Aug 2014 12:20:44 -0700 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 Message-ID: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: [rmackie ~/tst_petsc_problem] ./cmd_test ==24812== Invalid read of size 1 ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) ==24812== by 0x400F28: MAIN__ (test.F90:11) ==24812== by 0x400F9A: main (test.F90:16) ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) ==24812== by 0x400EFD: MAIN__ (test.F90:11) ==24812== by 0x400F9A: main (test.F90:16) ==24812== The program was compiled with PETSc V3.5.1 and --download-mpich. The same program compiled with V3.4.4 and --download-mpich does not give these errors. It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. Program, configure commands, etc, attached. Randy M. -------------- next part -------------- A non-text attachment was scrubbed... Name: makefile Type: application/octet-stream Size: 350 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: test.F90 Type: application/octet-stream Size: 274 bytes Desc: not available URL: -------------- next part -------------- An embedded and charset-unspecified text was scrubbed... Name: valgrind_out.txt URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: cmd_configure Type: application/octet-stream Size: 202 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: cmd_test Type: application/octet-stream Size: 176 bytes Desc: not available URL: From pascal.paschos at northwestern.edu Sun Aug 3 22:40:16 2014 From: pascal.paschos at northwestern.edu (Pascal Paschos) Date: Mon, 4 Aug 2014 03:40:16 +0000 Subject: [petsc-users] 3.5.1 fail with mumps Message-ID: Hi, I've already seen a thread where someone recently was trying to build with mumps and was failing at test. The recommendation that seemed to have worked for that user, at least on this point, was a fresh install and shared libraries off. Well, I am having the same problem with 3.5.1 with the same error message he was getting. The build can not interpret symbols in some mumps and parmetis references. Whether shared libraries is set to 0 or 1 is irrelevant, at least in my case. The problem persists. The error messages are in the bottom of this post. And yes, all packages are there, otherwise petsc would not build in the first place. It fails a test with an error message that is typical of the build missing some include files that it expects to have present. Without mumps - metis & parmetis - the install is fine and tests complete fine. So, I guess I am wondering if the developers have any more insight to spare... Thanks. Here is my configure: ./configure --prefix=/software/petsc/3.5.1.1 \ --with-blas-lib=/software/lapack/3.5.0/lib/libblas.so --with-lapack-lib=/software/lapack/3.5.0/liblapack.so \ --with-hdf5=1 --with-hdf5-dir=/software/hdf5/1.8.10 \ --with-valgrind=1 --with-valgrind-dir=/software/valgrind/3.8.1 \ --with-boost=1 --with-boost-dir=/software/boost/1.41.0 \ --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 \ --with-debugging=1 \ --download-fftw=yes \ --download-scalapack=yes \ --download-mumps=yes \ --download-parmetis=yes \ --download-metis=yes \ --CFLAGS="-I/usr/include -I/usr/include/openssl" \ --LDFLAGS=" -L/usr/lib64" \ --LDLIBS=" -lcrypto -lssl" \ --with-shared-libraries=0 I found it necessary to pass references to libssl to the linker because otherwise the make is then complaining with an SSL related issue, that it can not find some include file. make PETSC_DIR=/software/petsc/3.5.1.1 test Running test examples to verify correct installation Using PETSC_DIR=/software/petsc/3.5.1.1 and PETSC_ARCH=arch-linux2-c-debug *******************Error detected during compile or link!******************* See http://www.mcs.anl.gov/petsc/documentation/faq.html /software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials ex19 ********************************************************************************* *********************W-a-r-n-i-n-g************************* Your PETSC_DIR may not match the directory you are in PETSC_DIR /software/petsc/3.5.1.1 Current directory /software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials Ignore this if you are running make test ****************************************************** mpicc -o ex19.o -c -I/usr/include -I/usr/include/openssl -g3 -O0 -I/software/petsc/3.5.1.1/include -I/software/petsc/3.5.1.1/include -I/software/valgrind/3.8.1/include -I/software/hdf5/1.8.10/include -I/software/boost/1.41.0/include -I/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/include `pwd`/ex19.c mpicc -I/usr/include -I/usr/include/openssl -g3 -O0 -o ex19 ex19.o -L/software/petsc/3.5.1.1/lib -lpetsc -Wl,-rpath,/software/petsc/3.5.1.1/lib -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack -Wl,-rpath,/software/lapack/3.5.0 -L/software/lapack/3.5.0 -llapack -Wl,-rpath,/software/lapack/3.5.0/lib -L/software/lapack/3.5.0/lib -lblas -lparmetis -lmetis -lX11 -lssl -lcrypto -lpthread -lfftw3_mpi -lfftw3 -Wl,-rpath,/software/hdf5/1.8.10/lib -L/software/hdf5/1.8.10/lib -lhdf5_fortran -lhdf5_hl -lhdf5 -L/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/lib64 -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc/x86_64-unknown-linux-gnu/4.6.3 -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc -L/hpc/software/gcc/4.6.3-rhel6/lib64 -L/hpc/software/gcc/4.6.3-rhel6/lib -lmpi_f90 -lmpi_f77 -lgfortran -lm -lgfortran -lm -lgfortran -lm -lgfortran -lm -lquadmath -lm -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s -lpthread -ldl /software/petsc/3.5.1.1/lib/libpetsc.a(baij.o): In function `MatCreate_SeqBAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/seq/baij.c:3006: undefined reference to `MatGetFactor_baij_mumps's' /software/petsc/3.5.1.1/lib/libpetsc.a(mpibaij.o): In function `MatCreate_MPIBAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/mpi/mpibaij.c:3049: undefined reference to `MatGetFactor_baij_mumps' /software/petsc/3.5.1.1/lib/libpetsc.a(sbaij.o): In function `MatCreate_SeqSBAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/seq/sbaij.c:1966: undefined reference to `MatGetFactor_sbaij_mumps' /software/petsc/3.5.1.1/lib/libpetsc.a(mpisbaij.o): In function `MatCreate_MPISBAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/mpi/mpisbaij.c:1803: undefined reference to `MatGetFactor_sbaij_mumps' /software/petsc/3.5.1.1/lib/libpetsc.a(aij.o): In function `MatCreate_SeqAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/seq/aij.c:4136: undefined reference to `MatGetFactor_aij_mumps' /software/petsc/3.5.1.1/lib/libpetsc.a(mpiaij.o): In function `MatCreate_MPIAIJ': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/mpi/mpiaij.c:5578: undefined reference to `MatGetFactor_aij_mumps' /software/petsc/3.5.1.1/lib/libpetsc.a(spartition.o): In function `MatPartitioningRegisterAll': /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/partition/spartition.c:45: undefined reference to `MatPartitioningCreate_Parmetis' -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 4 00:35:20 2014 From: jed at jedbrown.org (Jed Brown) Date: Sun, 03 Aug 2014 23:35:20 -0600 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 In-Reply-To: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> References: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> Message-ID: <87fvhckeav.fsf@jedbrown.org> Randall Mackie writes: > The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: > > [rmackie ~/tst_petsc_problem] ./cmd_test > ==24812== Invalid read of size 1 > ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24812== by 0x400F28: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd Barry, this looks like you making PetscStrncpy behave unlike strncpy. https://bitbucket.org/petsc/petsc/commits/ff32304b6c2c50401fe7ef46e45693a4318e17f0 I'll note that I dislike having functions named after standard C functions, but with different behavior (e.g., PetscStrcmp and PetscStrncpy). If you really want these different semantics, I'd rather have different names. > ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x400EFD: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== > > > The program was compiled with PETSc V3.5.1 and --download-mpich. > > The same program compiled with V3.4.4 and --download-mpich does not give these errors. > > It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. > I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. > > Program, configure commands, etc, attached. > > Randy M. > > > [rmackie ~/tst_petsc_problem] ./cmd_test > ==24812== Invalid read of size 1 > ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24812== by 0x400F28: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd > ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x400EFD: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== > ==24814== Invalid read of size 1 > ==24814== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24814== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24814== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24814== by 0x400F28: MAIN__ (test.F90:11) > ==24814== by 0x400F9A: main (test.F90:16) > ==24814== Address 0x8cef5ab is 0 bytes after a block of size 11 alloc'd > ==24814== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24814== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24814== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24814== by 0x400EFD: MAIN__ (test.F90:11) > ==24814== by 0x400F9A: main (test.F90:16) > ==24814== > ==24815== Invalid read of size 1 > ==24815== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24815== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24815== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24815== by 0x400F28: MAIN__ (test.F90:11) > ==24815== by 0x400F9A: main (test.F90:16) > ==24815== Address 0x8cef51b is 0 bytes after a block of size 11 alloc'd > ==24815== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24815== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24815== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24815== by 0x400EFD: MAIN__ (test.F90:11) > ==24815== by 0x400F9A: main (test.F90:16) > ==24815== > ==24813== Invalid read of size 1 > ==24813== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24813== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24813== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24813== by 0x400F28: MAIN__ (test.F90:11) > ==24813== by 0x400F9A: main (test.F90:16) > ==24813== Address 0x8cef51b is 0 bytes after a block of size 11 alloc'd > ==24813== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24813== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24813== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24813== by 0x400EFD: MAIN__ (test.F90:11) > ==24813== by 0x400F9A: main (test.F90:16) > ==24813== -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From knepley at gmail.com Mon Aug 4 06:47:39 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 4 Aug 2014 06:47:39 -0500 Subject: [petsc-users] 3.5.1 fail with mumps In-Reply-To: References: Message-ID: Can you send make.log and configure.log? Thanks, Matt On Sun, Aug 3, 2014 at 10:40 PM, Pascal Paschos < pascal.paschos at northwestern.edu> wrote: > Hi, > > I've already seen a thread where someone recently was trying to build > with mumps and was failing at test. > The recommendation that seemed to have worked for that user, at least on > this point, was > a fresh install and shared libraries off. Well, I am having the same > problem with 3.5.1 with the same error message he was getting. > The build can not interpret symbols in some mumps and parmetis references. > Whether shared libraries is set to 0 or 1 is irrelevant, at least in my > case. The problem persists. > The error messages are in the bottom of this post. > And yes, all packages are there, otherwise petsc would not build in the > first place. It fails a test with an error message that is > typical of the build missing some include files that it expects to have > present. > Without mumps - metis & parmetis - the install is fine and tests complete > fine. > So, I guess I am wondering if the developers have any more insight to > spare... > Thanks. > > Here is my configure: > > ./configure --prefix=/software/petsc/3.5.1.1 \ > > --with-blas-lib=/software/lapack/3.5.0/lib/libblas.so > --with-lapack-lib=/software/lapack/3.5.0/liblapack.so \ > > --with-hdf5=1 --with-hdf5-dir=/software/hdf5/1.8.10 \ > > --with-valgrind=1 --with-valgrind-dir=/software/valgrind/3.8.1 \ > > --with-boost=1 --with-boost-dir=/software/boost/1.41.0 \ > > --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 \ > > --with-debugging=1 \ > > --download-fftw=yes \ > > --download-scalapack=yes \ > > --download-mumps=yes \ > > --download-parmetis=yes \ > > --download-metis=yes \ > > --CFLAGS="-I/usr/include -I/usr/include/openssl" \ > > --LDFLAGS=" -L/usr/lib64" \ > > --LDLIBS=" -lcrypto -lssl" \ > > --with-shared-libraries=0 > > > I found it necessary to pass references to libssl to the linker because > otherwise the make is then complaining with an SSL related issue, that it > can not find some include file. > > > > make PETSC_DIR=/software/petsc/3.5.1.1 test > > Running test examples to verify correct installation > > Using PETSC_DIR=/software/petsc/3.5.1.1 and PETSC_ARCH=arch-linux2-c-debug > > ********************Error detected during compile or > link!******************** > > *See http://www.mcs.anl.gov/petsc/documentation/faq.html > * > > */software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials > ex19* > > > *********************************************************************************** > > **********************W-a-r-n-i-n-g************************** > > *Your PETSC_DIR may not match the directory you are in* > > *PETSC_DIR /software/petsc/3.5.1.1 Current directory > /software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials* > > *Ignore this if you are running make test * > > ******************************************************** > > mpicc -o ex19.o -c -I/usr/include -I/usr/include/openssl -g3 -O0 > -I/software/petsc/3.5.1.1/include -I/software/petsc/3.5.1.1/include > -I/software/valgrind/3.8.1/include -I/software/hdf5/1.8.10/include > -I/software/boost/1.41.0/include > -I/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/include `pwd`/ex19.c > > mpicc -I/usr/include -I/usr/include/openssl -g3 -O0 -o ex19 ex19.o > -L/software/petsc/3.5.1.1/lib -lpetsc -Wl,-rpath,/software/petsc/ > 3.5.1.1/lib -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord > -lscalapack -Wl,-rpath,/software/lapack/3.5.0 -L/software/lapack/3.5.0 > -llapack -Wl,-rpath,/software/lapack/3.5.0/lib -L/software/lapack/3.5.0/lib > -lblas -lparmetis -lmetis -lX11 -lssl -lcrypto -lpthread -lfftw3_mpi > -lfftw3 -Wl,-rpath,/software/hdf5/1.8.10/lib -L/software/hdf5/1.8.10/lib > -lhdf5_fortran -lhdf5_hl -lhdf5 > -L/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/lib64 > -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc/x86_64-unknown-linux-gnu/4.6.3 > -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc > -L/hpc/software/gcc/4.6.3-rhel6/lib64 -L/hpc/software/gcc/4.6.3-rhel6/lib > -lmpi_f90 -lmpi_f77 -lgfortran -lm -lgfortran -lm -lgfortran -lm -lgfortran > -lm -lquadmath -lm -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil > -lgcc_s -lpthread -ldl > > /software/petsc/3.5.1.1/lib/libpetsc.a(baij.o): In function > `MatCreate_SeqBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/seq/baij.c:3006: > undefined reference to `MatGetFactor_baij_mumps's' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpibaij.o): In function > `MatCreate_MPIBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/mpi/mpibaij.c:3049: > undefined reference to `MatGetFactor_baij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(sbaij.o): In function > `MatCreate_SeqSBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/seq/sbaij.c:1966: > undefined reference to `MatGetFactor_sbaij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpisbaij.o): In function > `MatCreate_MPISBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/mpi/mpisbaij.c:1803: > undefined reference to `MatGetFactor_sbaij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(aij.o): In function > `MatCreate_SeqAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/seq/aij.c:4136: > undefined reference to `MatGetFactor_aij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpiaij.o): In function > `MatCreate_MPIAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/mpi/mpiaij.c:5578: > undefined reference to `MatGetFactor_aij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(spartition.o): In function > `MatPartitioningRegisterAll': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/partition/spartition.c:45: > undefined reference to `MatPartitioningCreate_Parmetis' > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From info at xerxesdvds.com Mon Aug 4 08:26:27 2014 From: info at xerxesdvds.com (Xerxes DVDs) Date: Mon, 04 Aug 2014 06:26:27 -0700 Subject: [petsc-users] Welcome to the Xerxes DVDs Grand Opening! Message-ID: <53df8a0356250_41a0f7de9c11504871@prd-nresque01.sf.verticalresponse.com.mail> View Online ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vZW1haWxzLzc2OTY1ODE0MDY1NDc_Y29udGFjdF9pZD03Njk2NTg0OTYxOTk5/lznNhdOYNodjPQBpkkiaKQ==&merge_field_type=%7BVR_HOSTED_LINK%7D ) Welcome To The Xerxes DVDs Grand Opening! ??Xerxes DVDs is indeed a Cinephile Delight dedicated solely to the Cinephile Completists out there looking to fill in the voids in their collections. ?Many titles have been added to the site for its Grand Opening and there are many, many more to be added. ?Please let me know which titles you require for your collections. ?I have spent the better part of my life collection seriously obscure movies, so I think I can really help you.? Here is a sample of the titles available. ?Just click on the movie title to read more about it at the website.Atlantic City (1944) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9hdGxhbnRpYy1jaXR5LTE5NDQtZHZkLw==/79tTzZoCLi78Fh3XFT0OhA==&merge_field_type=(?x-mi:(?%3C=href=)[ )Broadway Thru A Keyhole (1933) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9icm9hZHdheS10aHJ1LWEta2V5aG9sZS0xOTMzLWR2ZC8=/8M-XgeGeZuq9-rkl5w4SCQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Cthulhu Mansion (1992) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9jdGh1bGh1LW1hbnNpb24tMTk5Mi1kdmQv/mvRFBSThgNmV6FBRueJrzw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Dracula's Widow (1988) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9kcmFjdWxhcy13aWRvdy0xOTg4LWR2ZC8=/xjBX53g4L1efKa5jGUu3HQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Eve Knew Her Apples (1945) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9ldmUta25ldy1oZXItYXBwbGVzLTE5NDUtZHZkLw==/ISxxsgvM6GxGUh7Dn1r0tQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Fury At Showdown (1957) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9mdXJ5LWF0LXNob3dkb3duLTE5NTctZHZkLw==/BLbKybPJySkYI62lrXgrkQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Guilty Bystander (1950) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9ndWlsdHktYnlzdGFuZGVyLTE5NTAtZHZkLw==/D6wYnU0M8pqBOuC357eDJQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Hot Spell (1958) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9ob3Qtc3BlbGwtMTk1OC1kdmQv/tHc-hW6rQg4azOXJQj51aA==&merge_field_type=(?x-mi:(?%3C=href=)[ )It's All Yours (1937) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9pdHMtYWxsLXlvdXJzLTE5MzctZHZkLw==/-q86SIivdNZIgUjeFz22ww==&merge_field_type=(?x-mi:(?%3C=href=)[ )Journey To Midnight (1968) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9qb3VybmV5LXRvLW1pZG5pZ2h0LTE5NjgtZHZkLw==/606rvyF3pVht9Patul0xcQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Killers of Kilimanjaro (1959) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9raWxsZXJzLW9mLWtpbGltYW5qYXJvLTE5NTktZHZkLw==/UDTPz2bGn8XxmHNnKdI-aQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Loss of Innocence (1961) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9sb3NzLW9mLWlubm9jZW5jZS0xOTYxLWR2ZC8=/r6quFSK-snXZsKj_jznX-A==&merge_field_type=(?x-mi:(?%3C=href=)[ )My Sin (1931) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9teS1zaW4tMTkzMS1kdmQv/m6sKPka5OeuDoKRm31GZuQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )North West Mounted Police (1940) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9ub3J0aC13ZXN0LW1vdW50ZWQtcG9saWNlLTE5NDAtZHZkLw==/QCfZ2qscM_eAwH-n6b_OWg==&merge_field_type=(?x-mi:(?%3C=href=)[ )Ordeal (1973) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9vcmRlYWwtMTk3My1kdmQv/J1Y6WNBi3UTfktHPQo9NOQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Prince Valiant (1997) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9wcmluY2UtdmFsaWFudC0xOTk3LWR2ZC8=/vjMgxi_jFQANRCMPDOG87w==&merge_field_type=(?x-mi:(?%3C=href=)[ )Quiet Please, Murder (1942) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9xdWlldC1wbGVhc2UtbXVyZGVyLTE5NDItZHZkLw==/qXLJad0rcUWUO0aTUsUB9w==&merge_field_type=(?x-mi:(?%3C=href=)[ )Rogue River (1951) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9yb2d1ZS1yaXZlci0xOTUxLWR2ZC8=/YvxAP46Xl9VMi4b0cpfEhw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Sweater Girl (1942) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9zd2VhdGVyLWdpcmwtMTk0Mi1kdmQv/ezxHB2b4lOB5aheOFGUexg==&merge_field_type=(?x-mi:(?%3C=href=)[ )Tripoli (1950) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS90cmlwb2xpLTE5NTAtZHZkLw==/yW0d3hqoyxaM8P_Mu50PTg==&merge_field_type=(?x-mi:(?%3C=href=)[ )Uncle Silas (1947) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS91bmNsZS1zaWxhcy0xOTQ3LWR2ZC8=/pAO_D3_vAcMvrhbiR3ExMQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Victory (1940) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS92aWN0b3J5LTE5NDAtZHZkLw==/io9EVYGJu-ZtaJ1HTst_0A==&merge_field_type=(?x-mi:(?%3C=href=)[ )Word of Honor (1981) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS93b3JkLW9mLWhvbm9yLTE5ODEtZHZkLw==/RqwncMlmCpI7GlyfGzznJw==&merge_field_type=(?x-mi:(?%3C=href=)[ )X- The Man With The X-Ray Eyes (1963) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS94LXRoZS1tYW4td2l0aC10aGUteC1yYXktZXllcy0xOTYzLWR2ZC8=/cW5x_SzTQyqdHT-icmboTw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Young As You Feel (1931) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS95b3VuZy1hcy15b3UtZmVlbC0xOTMxLWR2ZC8=/Zf6v4m7L0XxhdcswkWOy3Q==&merge_field_type=(?x-mi:(?%3C=href=)[ )Zenobia (1939) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS96ZW5vYmlhLTE5MzktZHZkLw==/OmOiSSgwxYVtPPE0Nvj3eg==&merge_field_type=(?x-mi:(?%3C=href=)[ ) ARE YOU SALIVATING YET? You can use this search tool to check if any titles you are searching for have been added yet. ?Just click on the link below and you will be taken to Xerxes' advanced search utility.?SHOW ME WHAT YOU GOT XERXES! ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy54ZXJ4ZXNkdmRzLmNvbS9zZWFyY2gucGhwP3NlYXJjaF9xdWVyeT1TZWFyY2gmYW1wO1NlYXJjaD0=/7hzRpFuDbOAL_ClyuyNJvg==&merge_field_type=(?x-mi:(?%3C=href=)[ )? ALL SHIPPING IS FREE ALL THE TIME AND ALL ORDERS SHIP WITHIN 24 HOURS Share ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cDovL3d3dy5mYWNlYm9vay5jb20vc2hhcmVyL3NoYXJlci5waHA_cz0xMDAmcFt1cmxdPWh0dHBzJTNBJTJGJTJGdnIyLnZlcnRpY2FscmVzcG9uc2UuY29tJTJGZW1haWxzJTJGNzY5NjU4MTQwNjU0NyUzRnNrJTNEYW9ab0IySmdIakJMQm51NVFBUGdGNUkySzI4TnJ2cDdxaE12OXQxX09xbnMlMjUzRCUyNTJGYUhSMGNITTZMeTkyY2pJdWRtVnlkR2xqWVd4eVpYTndiMjV6WlM1amIyMHZaVzFoYVd4ekx6YzJPVFkxT0RFME1EWTFORGMlMjUzRCUyNTJGczA5TXQzemJQNURYNTZ0Yy1NVnNiZyUyNTNEJTI1M0QmcFtpbWFnZXNdWzBdPSZwW3RpdGxlXT1XZWxjb21lJTIwdG8lMjB0aGUlMjBYZXJ4ZXMlMjBEVkRzJTIwR3JhbmQlMjBPcGVuaW5nIQ==/RxEIH74g6iJ7wTWD0Nv_-A==&merge_field_type=%7BVR_SOCIAL_SHARE_FACEBOOK%7D ) ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cHM6Ly90d2l0dGVyLmNvbS9ob21lP3N0YXR1cz1XZWxjb21lK3RvK3RoZStYZXJ4ZXMrRFZEcytHcmFuZCtPcGVuaW5nJTIxJTNBK2h0dHBzJTNBJTJGJTJGdnIyLnZlcnRpY2FscmVzcG9uc2UuY29tJTJGZW1haWxzJTJGNzY5NjU4MTQwNjU0NyUzRmNvbnRhY3RfaWQlM0Q3Njk2NTg0OTYxOTk5JTI2c2slM0Rhb1pvQjJKZ0hqQkxCbnU1UUFQZ0Y1STJLMjhOcnZwN3FoTXY5dDFfT3FucyUyNTNEJTI1MkZhSFIwY0hNNkx5OTJjakl1ZG1WeWRHbGpZV3h5WlhOd2IyNXpaUzVqYjIwdlpXMWhhV3h6THpjMk9UWTFPREUwTURZMU5EY19ZMjl1ZEdGamRGOXBaRDAzTmprMk5UZzBPVFl4T1RrNSUyNTJGbHpuTmhkT1lOb2RqUFFCcGtraWFLUSUyNTNEJTI1M0Q=/VOZRHXcQQD-bdALafMGDIw==&merge_field_type=%7BVR_SOCIAL_SHARE_TWITTER%7D ) Xerxes DVDsP.O. Box 121055Fort Lauderdale, FL 33312 Update your Email Preferences ( https://cts.vrmailer1.com/click?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vY29udGFjdHMvNzY5NjU4NDk2MTk5OS9lZGl0P2VtYWlsX2lkPTc2OTY1ODE0MDY1NDc=/Hl3ghatc8-V8J9XPmKMLPg==&merge_field_type=%7BEMAIL_PREFERENCES%7D ) or Unsubscribe ( https://cts.vrmailer1.com/unsub?sk=aoZoB2JgHjBLBnu5QAPgF5I2K28Nrvp7qhMv9t1_Oqns=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vY29udGFjdHMvNzY5NjU4NDk2MTk5OS91bnN1YnNjcmliZT9lbWFpbF9pZD03Njk2NTgxNDA2NTQ3/4sCdrVZn7Sac7jFHmdRZHg==&merge_field_type=%7BUNSUBSCRIBE_LINK%7D ) ( http://www.verticalresponse.com/?utm_campaign=email-footer&utm_medium=referral&utm_source=footer&utm_content=CamID7696581406547&sn=CamID7696581406547 ) -------------- next part -------------- An HTML attachment was scrubbed... URL: From andrea.fani at epfl.ch Mon Aug 4 09:17:45 2014 From: andrea.fani at epfl.ch (Andrea Fani) Date: Mon, 4 Aug 2014 16:17:45 +0200 Subject: [petsc-users] Slepc: B not semi-positive definite Message-ID: Hello, I have to solve a generalized eigenvalue problem Ax=sigma B x. A is not hermitian. B is singular and is slightly not hermitian (only few elements breaks the symmetry). I used the standard krilov-shur algorithm with a shift and invert tranformation and it seems to work fine, but I am a bit worried since in the documentation it is treated only the case with B singular but symmetric. Andrea -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Mon Aug 4 10:08:40 2014 From: jroman at dsic.upv.es (Jose E. Roman) Date: Mon, 4 Aug 2014 17:08:40 +0200 Subject: [petsc-users] Slepc: B not semi-positive definite In-Reply-To: References: Message-ID: El 04/08/2014, a las 16:17, Andrea Fani escribi?: > Hello, > > I have to solve a generalized eigenvalue problem Ax=sigma B x. > > A is not hermitian. B is singular and is slightly not hermitian (only few elements breaks the symmetry). > > I used the standard krilov-shur algorithm with a shift and invert tranformation and it seems to work fine, but I am a bit worried since in the documentation it is treated only the case with B singular but symmetric. > > Andrea Symmetric Krylov methods in SLEPc use the B-inner product, so if B is singular we need to do purification of the computed solution to remove directions in the nullspace of B. Non-symmetric Krylov solvers use the standard inner product (not the B-inner product), so purification is not necessary. Jose From balay at mcs.anl.gov Mon Aug 4 10:56:10 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Mon, 4 Aug 2014 10:56:10 -0500 Subject: [petsc-users] 3.5.1 fail with mumps In-Reply-To: References: Message-ID: On Sun, 3 Aug 2014, Pascal Paschos wrote: > Hi, > > I've already seen a thread where someone recently was trying to build with mumps and was failing at test. > The recommendation that seemed to have worked for that user, at least on this point, was > a fresh install and shared libraries off. Well, I am having the same problem with 3.5.1 with the same error message he was getting. > The build can not interpret symbols in some mumps and parmetis references. > Whether shared libraries is set to 0 or 1 is irrelevant, at least in my case. The problem persists. > The error messages are in the bottom of this post. > And yes, all packages are there, otherwise petsc would not build in the first place. It fails a test with an error message that is > typical of the build missing some include files that it expects to have present. > Without mumps - metis & parmetis - the install is fine and tests complete fine. > So, I guess I am wondering if the developers have any more insight to spare... > Thanks. > > Here is my configure: > > ./configure --prefix=/software/petsc/3.5.1.1 \ > > --with-blas-lib=/software/lapack/3.5.0/lib/libblas.so --with-lapack-lib=/software/lapack/3.5.0/liblapack.so \ > > --with-hdf5=1 --with-hdf5-dir=/software/hdf5/1.8.10 \ > > --with-valgrind=1 --with-valgrind-dir=/software/valgrind/3.8.1 \ > > --with-boost=1 --with-boost-dir=/software/boost/1.41.0 \ > > --with-cc=mpicc --with-cxx=mpicxx --with-fc=mpif90 \ > > --with-debugging=1 \ > > --download-fftw=yes \ > > --download-scalapack=yes \ > > --download-mumps=yes \ > > --download-parmetis=yes \ > > --download-metis=yes \ > > --CFLAGS="-I/usr/include -I/usr/include/openssl" \ > > --LDFLAGS=" -L/usr/lib64" \ > > --LDLIBS=" -lcrypto -lssl" \ > > --with-shared-libraries=0 > > > I found it necessary to pass references to libssl to the linker because otherwise the make is then complaining with an SSL related issue, that it can not find some include file. > you can remove the ssl related options - and use --with-ssl=0 Satish > > > make PETSC_DIR=/software/petsc/3.5.1.1 test > > Running test examples to verify correct installation > > Using PETSC_DIR=/software/petsc/3.5.1.1 and PETSC_ARCH=arch-linux2-c-debug > > *******************Error detected during compile or link!******************* > > See http://www.mcs.anl.gov/petsc/documentation/faq.html > > /software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials ex19 > > ********************************************************************************* > > *********************W-a-r-n-i-n-g************************* > > Your PETSC_DIR may not match the directory you are in > > PETSC_DIR /software/petsc/3.5.1.1 Current directory /software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/snes/examples/tutorials > > Ignore this if you are running make test > > ****************************************************** > > mpicc -o ex19.o -c -I/usr/include -I/usr/include/openssl -g3 -O0 -I/software/petsc/3.5.1.1/include -I/software/petsc/3.5.1.1/include -I/software/valgrind/3.8.1/include -I/software/hdf5/1.8.10/include -I/software/boost/1.41.0/include -I/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/include `pwd`/ex19.c > > mpicc -I/usr/include -I/usr/include/openssl -g3 -O0 -o ex19 ex19.o -L/software/petsc/3.5.1.1/lib -lpetsc -Wl,-rpath,/software/petsc/3.5.1.1/lib -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack -Wl,-rpath,/software/lapack/3.5.0 -L/software/lapack/3.5.0 -llapack -Wl,-rpath,/software/lapack/3.5.0/lib -L/software/lapack/3.5.0/lib -lblas -lparmetis -lmetis -lX11 -lssl -lcrypto -lpthread -lfftw3_mpi -lfftw3 -Wl,-rpath,/software/hdf5/1.8.10/lib -L/software/hdf5/1.8.10/lib -lhdf5_fortran -lhdf5_hl -lhdf5 -L/software/mpi/openmpi-1.6.3-gcc-4.6.3-trq4/lib64 -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc/x86_64-unknown-linux-gnu/4.6.3 -L/hpc/software/gcc/4.6.3-rhel6/lib/gcc -L/hpc/software/gcc/4.6.3-rhel6/lib64 -L/hpc/software/gcc/4.6.3-rhel6/lib -lmpi_f90 -lmpi_f77 -lgfortran -lm -lgfortran -lm -lgfortran -lm -lgfortran -lm -lquadmath -lm -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s -lpthread -ldl > > /software/petsc/3.5.1.1/lib/libpetsc.a(baij.o): In function `MatCreate_SeqBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/seq/baij.c:3006: undefined reference to `MatGetFactor_baij_mumps's' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpibaij.o): In function `MatCreate_MPIBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/baij/mpi/mpibaij.c:3049: undefined reference to `MatGetFactor_baij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(sbaij.o): In function `MatCreate_SeqSBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/seq/sbaij.c:1966: undefined reference to `MatGetFactor_sbaij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpisbaij.o): In function `MatCreate_MPISBAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/sbaij/mpi/mpisbaij.c:1803: undefined reference to `MatGetFactor_sbaij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(aij.o): In function `MatCreate_SeqAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/seq/aij.c:4136: undefined reference to `MatGetFactor_aij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(mpiaij.o): In function `MatCreate_MPIAIJ': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/impls/aij/mpi/mpiaij.c:5578: undefined reference to `MatGetFactor_aij_mumps' > > /software/petsc/3.5.1.1/lib/libpetsc.a(spartition.o): In function `MatPartitioningRegisterAll': > > /hpc/software/sources/builds/petsc-3.5.1_PP/petsc-debug/petsc-3.5.1/src/mat/partition/spartition.c:45: undefined reference to `MatPartitioningCreate_Parmetis' > > > From bsmith at mcs.anl.gov Mon Aug 4 15:49:34 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 4 Aug 2014 15:49:34 -0500 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 In-Reply-To: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> References: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> Message-ID: <68A73FB5-7922-46E3-BC7A-AF0A2984CFCF@mcs.anl.gov> Randall, If you replace the PetscStrncpy(b,a,n+1); with PetscStrncpy(b,a,n); #define FIXCHAR(a,n,b) \ {\ if (a == PETSC_NULL_CHARACTER_Fortran) { \ b = a = 0; \ } else { \ while((n > 0) && (a[n-1] == ' ')) n--; \ *ierr = PetscMalloc((n+1)*sizeof(char),&b); \ if (*ierr) return; \ *ierr = PetscStrncpy(b,a,n+1); \ if (*ierr) return; \ b[n] = 0; \ } \ } in include/petsc-private/fortranimpl.h and recompile the PETSc libraries does the problem go away? Let me know and I?ll fix the code. Thanks Barry On Aug 2, 2014, at 2:20 PM, Randall Mackie wrote: > The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: > > [rmackie ~/tst_petsc_problem] ./cmd_test > ==24812== Invalid read of size 1 > ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) > ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) > ==24812== by 0x400F28: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd > ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) > ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) > ==24812== by 0x400EFD: MAIN__ (test.F90:11) > ==24812== by 0x400F9A: main (test.F90:16) > ==24812== > > > The program was compiled with PETSc V3.5.1 and --download-mpich. > > The same program compiled with V3.4.4 and --download-mpich does not give these errors. > > It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. > I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. > > Program, configure commands, etc, attached. > > Randy M. > > > From rlmackie862 at gmail.com Mon Aug 4 17:14:13 2014 From: rlmackie862 at gmail.com (Randall Mackie) Date: Mon, 4 Aug 2014 15:14:13 -0700 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 In-Reply-To: <68A73FB5-7922-46E3-BC7A-AF0A2984CFCF@mcs.anl.gov> References: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> <68A73FB5-7922-46E3-BC7A-AF0A2984CFCF@mcs.anl.gov> Message-ID: Barry, Yes, that fixes the problem. Thanks, Randy On Aug 4, 2014, at 1:49 PM, Barry Smith wrote: > > Randall, > > If you replace the PetscStrncpy(b,a,n+1); with PetscStrncpy(b,a,n); > > #define FIXCHAR(a,n,b) \ > {\ > if (a == PETSC_NULL_CHARACTER_Fortran) { \ > b = a = 0; \ > } else { \ > while((n > 0) && (a[n-1] == ' ')) n--; \ > *ierr = PetscMalloc((n+1)*sizeof(char),&b); \ > if (*ierr) return; \ > *ierr = PetscStrncpy(b,a,n+1); \ > if (*ierr) return; \ > b[n] = 0; \ > } \ > } > > in include/petsc-private/fortranimpl.h and recompile the PETSc libraries does the problem go away? > > Let me know and I?ll fix the code. > > Thanks > > Barry > > > > On Aug 2, 2014, at 2:20 PM, Randall Mackie wrote: > >> The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: >> >> [rmackie ~/tst_petsc_problem] ./cmd_test >> ==24812== Invalid read of size 1 >> ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24812== by 0x400F28: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd >> ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x400EFD: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== >> >> >> The program was compiled with PETSc V3.5.1 and --download-mpich. >> >> The same program compiled with V3.4.4 and --download-mpich does not give these errors. >> >> It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. >> I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. >> >> Program, configure commands, etc, attached. >> >> Randy M. >> >> >> > From jifengzhao2015 at u.northwestern.edu Mon Aug 4 20:08:57 2014 From: jifengzhao2015 at u.northwestern.edu (jifeng zhao) Date: Mon, 4 Aug 2014 20:08:57 -0500 Subject: [petsc-users] eps_target malloc issue In-Reply-To: References: <42B8A7D6-2001-48BC-8E5C-B68CEB1394DD@mcs.anl.gov> <63FDFE2D-2B08-4B30-BF39-C0F314751E19@dsic.upv.es> <8C032529-BA15-4457-8E89-EDC50A2A5DBB@mcs.anl.gov> <7379E8E2-0D4F-4FB6-B886-3469A1F9BCE8@dsic.upv.es> Message-ID: Hello Hong, I just want to check with you if there is any updates on why the code crashes under -sbaij? At the meanwhile, unfortunately PETSC-3.5 hasn't been installed on my server due to some technical problems. I hope technicians can get it done as soon as possible. I will update you when I have any new results. Thanks so much. Best regards, Jifeng On Wed, Jul 30, 2014 at 2:53 PM, jifeng zhao < jifengzhao2015 at u.northwestern.edu> wrote: > Hello Hong, > > Thanks a lot. The result makes sense, but I think I will need higher > accuracy (smaller tolerance). I will take a try myself at the meanwhile. > > Best regards, > Jifeng Zhao > > > On Wed, Jul 30, 2014 at 1:16 PM, hong at aspiritech.org > wrote: > >> Jifeng, >> Using petsc-3.5 and slepc-3.5 (maint branch), I tested your matrices >> >> mpiexec -n 32 ./ex7 -f1 $data/zhao/petsc_stiff20.dat -f2 >> $data/zhao/petsc_mass20.dat -mat_view ascii::ascii_info -mat_type aij >> -eps_gen_hermitian -eps_type krylovschur -eps_target -0.1 -st_ksp_type >> minres -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-2 >> -eps_tol 1.e-2 -eps_nev 40 -st_type sinvert -log_summary |& tee >> log.mat20.ex7.np32.tol-2 >> >> The output is attached. >> >> When using '-mat_type sbaij', I got same error as reported, which >> might be a bug in our libraries. I'll investigate it. >> Switching to '-mat_type aij' works (I'm not sure if the computed >> eigenvalues are meaningful though), but the linear solver >> minres/bjacobi/icc converges very slow, takes around 500 - 1000 linear >> iterations for each eps iteration. You may experiment with stronger >> pc_type, e.g., '-pc_type asm' etc. >> >> I'll let you know why sbaij crashes. >> >> Hong >> >> On Mon, Jul 28, 2014 at 4:52 PM, Jose E. Roman >> wrote: >> > >> > El 28/07/2014, a las 23:48, jifeng zhao escribi?: >> > >> >> Hi Barry, >> >> >> >> Thanks for the reply. I see. I am still testing it and looking for the >> bug. >> >> >> >> It is pretty weird that the error appears, since the code I am running >> is ex7 and I didn't change anything. >> >> >> >> My matrices are assembled in binary files separately. As I explained >> earlier, I have a series of matrices to solve, each of them have the same >> patterns but with different values. The way I assembly the matrix has >> proven to be correct for all the other cases. Only for this one, when the >> matrix has an zero eigenvalue, ex7 failed to solve it. >> >> >> >> In fact, I don't understand why this "Out of range" error could >> possibly appear? 1. my matrices have the correct parrellel lay up. 2. In >> ex7, I am not explicitly accessing to any elements at all! All I did is >> EPSSolve(); >> >> >> >> Any ideas? >> >> >> >> Best regards, >> >> Jifeng Zhao >> >> >> > >> > Tomorrow we will release slepc-3.5. I would suggest trying with the new >> version. If the problem persist we can help to track down the problem. >> > >> > Jose >> > >> > > > > -- > Jifeng Zhao > PhD candidate at Northwestern University, US > Theoretical and Applied Mechanics Program > -- Jifeng Zhao PhD candidate at Northwestern University, US Theoretical and Applied Mechanics Program -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 4 22:28:30 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 4 Aug 2014 22:28:30 -0500 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 In-Reply-To: <87fvhckeav.fsf@jedbrown.org> References: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> <87fvhckeav.fsf@jedbrown.org> Message-ID: On Aug 4, 2014, at 12:35 AM, Jed Brown wrote: > Randall Mackie writes: > >> The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: >> >> [rmackie ~/tst_petsc_problem] ./cmd_test >> ==24812== Invalid read of size 1 >> ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24812== by 0x400F28: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd > > Barry, this looks like you making PetscStrncpy behave unlike strncpy. > > https://bitbucket.org/petsc/petsc/commits/ff32304b6c2c50401fe7ef46e45693a4318e17f0 > > I'll note that I dislike having functions named after standard C > functions, but with different behavior (e.g., PetscStrcmp and > PetscStrncpy). If you really want these different semantics, I'd rather > have different names. They do have different names. standard C functions do not begin with Petsc. The PETSc ones ?fix? the standard ones for our needs and we document in the manual page (or should document) the differences from the standard ones. Barry > >> ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x400EFD: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== >> >> >> The program was compiled with PETSc V3.5.1 and --download-mpich. >> >> The same program compiled with V3.4.4 and --download-mpich does not give these errors. >> >> It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. >> I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. >> >> Program, configure commands, etc, attached. >> >> Randy M. >> >> >> [rmackie ~/tst_petsc_problem] ./cmd_test >> ==24812== Invalid read of size 1 >> ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24812== by 0x400F28: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd >> ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24812== by 0x400EFD: MAIN__ (test.F90:11) >> ==24812== by 0x400F9A: main (test.F90:16) >> ==24812== >> ==24814== Invalid read of size 1 >> ==24814== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24814== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24814== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24814== by 0x400F28: MAIN__ (test.F90:11) >> ==24814== by 0x400F9A: main (test.F90:16) >> ==24814== Address 0x8cef5ab is 0 bytes after a block of size 11 alloc'd >> ==24814== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24814== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24814== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24814== by 0x400EFD: MAIN__ (test.F90:11) >> ==24814== by 0x400F9A: main (test.F90:16) >> ==24814== >> ==24815== Invalid read of size 1 >> ==24815== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24815== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24815== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24815== by 0x400F28: MAIN__ (test.F90:11) >> ==24815== by 0x400F9A: main (test.F90:16) >> ==24815== Address 0x8cef51b is 0 bytes after a block of size 11 alloc'd >> ==24815== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24815== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24815== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24815== by 0x400EFD: MAIN__ (test.F90:11) >> ==24815== by 0x400F9A: main (test.F90:16) >> ==24815== >> ==24813== Invalid read of size 1 >> ==24813== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24813== by 0x4EF5B4D: PetscStrncpy (str.c:335) >> ==24813== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >> ==24813== by 0x400F28: MAIN__ (test.F90:11) >> ==24813== by 0x400F9A: main (test.F90:16) >> ==24813== Address 0x8cef51b is 0 bytes after a block of size 11 alloc'd >> ==24813== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >> ==24813== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24813== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >> ==24813== by 0x400EFD: MAIN__ (test.F90:11) >> ==24813== by 0x400F9A: main (test.F90:16) >> ==24813== From hong at aspiritech.org Mon Aug 4 23:18:33 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Mon, 4 Aug 2014 23:18:33 -0500 Subject: [petsc-users] eps_target malloc issue In-Reply-To: References: <42B8A7D6-2001-48BC-8E5C-B68CEB1394DD@mcs.anl.gov> <63FDFE2D-2B08-4B30-BF39-C0F314751E19@dsic.upv.es> <8C032529-BA15-4457-8E89-EDC50A2A5DBB@mcs.anl.gov> <7379E8E2-0D4F-4FB6-B886-3469A1F9BCE8@dsic.upv.es> Message-ID: jifeng : > > I just want to check with you if there is any updates on why the code > crashes under -sbaij? It is a bug in petsc. I've fixed it in the brach hzhang/mataxpy-bugfix: https://bitbucket.org/petsc/petsc/branch/hzhang/mataxpy-bugfix which will be merged to 'next' branch for tests, then patch to petsc-3.5. You can use this branch if you like. Again, I like to add your matrices into petsc matrix collection. Can you give me a short sentence describing your matrices, e.g., "The following matrices come from Rick Dean, Arco E&P Technology, rhd at arco.com. They arise from multiphase flow modeling of oil reservoirs,..." Thanks, Hong > > At the meanwhile, unfortunately PETSC-3.5 hasn't been installed on my server > due to some technical problems. I hope technicians can get it done as soon > as possible. I will update you when I have any new results. Thanks so much. > > Best regards, > Jifeng > > > On Wed, Jul 30, 2014 at 2:53 PM, jifeng zhao > wrote: >> >> Hello Hong, >> >> Thanks a lot. The result makes sense, but I think I will need higher >> accuracy (smaller tolerance). I will take a try myself at the meanwhile. >> >> Best regards, >> Jifeng Zhao >> >> >> On Wed, Jul 30, 2014 at 1:16 PM, hong at aspiritech.org >> wrote: >>> >>> Jifeng, >>> Using petsc-3.5 and slepc-3.5 (maint branch), I tested your matrices >>> >>> mpiexec -n 32 ./ex7 -f1 $data/zhao/petsc_stiff20.dat -f2 >>> $data/zhao/petsc_mass20.dat -mat_view ascii::ascii_info -mat_type aij >>> -eps_gen_hermitian -eps_type krylovschur -eps_target -0.1 -st_ksp_type >>> minres -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-2 >>> -eps_tol 1.e-2 -eps_nev 40 -st_type sinvert -log_summary |& tee >>> log.mat20.ex7.np32.tol-2 >>> >>> The output is attached. >>> >>> When using '-mat_type sbaij', I got same error as reported, which >>> might be a bug in our libraries. I'll investigate it. >>> Switching to '-mat_type aij' works (I'm not sure if the computed >>> eigenvalues are meaningful though), but the linear solver >>> minres/bjacobi/icc converges very slow, takes around 500 - 1000 linear >>> iterations for each eps iteration. You may experiment with stronger >>> pc_type, e.g., '-pc_type asm' etc. >>> >>> I'll let you know why sbaij crashes. >>> >>> Hong >>> >>> On Mon, Jul 28, 2014 at 4:52 PM, Jose E. Roman >>> wrote: >>> > >>> > El 28/07/2014, a las 23:48, jifeng zhao escribi?: >>> > >>> >> Hi Barry, >>> >> >>> >> Thanks for the reply. I see. I am still testing it and looking for the >>> >> bug. >>> >> >>> >> It is pretty weird that the error appears, since the code I am running >>> >> is ex7 and I didn't change anything. >>> >> >>> >> My matrices are assembled in binary files separately. As I explained >>> >> earlier, I have a series of matrices to solve, each of them have the same >>> >> patterns but with different values. The way I assembly the matrix has proven >>> >> to be correct for all the other cases. Only for this one, when the matrix >>> >> has an zero eigenvalue, ex7 failed to solve it. >>> >> >>> >> In fact, I don't understand why this "Out of range" error could >>> >> possibly appear? 1. my matrices have the correct parrellel lay up. 2. In >>> >> ex7, I am not explicitly accessing to any elements at all! All I did is >>> >> EPSSolve(); >>> >> >>> >> Any ideas? >>> >> >>> >> Best regards, >>> >> Jifeng Zhao >>> >> >>> > >>> > Tomorrow we will release slepc-3.5. I would suggest trying with the new >>> > version. If the problem persist we can help to track down the problem. >>> > >>> > Jose >>> > >> >> >> >> >> -- >> Jifeng Zhao >> PhD candidate at Northwestern University, US >> Theoretical and Applied Mechanics Program > > > > > -- > Jifeng Zhao > PhD candidate at Northwestern University, US > Theoretical and Applied Mechanics Program From bsmith at mcs.anl.gov Mon Aug 4 23:55:07 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 4 Aug 2014 23:55:07 -0500 Subject: [petsc-users] valgrind error messages with PETSc V3.5.1 In-Reply-To: References: <718904B1-CB4B-47A5-A745-37AB4F558BA7@gmail.com> <68A73FB5-7922-46E3-BC7A-AF0A2984CFCF@mcs.anl.gov> Message-ID: Randy, Thanks, this is now fixed in master, maint, and next and will be fixed in the next patch release. Barry On Aug 4, 2014, at 5:14 PM, Randall Mackie wrote: > Barry, > > Yes, that fixes the problem. > > Thanks, Randy > > > On Aug 4, 2014, at 1:49 PM, Barry Smith wrote: > >> >> Randall, >> >> If you replace the PetscStrncpy(b,a,n+1); with PetscStrncpy(b,a,n); >> >> #define FIXCHAR(a,n,b) \ >> {\ >> if (a == PETSC_NULL_CHARACTER_Fortran) { \ >> b = a = 0; \ >> } else { \ >> while((n > 0) && (a[n-1] == ' ')) n--; \ >> *ierr = PetscMalloc((n+1)*sizeof(char),&b); \ >> if (*ierr) return; \ >> *ierr = PetscStrncpy(b,a,n+1); \ >> if (*ierr) return; \ >> b[n] = 0; \ >> } \ >> } >> >> in include/petsc-private/fortranimpl.h and recompile the PETSc libraries does the problem go away? >> >> Let me know and I?ll fix the code. >> >> Thanks >> >> Barry >> >> >> >> On Aug 2, 2014, at 2:20 PM, Randall Mackie wrote: >> >>> The attached small program, basically a call to PetscPrintf, gives the following valgrind errors: >>> >>> [rmackie ~/tst_petsc_problem] ./cmd_test >>> ==24812== Invalid read of size 1 >>> ==24812== at 0x4C2E500: __GI_strncpy (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >>> ==24812== by 0x4EF5B4D: PetscStrncpy (str.c:335) >>> ==24812== by 0x4F334E0: petscprintf_ (zmprintf.c:54) >>> ==24812== by 0x400F28: MAIN__ (test.F90:11) >>> ==24812== by 0x400F9A: main (test.F90:16) >>> ==24812== Address 0x8cef9bb is 0 bytes after a block of size 11 alloc'd >>> ==24812== at 0x4C2AB80: malloc (in /usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so) >>> ==24812== by 0x6828BB4: ??? (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >>> ==24812== by 0x68FBC97: _gfortran_string_trim (in /usr/lib/x86_64-linux-gnu/libgfortran.so.3.0.0) >>> ==24812== by 0x400EFD: MAIN__ (test.F90:11) >>> ==24812== by 0x400F9A: main (test.F90:16) >>> ==24812== >>> >>> >>> The program was compiled with PETSc V3.5.1 and --download-mpich. >>> >>> The same program compiled with V3.4.4 and --download-mpich does not give these errors. >>> >>> It seems like an innocuous error, and I can certainly create a suppression file for it, but I thought I'd report it anyway. >>> I get the same error on 2 different systems and I've tried 3 different gfortran versions, all with the same result. >>> >>> Program, configure commands, etc, attached. >>> >>> Randy M. >>> >>> >>> >> > From tlk0812 at hotmail.com Tue Aug 5 01:24:22 2014 From: tlk0812 at hotmail.com (LikunTan) Date: Tue, 5 Aug 2014 14:24:22 +0800 Subject: [petsc-users] efficiency of parallel convolution Message-ID: Hi all, I am calculating the multiplication of matrix and vector using fast convolution, but this has to be done for many times. Here is a brief framework of my code: for(dim=0; dim From jifengzhao2015 at u.northwestern.edu Tue Aug 5 10:43:52 2014 From: jifengzhao2015 at u.northwestern.edu (jifeng zhao) Date: Tue, 5 Aug 2014 10:43:52 -0500 Subject: [petsc-users] eps_target malloc issue In-Reply-To: References: <42B8A7D6-2001-48BC-8E5C-B68CEB1394DD@mcs.anl.gov> <63FDFE2D-2B08-4B30-BF39-C0F314751E19@dsic.upv.es> <8C032529-BA15-4457-8E89-EDC50A2A5DBB@mcs.anl.gov> <7379E8E2-0D4F-4FB6-B886-3469A1F9BCE8@dsic.upv.es> Message-ID: Hello Hong, There is no problem. You can add the following description: "The matrices come from Jifeng Zhao, Northwestern University, zhaojf06 at gmail.com. The stiffness and mass matrices arise from a extended finite element model to predict phononic band gap of a three-dimensional two-phase composite with periodic SCC crystal structure. In addition, periodic boundary conditions are applied on the primary unit cell by employing Bloch wave analysis." ---------------------------- In addition, do want to let you know that I tried the runtime command you gave me using PETSC/3.4.4 (3.5 is not ready yet for me), it failed to converge. PETSC ERROR: ! PETSC ERROR: KSP did not converge (reason=DIVERGED_ITS)*!* *I also tried to different preconditioners:* minres/bjacobi/ icc minres/bjacobi/ asm minres/bjacobi/ gamg All of them failed by the same error. I can try to increase the maximum iteration number to remove this error message, but it will converge very slow for sure. Since I am already using -aij command, I am not sure if these slow convergence performance will disappear if I upgrade to PETSC/3.5. Is there anything else I can try on? Thank you so much, Jifeng Zhao On Mon, Aug 4, 2014 at 11:18 PM, hong at aspiritech.org wrote: > jifeng : > > > > I just want to check with you if there is any updates on why the code > > crashes under -sbaij? > > It is a bug in petsc. I've fixed it in the brach hzhang/mataxpy-bugfix: > https://bitbucket.org/petsc/petsc/branch/hzhang/mataxpy-bugfix > > which will be merged to 'next' branch for tests, then patch to petsc-3.5. > You can use this branch if you like. > > Again, I like to add your matrices into petsc matrix collection. > Can you give me a short sentence describing your matrices, e.g., > "The following matrices come from Rick Dean, Arco E&P Technology, > rhd at arco.com. They arise from multiphase flow modeling of oil > reservoirs,..." > > Thanks, > Hong > > > > > > At the meanwhile, unfortunately PETSC-3.5 hasn't been installed on my > server > > due to some technical problems. I hope technicians can get it done as > soon > > as possible. I will update you when I have any new results. Thanks so > much. > > > > Best regards, > > Jifeng > > > > > > On Wed, Jul 30, 2014 at 2:53 PM, jifeng zhao > > wrote: > >> > >> Hello Hong, > >> > >> Thanks a lot. The result makes sense, but I think I will need higher > >> accuracy (smaller tolerance). I will take a try myself at the meanwhile. > >> > >> Best regards, > >> Jifeng Zhao > >> > >> > >> On Wed, Jul 30, 2014 at 1:16 PM, hong at aspiritech.org < > hong at aspiritech.org> > >> wrote: > >>> > >>> Jifeng, > >>> Using petsc-3.5 and slepc-3.5 (maint branch), I tested your matrices > >>> > >>> mpiexec -n 32 ./ex7 -f1 $data/zhao/petsc_stiff20.dat -f2 > >>> $data/zhao/petsc_mass20.dat -mat_view ascii::ascii_info -mat_type aij > >>> -eps_gen_hermitian -eps_type krylovschur -eps_target -0.1 -st_ksp_type > >>> minres -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-2 > >>> -eps_tol 1.e-2 -eps_nev 40 -st_type sinvert -log_summary |& tee > >>> log.mat20.ex7.np32.tol-2 > >>> > >>> The output is attached. > >>> > >>> When using '-mat_type sbaij', I got same error as reported, which > >>> might be a bug in our libraries. I'll investigate it. > >>> Switching to '-mat_type aij' works (I'm not sure if the computed > >>> eigenvalues are meaningful though), but the linear solver > >>> minres/bjacobi/icc converges very slow, takes around 500 - 1000 linear > >>> iterations for each eps iteration. You may experiment with stronger > >>> pc_type, e.g., '-pc_type asm' etc. > >>> > >>> I'll let you know why sbaij crashes. > >>> > >>> Hong > >>> > >>> On Mon, Jul 28, 2014 at 4:52 PM, Jose E. Roman > >>> wrote: > >>> > > >>> > El 28/07/2014, a las 23:48, jifeng zhao escribi?: > >>> > > >>> >> Hi Barry, > >>> >> > >>> >> Thanks for the reply. I see. I am still testing it and looking for > the > >>> >> bug. > >>> >> > >>> >> It is pretty weird that the error appears, since the code I am > running > >>> >> is ex7 and I didn't change anything. > >>> >> > >>> >> My matrices are assembled in binary files separately. As I explained > >>> >> earlier, I have a series of matrices to solve, each of them have > the same > >>> >> patterns but with different values. The way I assembly the matrix > has proven > >>> >> to be correct for all the other cases. Only for this one, when the > matrix > >>> >> has an zero eigenvalue, ex7 failed to solve it. > >>> >> > >>> >> In fact, I don't understand why this "Out of range" error could > >>> >> possibly appear? 1. my matrices have the correct parrellel lay up. > 2. In > >>> >> ex7, I am not explicitly accessing to any elements at all! All I > did is > >>> >> EPSSolve(); > >>> >> > >>> >> Any ideas? > >>> >> > >>> >> Best regards, > >>> >> Jifeng Zhao > >>> >> > >>> > > >>> > Tomorrow we will release slepc-3.5. I would suggest trying with the > new > >>> > version. If the problem persist we can help to track down the > problem. > >>> > > >>> > Jose > >>> > > >> > >> > >> > >> > >> -- > >> Jifeng Zhao > >> PhD candidate at Northwestern University, US > >> Theoretical and Applied Mechanics Program > > > > > > > > > > -- > > Jifeng Zhao > > PhD candidate at Northwestern University, US > > Theoretical and Applied Mechanics Program > -- Jifeng Zhao PhD candidate at Northwestern University, US Theoretical and Applied Mechanics Program -------------- next part -------------- An HTML attachment was scrubbed... URL: From hong at aspiritech.org Tue Aug 5 11:15:56 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Tue, 5 Aug 2014 11:15:56 -0500 Subject: [petsc-users] eps_target malloc issue In-Reply-To: References: <42B8A7D6-2001-48BC-8E5C-B68CEB1394DD@mcs.anl.gov> <63FDFE2D-2B08-4B30-BF39-C0F314751E19@dsic.upv.es> <8C032529-BA15-4457-8E89-EDC50A2A5DBB@mcs.anl.gov> <7379E8E2-0D4F-4FB6-B886-3469A1F9BCE8@dsic.upv.es> Message-ID: jifeng : > "The matrices come from Jifeng Zhao, Northwestern University, > zhaojf06 at gmail.com. The stiffness and mass matrices arise from a extended > finite element model to predict phononic band gap of a three-dimensional > two-phase composite with periodic SCC crystal structure. In addition, > periodic boundary conditions are applied on the primary unit cell by > employing Bloch wave analysis." Thanks. I used your description, but removed your email address: ============================= The matrices come from Jifeng Zhao, Northwestern University. The stiffness and mass matrices arise from a extended finite element model to predict phononic band gap of a three-dimensional two-phase composite with periodic SCC crystal structure. In addition, periodic boundary conditions are applied on the primary unit cell by employing Bloch wave analysis. Compute first 40 eigensolutions K x = lamda M x K and M are real and symmetric (Aug. 2014) ----------------------------------------------- petsc_stiff20.dat: type: seqaij rows=1591812, cols=1591812, total: nonzeros=6.93869e+07 petsc_mass20.dat type: seqaij rows=1591812, cols=1591812, total: nonzeros=4.09661e+07, --------------------------------- petsc_stiff33.dat: type: seqaij rows=1591812, cols=1591812, total: nonzeros=7.05468e+07, petsc_mass33.dat: type: seqaij rows=1591812, cols=1591812, total: nonzeros=4.13649e+07 ============================== As you see, K and M have different data structures (different non zeros) which makes MatAXPY() less efficient than the same data structure. You may create K and M with same data structure, i.e., inserting additional zeros to K or M. Then tells slepc that your matrices K and M have same non-zero structure. > > ---------------------------- > > In addition, do want to let you know that I tried the runtime command you > gave me using PETSC/3.4.4 (3.5 is not ready yet for me), it failed to > converge. > > PETSC ERROR: ! > PETSC ERROR: KSP did not converge (reason=DIVERGED_ITS)! I used minres/bjacobi/ icc with np=32 CPUs and got very slow convergence. How many CPUs do you use? When I run sequential minres/ icc, I got better convergence (use '-st_ksp_monitor to monitor the convergence). If you use more than 32 CPUs, then your bjacobi has more blocks than 32, thus a weaker preconditioner than the one I used. Finding an efficient preconditioner seems the key for your application. > > I also tried to different preconditioners: > minres/bjacobi/ icc > minres/bjacobi/ asm This should be minres/asm/icc Use '-st_ksp_monitor', do you see improvement of asm over bjacobi? You may also increase levels of icc. > minres/bjacobi/ gamg Do not do this. > > All of them failed by the same error. I can try to increase the maximum > iteration number to remove this error message, but it will converge very > slow for sure. > > Since I am already using -aij command, I am not sure if these slow > convergence performance will disappear if I upgrade to PETSC/3.5. Is there > anything else I can try on? The bug in sbaij format is irrelevant to the convergence problems. I would suggest staying with aij format until we patch the petsc-3.5. When I find time, I may help you explore better preconditioners. Which matrices are you interested, petsc_mass20.dat and petsc_stiff20.dat, or something more challenging? I would suggest you sending email to petsc-maint instead of petsc-users. I guess Jose also on the mailing list of petsc-maint. Hong > > On Mon, Aug 4, 2014 at 11:18 PM, hong at aspiritech.org > wrote: >> >> jifeng : >> > >> > I just want to check with you if there is any updates on why the code >> > crashes under -sbaij? >> >> It is a bug in petsc. I've fixed it in the brach hzhang/mataxpy-bugfix: >> https://bitbucket.org/petsc/petsc/branch/hzhang/mataxpy-bugfix >> >> which will be merged to 'next' branch for tests, then patch to petsc-3.5. >> You can use this branch if you like. >> >> Again, I like to add your matrices into petsc matrix collection. >> Can you give me a short sentence describing your matrices, e.g., >> "The following matrices come from Rick Dean, Arco E&P Technology, >> rhd at arco.com. They arise from multiphase flow modeling of oil >> reservoirs,..." >> >> Thanks, >> Hong >> >> >> > >> > At the meanwhile, unfortunately PETSC-3.5 hasn't been installed on my >> > server >> > due to some technical problems. I hope technicians can get it done as >> > soon >> > as possible. I will update you when I have any new results. Thanks so >> > much. >> > >> > Best regards, >> > Jifeng >> > >> > >> > On Wed, Jul 30, 2014 at 2:53 PM, jifeng zhao >> > wrote: >> >> >> >> Hello Hong, >> >> >> >> Thanks a lot. The result makes sense, but I think I will need higher >> >> accuracy (smaller tolerance). I will take a try myself at the >> >> meanwhile. >> >> >> >> Best regards, >> >> Jifeng Zhao >> >> >> >> >> >> On Wed, Jul 30, 2014 at 1:16 PM, hong at aspiritech.org >> >> >> >> wrote: >> >>> >> >>> Jifeng, >> >>> Using petsc-3.5 and slepc-3.5 (maint branch), I tested your matrices >> >>> >> >>> mpiexec -n 32 ./ex7 -f1 $data/zhao/petsc_stiff20.dat -f2 >> >>> $data/zhao/petsc_mass20.dat -mat_view ascii::ascii_info -mat_type aij >> >>> -eps_gen_hermitian -eps_type krylovschur -eps_target -0.1 -st_ksp_type >> >>> minres -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-2 >> >>> -eps_tol 1.e-2 -eps_nev 40 -st_type sinvert -log_summary |& tee >> >>> log.mat20.ex7.np32.tol-2 >> >>> >> >>> The output is attached. >> >>> >> >>> When using '-mat_type sbaij', I got same error as reported, which >> >>> might be a bug in our libraries. I'll investigate it. >> >>> Switching to '-mat_type aij' works (I'm not sure if the computed >> >>> eigenvalues are meaningful though), but the linear solver >> >>> minres/bjacobi/icc converges very slow, takes around 500 - 1000 linear >> >>> iterations for each eps iteration. You may experiment with stronger >> >>> pc_type, e.g., '-pc_type asm' etc. >> >>> >> >>> I'll let you know why sbaij crashes. >> >>> >> >>> Hong >> >>> >> >>> On Mon, Jul 28, 2014 at 4:52 PM, Jose E. Roman >> >>> wrote: >> >>> > >> >>> > El 28/07/2014, a las 23:48, jifeng zhao escribi?: >> >>> > >> >>> >> Hi Barry, >> >>> >> >> >>> >> Thanks for the reply. I see. I am still testing it and looking for >> >>> >> the >> >>> >> bug. >> >>> >> >> >>> >> It is pretty weird that the error appears, since the code I am >> >>> >> running >> >>> >> is ex7 and I didn't change anything. >> >>> >> >> >>> >> My matrices are assembled in binary files separately. As I >> >>> >> explained >> >>> >> earlier, I have a series of matrices to solve, each of them have >> >>> >> the same >> >>> >> patterns but with different values. The way I assembly the matrix >> >>> >> has proven >> >>> >> to be correct for all the other cases. Only for this one, when the >> >>> >> matrix >> >>> >> has an zero eigenvalue, ex7 failed to solve it. >> >>> >> >> >>> >> In fact, I don't understand why this "Out of range" error could >> >>> >> possibly appear? 1. my matrices have the correct parrellel lay up. >> >>> >> 2. In >> >>> >> ex7, I am not explicitly accessing to any elements at all! All I >> >>> >> did is >> >>> >> EPSSolve(); >> >>> >> >> >>> >> Any ideas? >> >>> >> >> >>> >> Best regards, >> >>> >> Jifeng Zhao >> >>> >> >> >>> > >> >>> > Tomorrow we will release slepc-3.5. I would suggest trying with the >> >>> > new >> >>> > version. If the problem persist we can help to track down the >> >>> > problem. >> >>> > >> >>> > Jose >> >>> > >> >> >> >> >> >> >> >> >> >> -- >> >> Jifeng Zhao >> >> PhD candidate at Northwestern University, US >> >> Theoretical and Applied Mechanics Program >> > >> > >> > >> > >> > -- >> > Jifeng Zhao >> > PhD candidate at Northwestern University, US >> > Theoretical and Applied Mechanics Program > > > > > -- > Jifeng Zhao > PhD candidate at Northwestern University, US > Theoretical and Applied Mechanics Program From jifengzhao2015 at u.northwestern.edu Tue Aug 5 11:37:30 2014 From: jifengzhao2015 at u.northwestern.edu (jifeng zhao) Date: Tue, 5 Aug 2014 11:37:30 -0500 Subject: [petsc-users] eps_target malloc issue In-Reply-To: References: <42B8A7D6-2001-48BC-8E5C-B68CEB1394DD@mcs.anl.gov> <63FDFE2D-2B08-4B30-BF39-C0F314751E19@dsic.upv.es> <8C032529-BA15-4457-8E89-EDC50A2A5DBB@mcs.anl.gov> <7379E8E2-0D4F-4FB6-B886-3469A1F9BCE8@dsic.upv.es> Message-ID: Hello Hong, Thank you so much. I was using 24 processors currently and may considering using more. For this application, the fewer processors, the more efficient bjacobi will be, Is that right? As you suggest, these days I will start trying these combinations: minres/icc or minres/asm/icc or minres/icc/others ... What is more, how about jacobi? the most simplest preconditioner? It gives me the best performance actually when I was trying to use JD solver before. petsc_mass20.dat and petsc_stiff20.dat are the most challenging one for now. I have another set of matrices which have very similar eigenvalues distribution with ***20.dat. I think they should work under the same conditions. It will be fantastic, if you will have time to work out a better preconditioner for them. I deeply appreciate your kind help. Best regards, Jifeng Zhao On Tue, Aug 5, 2014 at 11:15 AM, hong at aspiritech.org wrote: > jifeng : > > > "The matrices come from Jifeng Zhao, Northwestern University, > > zhaojf06 at gmail.com. The stiffness and mass matrices arise from a > extended > > finite element model to predict phononic band gap of a three-dimensional > > two-phase composite with periodic SCC crystal structure. In addition, > > periodic boundary conditions are applied on the primary unit cell by > > employing Bloch wave analysis." > > Thanks. I used your description, but removed your email address: > ============================= > The matrices come from Jifeng Zhao, Northwestern University. The > stiffness and mass matrices arise from a extended finite element model > to predict phononic band gap of a three-dimensional two-phase > composite with periodic SCC crystal structure. In addition, periodic > boundary conditions are applied on the primary unit cell by employing > Bloch wave analysis. > > Compute first 40 eigensolutions > K x = lamda M x > K and M are real and symmetric (Aug. 2014) > ----------------------------------------------- > petsc_stiff20.dat: > type: seqaij > rows=1591812, cols=1591812, total: nonzeros=6.93869e+07 > petsc_mass20.dat > type: seqaij > rows=1591812, cols=1591812, total: nonzeros=4.09661e+07, > --------------------------------- > petsc_stiff33.dat: > type: seqaij > rows=1591812, cols=1591812, total: nonzeros=7.05468e+07, > petsc_mass33.dat: > type: seqaij > rows=1591812, cols=1591812, total: nonzeros=4.13649e+07 > ============================== > > As you see, K and M have different data structures (different non > zeros) which makes > MatAXPY() less efficient than the same data structure. You may create > K and M with same data structure, i.e., inserting additional zeros to > K or M. Then tells slepc that your matrices K and M have same non-zero > structure. > > > > ---------------------------- > > > > In addition, do want to let you know that I tried the runtime command you > > gave me using PETSC/3.4.4 (3.5 is not ready yet for me), it failed to > > converge. > > > > PETSC ERROR: ! > > PETSC ERROR: KSP did not converge (reason=DIVERGED_ITS)! > > I used minres/bjacobi/ icc with np=32 CPUs and got very slow > convergence. How many CPUs do you use? > When I run sequential minres/ icc, I got better convergence > (use '-st_ksp_monitor to monitor the convergence). If you use more > than 32 CPUs, then your bjacobi has more blocks than 32, thus a weaker > preconditioner than the one I used. Finding an efficient > preconditioner seems the key for your application. > > > > I also tried to different preconditioners: > > minres/bjacobi/ icc > > minres/bjacobi/ asm > > This should be minres/asm/icc > Use '-st_ksp_monitor', do you see improvement of asm over bjacobi? > You may also increase levels of icc. > > > minres/bjacobi/ gamg > Do not do this. > > > > All of them failed by the same error. I can try to increase the maximum > > iteration number to remove this error message, but it will converge very > > slow for sure. > > > > Since I am already using -aij command, I am not sure if these slow > > convergence performance will disappear if I upgrade to PETSC/3.5. Is > there > > anything else I can try on? > > The bug in sbaij format is irrelevant to the convergence problems. I > would suggest staying with aij format until we patch the petsc-3.5. > > When I find time, I may help you explore better preconditioners. Which > matrices are you interested, > petsc_mass20.dat and petsc_stiff20.dat, or something more challenging? > > I would suggest you sending email to petsc-maint instead of > petsc-users. I guess Jose also on the mailing list of petsc-maint. > > Hong > > > > > On Mon, Aug 4, 2014 at 11:18 PM, hong at aspiritech.org < > hong at aspiritech.org> > > wrote: > >> > >> jifeng : > >> > > >> > I just want to check with you if there is any updates on why the code > >> > crashes under -sbaij? > >> > >> It is a bug in petsc. I've fixed it in the brach hzhang/mataxpy-bugfix: > >> https://bitbucket.org/petsc/petsc/branch/hzhang/mataxpy-bugfix > >> > >> which will be merged to 'next' branch for tests, then patch to > petsc-3.5. > >> You can use this branch if you like. > >> > >> Again, I like to add your matrices into petsc matrix collection. > >> Can you give me a short sentence describing your matrices, e.g., > >> "The following matrices come from Rick Dean, Arco E&P Technology, > >> rhd at arco.com. They arise from multiphase flow modeling of oil > >> reservoirs,..." > >> > >> Thanks, > >> Hong > >> > >> > >> > > >> > At the meanwhile, unfortunately PETSC-3.5 hasn't been installed on my > >> > server > >> > due to some technical problems. I hope technicians can get it done as > >> > soon > >> > as possible. I will update you when I have any new results. Thanks so > >> > much. > >> > > >> > Best regards, > >> > Jifeng > >> > > >> > > >> > On Wed, Jul 30, 2014 at 2:53 PM, jifeng zhao > >> > wrote: > >> >> > >> >> Hello Hong, > >> >> > >> >> Thanks a lot. The result makes sense, but I think I will need higher > >> >> accuracy (smaller tolerance). I will take a try myself at the > >> >> meanwhile. > >> >> > >> >> Best regards, > >> >> Jifeng Zhao > >> >> > >> >> > >> >> On Wed, Jul 30, 2014 at 1:16 PM, hong at aspiritech.org > >> >> > >> >> wrote: > >> >>> > >> >>> Jifeng, > >> >>> Using petsc-3.5 and slepc-3.5 (maint branch), I tested your matrices > >> >>> > >> >>> mpiexec -n 32 ./ex7 -f1 $data/zhao/petsc_stiff20.dat -f2 > >> >>> $data/zhao/petsc_mass20.dat -mat_view ascii::ascii_info -mat_type > aij > >> >>> -eps_gen_hermitian -eps_type krylovschur -eps_target -0.1 > -st_ksp_type > >> >>> minres -st_pc_type bjacobi -st_sub_pc_type icc -st_ksp_rtol 1.e-2 > >> >>> -eps_tol 1.e-2 -eps_nev 40 -st_type sinvert -log_summary |& tee > >> >>> log.mat20.ex7.np32.tol-2 > >> >>> > >> >>> The output is attached. > >> >>> > >> >>> When using '-mat_type sbaij', I got same error as reported, which > >> >>> might be a bug in our libraries. I'll investigate it. > >> >>> Switching to '-mat_type aij' works (I'm not sure if the computed > >> >>> eigenvalues are meaningful though), but the linear solver > >> >>> minres/bjacobi/icc converges very slow, takes around 500 - 1000 > linear > >> >>> iterations for each eps iteration. You may experiment with stronger > >> >>> pc_type, e.g., '-pc_type asm' etc. > >> >>> > >> >>> I'll let you know why sbaij crashes. > >> >>> > >> >>> Hong > >> >>> > >> >>> On Mon, Jul 28, 2014 at 4:52 PM, Jose E. Roman > >> >>> wrote: > >> >>> > > >> >>> > El 28/07/2014, a las 23:48, jifeng zhao escribi?: > >> >>> > > >> >>> >> Hi Barry, > >> >>> >> > >> >>> >> Thanks for the reply. I see. I am still testing it and looking > for > >> >>> >> the > >> >>> >> bug. > >> >>> >> > >> >>> >> It is pretty weird that the error appears, since the code I am > >> >>> >> running > >> >>> >> is ex7 and I didn't change anything. > >> >>> >> > >> >>> >> My matrices are assembled in binary files separately. As I > >> >>> >> explained > >> >>> >> earlier, I have a series of matrices to solve, each of them have > >> >>> >> the same > >> >>> >> patterns but with different values. The way I assembly the matrix > >> >>> >> has proven > >> >>> >> to be correct for all the other cases. Only for this one, when > the > >> >>> >> matrix > >> >>> >> has an zero eigenvalue, ex7 failed to solve it. > >> >>> >> > >> >>> >> In fact, I don't understand why this "Out of range" error could > >> >>> >> possibly appear? 1. my matrices have the correct parrellel lay > up. > >> >>> >> 2. In > >> >>> >> ex7, I am not explicitly accessing to any elements at all! All I > >> >>> >> did is > >> >>> >> EPSSolve(); > >> >>> >> > >> >>> >> Any ideas? > >> >>> >> > >> >>> >> Best regards, > >> >>> >> Jifeng Zhao > >> >>> >> > >> >>> > > >> >>> > Tomorrow we will release slepc-3.5. I would suggest trying with > the > >> >>> > new > >> >>> > version. If the problem persist we can help to track down the > >> >>> > problem. > >> >>> > > >> >>> > Jose > >> >>> > > >> >> > >> >> > >> >> > >> >> > >> >> -- > >> >> Jifeng Zhao > >> >> PhD candidate at Northwestern University, US > >> >> Theoretical and Applied Mechanics Program > >> > > >> > > >> > > >> > > >> > -- > >> > Jifeng Zhao > >> > PhD candidate at Northwestern University, US > >> > Theoretical and Applied Mechanics Program > > > > > > > > > > -- > > Jifeng Zhao > > PhD candidate at Northwestern University, US > > Theoretical and Applied Mechanics Program > -- Jifeng Zhao PhD candidate at Northwestern University, US Theoretical and Applied Mechanics Program -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Wed Aug 6 08:11:55 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 09:11:55 -0400 Subject: [petsc-users] gamg failure with petsc-dev In-Reply-To: <87d2h0didi.fsf@jedbrown.org> References: <532B19AD.50105@imperial.ac.uk> <87lhw4yy9n.fsf@jedbrown.org> <532C23D6.7000400@imperial.ac.uk> <53306FA8.4040001@imperial.ac.uk> <533B0129.2030905@imperial.ac.uk> <87d2h0didi.fsf@jedbrown.org> Message-ID: > > > > Mark, should we provide some more flexible way to label "fields"? It > will be more complicated than the present code and I think packing into > interlaced format is faster anyway. > I'm thinking this would entail reordering the matrix and inverting this permutation for the fine grid R & P. This would be some work for a small number of people. It might be nice to be able to detect this and give a warning but I don't see how this could be done. -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 6 10:13:34 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 6 Aug 2014 10:13:34 -0500 Subject: [petsc-users] efficiency of parallel convolution In-Reply-To: References: Message-ID: <9AC612CA-414C-4852-97D5-C47B82050E6E@mcs.anl.gov> It is difficult to understand what you are doing here. What is dim? What is NX and NY? Is the length of inpx and inpw 256*256 ? Are you using a PETSc Mat like AIJ to apply the ?fast convolution? or some custom MATSHELL? Is the ?fast convolution? the same for each dim, i and j or is it different ? Barry On Aug 5, 2014, at 1:24 AM, LikunTan wrote: > Hi all, > > I am calculating the multiplication of matrix and vector using fast convolution, but this has to be done for many times. Here is a brief framework of my code: > > for(dim=0; dim { > for(i=0; i { > for(j=0; j { > //compute inpx > //compute inpw > //fast convolution > } > } > } > > The fast convolution needs to compute multiple times within the for loops. The dimension of the input vector is 256*256. The most time consuming parts are MatMult(), VecPoinstwiseMult() and MatMultTranspose() during fast convolution. The optimal number of processors is 2. Further increase of processor numbers will reduce the efficiency. In this case, would you please suggest a way to improve efficiency and fully make use of parallelization? Thanks. From mfadams at lbl.gov Wed Aug 6 11:00:37 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 12:00:37 -0400 Subject: [petsc-users] (no subject) Message-ID: I am moving my code to have the DM create the matrix and am hitting this error in DMGetLocalToGlobalMapping: if (!dm->ops->getlocaltoglobalmapping) SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create LocalToGlobalMapping"); This happens when I create the matrix like this: call DMCompositeCreate(comm,solver%da,ierr) call DMSetOptionsPrefix(solver%da,'fsa_',ierr) call DMCompositeAddDM(solver%da,solver%daphi,ierr) call DMCompositeAddDM(solver%da,solver%dalam,ierr) call DMSetFromOptions(solver%da,ierr) call DMCreateMatrix(solver%da,solver%KKTmat,ierr) I am using DMShell and create them like so: ! phi DM call VecCreate(comm,x1Vec,ierr) call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) call VecSetFromOptions(x1Vec,ierr) call DMShellCreate(comm,solver%daphi,ierr) call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) call VecDestroy(x1Vec,ierr) call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) call DMSetFromOptions(solver%daphi,ierr) call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) call VecSetFromOptions(x1Vecloc,ierr) call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) call VecDestroy(x1Vecloc,ierr) All the examples that I see use DMDAs. I am able to create a global vector with this DM. Any ideas? -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Wed Aug 6 11:23:21 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 12:23:21 -0400 Subject: [petsc-users] DMCreateMatrix error with Composite (no getlocaltoglobalmapping) Message-ID: adding a subject ... On Wed, Aug 6, 2014 at 12:00 PM, Mark Adams wrote: > I am moving my code to have the DM create the matrix and am hitting this > error in DMGetLocalToGlobalMapping: > > if (!dm->ops->getlocaltoglobalmapping) > SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create > LocalToGlobalMapping"); > > This happens when I create the matrix like this: > > call DMCompositeCreate(comm,solver%da,ierr) > call DMSetOptionsPrefix(solver%da,'fsa_',ierr) > call DMCompositeAddDM(solver%da,solver%daphi,ierr) > call DMCompositeAddDM(solver%da,solver%dalam,ierr) > call DMSetFromOptions(solver%da,ierr) > call DMCreateMatrix(solver%da,solver%KKTmat,ierr) > > I am using DMShell and create them like so: > > ! phi DM > call VecCreate(comm,x1Vec,ierr) > call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) > call VecSetFromOptions(x1Vec,ierr) > > call DMShellCreate(comm,solver%daphi,ierr) > call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) > call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) > call VecDestroy(x1Vec,ierr) > call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) > call DMSetFromOptions(solver%daphi,ierr) > > call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) > call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) > call VecSetFromOptions(x1Vecloc,ierr) > call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) > call VecDestroy(x1Vecloc,ierr) > > All the examples that I see use DMDAs. I am able to create a global > vector with this DM. > > Any ideas? > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Wed Aug 6 13:34:37 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 14:34:37 -0400 Subject: [petsc-users] DMCreateMatrix error with Composite (no getlocaltoglobalmapping) In-Reply-To: References: Message-ID: It looks like DMShellCreate does not set dm->ops->getlocaltoglobalmapping, which is needed for DMCreateMatrix with a composite DM. I do set a global and local vector and a matrix. It looks like I could call DMShellSetLocalToGlobal. Should I be doing this? Seems low level and the kind of thing this using the DM was supposed to avoid This seems like it is simply a copy of a local vector to to local part of a global vector. Mark On Wed, Aug 6, 2014 at 12:23 PM, Mark Adams wrote: > adding a subject ... > > > On Wed, Aug 6, 2014 at 12:00 PM, Mark Adams wrote: > >> I am moving my code to have the DM create the matrix and am hitting this >> error in DMGetLocalToGlobalMapping: >> >> if (!dm->ops->getlocaltoglobalmapping) >> SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create >> LocalToGlobalMapping"); >> >> This happens when I create the matrix like this: >> >> call DMCompositeCreate(comm,solver%da,ierr) >> call DMSetOptionsPrefix(solver%da,'fsa_',ierr) >> call DMCompositeAddDM(solver%da,solver%daphi,ierr) >> call DMCompositeAddDM(solver%da,solver%dalam,ierr) >> call DMSetFromOptions(solver%da,ierr) >> call DMCreateMatrix(solver%da,solver%KKTmat,ierr) >> >> I am using DMShell and create them like so: >> >> ! phi DM >> call VecCreate(comm,x1Vec,ierr) >> call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) >> call VecSetFromOptions(x1Vec,ierr) >> >> call DMShellCreate(comm,solver%daphi,ierr) >> call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) >> call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) >> call VecDestroy(x1Vec,ierr) >> call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) >> call DMSetFromOptions(solver%daphi,ierr) >> >> call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) >> call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) >> call VecSetFromOptions(x1Vecloc,ierr) >> call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) >> call VecDestroy(x1Vecloc,ierr) >> >> All the examples that I see use DMDAs. I am able to create a global >> vector with this DM. >> >> Any ideas? >> > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From tlk0812 at hotmail.com Wed Aug 6 13:39:54 2014 From: tlk0812 at hotmail.com (LikunTan) Date: Thu, 7 Aug 2014 02:39:54 +0800 Subject: [petsc-users] efficiency of parallel convolution In-Reply-To: <9AC612CA-414C-4852-97D5-C47B82050E6E@mcs.anl.gov> References: , <9AC612CA-414C-4852-97D5-C47B82050E6E@mcs.anl.gov> Message-ID: Hi Barry, Thanks for your email. sorry i did not make it clear. Here is a more detailed one: int dim, i, j; int NDOF=3, NX=5, NY=5; for(dim=0; dim Subject: Re: [petsc-users] efficiency of parallel convolution > From: bsmith at mcs.anl.gov > Date: Wed, 6 Aug 2014 10:13:34 -0500 > CC: petsc-users at mcs.anl.gov > To: tlk0812 at hotmail.com > > > It is difficult to understand what you are doing here. What is dim? What is NX and NY? Is the length of inpx and inpw 256*256 ? Are you using a PETSc Mat like AIJ to apply the ?fast convolution? or some custom MATSHELL? Is the ?fast convolution? the same for each dim, i and j or is it different ? > > Barry > > On Aug 5, 2014, at 1:24 AM, LikunTan wrote: > > > Hi all, > > > > I am calculating the multiplication of matrix and vector using fast convolution, but this has to be done for many times. Here is a brief framework of my code: > > > > for(dim=0; dim > { > > for(i=0; i > { > > for(j=0; j > { > > //compute inpx > > //compute inpw > > //fast convolution > > } > > } > > } > > > > The fast convolution needs to compute multiple times within the for loops. The dimension of the input vector is 256*256. The most time consuming parts are MatMult(), VecPoinstwiseMult() and MatMultTranspose() during fast convolution. The optimal number of processors is 2. Further increase of processor numbers will reduce the efficiency. In this case, would you please suggest a way to improve efficiency and fully make use of parallelization? Thanks. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Wed Aug 6 13:49:16 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 14:49:16 -0400 Subject: [petsc-users] DMCreateMatrix error with Composite (no getlocaltoglobalmapping) In-Reply-To: References: Message-ID: Now that I look at DMShellSetLocalToGlobal, I see that it sets the begin/end functions. But these are already set. It looks like DMShell's SetType must set something for dm->ops->getlocaltoglobalmapping for DMShell to be usable to get a matrix from a Composite DM. On Wed, Aug 6, 2014 at 2:34 PM, Mark Adams wrote: > It looks like DMShellCreate does not set dm->ops->getlocaltoglobalmapping, > which is needed for DMCreateMatrix with a composite DM. I do set a > global and local vector and a matrix. It looks like I could call DMShellSetLocalToGlobal. > Should I be doing this? Seems low level and the kind of thing this using > the DM was supposed to avoid > > This seems like it is simply a copy of a local vector to to local part of > a global vector. > > Mark > > > > On Wed, Aug 6, 2014 at 12:23 PM, Mark Adams wrote: > >> adding a subject ... >> >> >> On Wed, Aug 6, 2014 at 12:00 PM, Mark Adams wrote: >> >>> I am moving my code to have the DM create the matrix and am hitting this >>> error in DMGetLocalToGlobalMapping: >>> >>> if (!dm->ops->getlocaltoglobalmapping) >>> SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create >>> LocalToGlobalMapping"); >>> >>> This happens when I create the matrix like this: >>> >>> call DMCompositeCreate(comm,solver%da,ierr) >>> call DMSetOptionsPrefix(solver%da,'fsa_',ierr) >>> call DMCompositeAddDM(solver%da,solver%daphi,ierr) >>> call DMCompositeAddDM(solver%da,solver%dalam,ierr) >>> call DMSetFromOptions(solver%da,ierr) >>> call DMCreateMatrix(solver%da,solver%KKTmat,ierr) >>> >>> I am using DMShell and create them like so: >>> >>> ! phi DM >>> call VecCreate(comm,x1Vec,ierr) >>> call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) >>> call VecSetFromOptions(x1Vec,ierr) >>> >>> call DMShellCreate(comm,solver%daphi,ierr) >>> call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) >>> call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) >>> call VecDestroy(x1Vec,ierr) >>> call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) >>> call DMSetFromOptions(solver%daphi,ierr) >>> >>> call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) >>> call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) >>> call VecSetFromOptions(x1Vecloc,ierr) >>> call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) >>> call VecDestroy(x1Vecloc,ierr) >>> >>> All the examples that I see use DMDAs. I am able to create a global >>> vector with this DM. >>> >>> Any ideas? >>> >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From Mathieu.Morlighem at uci.edu Wed Aug 6 16:48:22 2014 From: Mathieu.Morlighem at uci.edu (Mathieu MORLIGHEM) Date: Wed, 6 Aug 2014 14:48:22 -0700 Subject: [petsc-users] Pointwise max for matrices Message-ID: <2DACA59D-70C2-4A65-A4CE-CAFD9D1F9EC3@uci.edu> Hello, I am trying to implement a Flux Correction Transport method for advection equations (e.g. http://www.mathematik.uni-dortmund.de/~kuzmin/linfct.pdf). One of the steps consists of calculating a matrix D which is such that d_ij = max{ 0 , -k_ij , -kJi } where k_ij are the components of a transport operator K. Is there a way to do that without serializing K, which could be memory intensive. Thanks a lot for your help Mathieu From mfadams at lbl.gov Wed Aug 6 17:31:20 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 18:31:20 -0400 Subject: [petsc-users] DMCreateMatrix error with Composite (no getlocaltoglobalmapping) In-Reply-To: References: Message-ID: Jed, it looks like DM_DA creates its l2gmap in Setup, but DM_Shell does not. This seems to be causing errors when DM_Shell is used in DM_Composit and I make a matrix. I'm thinking I could add this construction to DM_Shell. DM_Shell does not have a Setup method (like DM_DA) but I could create function and set it in DMShellCreate, like PetscErrorCode DMShellCreate(MPI_Comm comm,DM *dm) { PetscErrorCode ierr; PetscFunctionBegin; PetscValidPointer(dm,2); ierr = DMCreate(comm,dm);CHKERRQ(ierr); ierr = DMSetType(*dm,DMSHELL);CHKERRQ(ierr); ierr = DMSetUp(*dm);CHKERRQ(ierr); dm->ops->getlocaltoglobalmapping = DMGetLocalToGlobalMapping_Shell PetscFunctionReturn(0); } Does this seem like a reasonable approach? On Wed, Aug 6, 2014 at 2:49 PM, Mark Adams wrote: > Now that I look at DMShellSetLocalToGlobal, I see that it sets the > begin/end functions. But these are already set. > > It looks like DMShell's SetType must set something for dm->ops->getlocaltoglobalmapping > for DMShell to be usable to get a matrix from a Composite DM. > > > On Wed, Aug 6, 2014 at 2:34 PM, Mark Adams wrote: > >> It looks like DMShellCreate does not set dm->ops->getlocaltoglobalmapping, >> which is needed for DMCreateMatrix with a composite DM. I do set a >> global and local vector and a matrix. It looks like I could call DMShellSetLocalToGlobal. >> Should I be doing this? Seems low level and the kind of thing this using >> the DM was supposed to avoid >> >> This seems like it is simply a copy of a local vector to to local part of >> a global vector. >> >> Mark >> >> >> >> On Wed, Aug 6, 2014 at 12:23 PM, Mark Adams wrote: >> >>> adding a subject ... >>> >>> >>> On Wed, Aug 6, 2014 at 12:00 PM, Mark Adams wrote: >>> >>>> I am moving my code to have the DM create the matrix and am hitting >>>> this error in DMGetLocalToGlobalMapping: >>>> >>>> if (!dm->ops->getlocaltoglobalmapping) >>>> SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create >>>> LocalToGlobalMapping"); >>>> >>>> This happens when I create the matrix like this: >>>> >>>> call DMCompositeCreate(comm,solver%da,ierr) >>>> call DMSetOptionsPrefix(solver%da,'fsa_',ierr) >>>> call DMCompositeAddDM(solver%da,solver%daphi,ierr) >>>> call DMCompositeAddDM(solver%da,solver%dalam,ierr) >>>> call DMSetFromOptions(solver%da,ierr) >>>> call DMCreateMatrix(solver%da,solver%KKTmat,ierr) >>>> >>>> I am using DMShell and create them like so: >>>> >>>> ! phi DM >>>> call VecCreate(comm,x1Vec,ierr) >>>> call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) >>>> call VecSetFromOptions(x1Vec,ierr) >>>> >>>> call DMShellCreate(comm,solver%daphi,ierr) >>>> call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) >>>> call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) >>>> call VecDestroy(x1Vec,ierr) >>>> call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) >>>> call DMSetFromOptions(solver%daphi,ierr) >>>> >>>> call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) >>>> call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) >>>> call VecSetFromOptions(x1Vecloc,ierr) >>>> call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) >>>> call VecDestroy(x1Vecloc,ierr) >>>> >>>> All the examples that I see use DMDAs. I am able to create a global >>>> vector with this DM. >>>> >>>> Any ideas? >>>> >>> >>> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Wed Aug 6 17:40:53 2014 From: mfadams at lbl.gov (Mark Adams) Date: Wed, 6 Aug 2014 18:40:53 -0400 Subject: [petsc-users] DMCreateMatrix error with Composite (no getlocaltoglobalmapping) In-Reply-To: References: Message-ID: I see there is a DM_Create_Shell that I can out this in. On Wed, Aug 6, 2014 at 6:31 PM, Mark Adams wrote: > Jed, it looks like DM_DA creates its l2gmap in Setup, but DM_Shell does > not. This seems to be causing errors when DM_Shell is used in DM_Composit > and I make a matrix. > > I'm thinking I could add this construction to DM_Shell. DM_Shell does not > have a Setup method (like DM_DA) but I could create function and set it > in DMShellCreate, like PetscErrorCode DMShellCreate(MPI_Comm comm,DM *dm) > { > PetscErrorCode ierr; > > PetscFunctionBegin; > PetscValidPointer(dm,2); > ierr = DMCreate(comm,dm);CHKERRQ(ierr); > ierr = DMSetType(*dm,DMSHELL);CHKERRQ(ierr); > ierr = DMSetUp(*dm);CHKERRQ(ierr); > dm->ops->getlocaltoglobalmapping = DMGetLocalToGlobalMapping_Shell > PetscFunctionReturn(0); > } > > Does this seem like a reasonable approach? > > > > > > On Wed, Aug 6, 2014 at 2:49 PM, Mark Adams wrote: > >> Now that I look at DMShellSetLocalToGlobal, I see that it sets the >> begin/end functions. But these are already set. >> >> It looks like DMShell's SetType must set something for dm->ops->getlocaltoglobalmapping >> for DMShell to be usable to get a matrix from a Composite DM. >> >> >> On Wed, Aug 6, 2014 at 2:34 PM, Mark Adams wrote: >> >>> It looks like DMShellCreate does not set dm->ops->getlocaltoglobalmapping, >>> which is needed for DMCreateMatrix with a composite DM. I do set a >>> global and local vector and a matrix. It looks like I could call DMShellSetLocalToGlobal. >>> Should I be doing this? Seems low level and the kind of thing this using >>> the DM was supposed to avoid >>> >>> This seems like it is simply a copy of a local vector to to local part >>> of a global vector. >>> >>> Mark >>> >>> >>> >>> On Wed, Aug 6, 2014 at 12:23 PM, Mark Adams wrote: >>> >>>> adding a subject ... >>>> >>>> >>>> On Wed, Aug 6, 2014 at 12:00 PM, Mark Adams wrote: >>>> >>>>> I am moving my code to have the DM create the matrix and am hitting >>>>> this error in DMGetLocalToGlobalMapping: >>>>> >>>>> if (!dm->ops->getlocaltoglobalmapping) >>>>> SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_SUP,"DM can not create >>>>> LocalToGlobalMapping"); >>>>> >>>>> This happens when I create the matrix like this: >>>>> >>>>> call DMCompositeCreate(comm,solver%da,ierr) >>>>> call DMSetOptionsPrefix(solver%da,'fsa_',ierr) >>>>> call DMCompositeAddDM(solver%da,solver%daphi,ierr) >>>>> call DMCompositeAddDM(solver%da,solver%dalam,ierr) >>>>> call DMSetFromOptions(solver%da,ierr) >>>>> call DMCreateMatrix(solver%da,solver%KKTmat,ierr) >>>>> >>>>> I am using DMShell and create them like so: >>>>> >>>>> ! phi DM >>>>> call VecCreate(comm,x1Vec,ierr) >>>>> call VecSetSizes(x1Vec,N1loc,N1Glob,ierr) >>>>> call VecSetFromOptions(x1Vec,ierr) >>>>> >>>>> call DMShellCreate(comm,solver%daphi,ierr) >>>>> call DMShellSetGlobalVector(solver%daphi,x1Vec,ierr) >>>>> call DMShellSetMatrix(solver%daphi,solver%A0Mat,ierr) >>>>> call VecDestroy(x1Vec,ierr) >>>>> call DMSetOptionsPrefix(solver%daphi,'phi_',ierr) >>>>> call DMSetFromOptions(solver%daphi,ierr) >>>>> >>>>> call VecCreate(PETSC_COMM_SELF,x1Vecloc,ierr) >>>>> call VecSetSizes(x1Vecloc,N1loc,N1loc,ierr) >>>>> call VecSetFromOptions(x1Vecloc,ierr) >>>>> call DMShellSetLocalVector(solver%daphi,x1Vecloc,ierr) >>>>> call VecDestroy(x1Vecloc,ierr) >>>>> >>>>> All the examples that I see use DMDAs. I am able to create a global >>>>> vector with this DM. >>>>> >>>>> Any ideas? >>>>> >>>> >>>> >>> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Wed Aug 6 17:49:36 2014 From: jed at jedbrown.org (Jed Brown) Date: Wed, 06 Aug 2014 17:49:36 -0500 Subject: [petsc-users] Pointwise max for matrices In-Reply-To: <2DACA59D-70C2-4A65-A4CE-CAFD9D1F9EC3@uci.edu> References: <2DACA59D-70C2-4A65-A4CE-CAFD9D1F9EC3@uci.edu> Message-ID: <87bnrxdyin.fsf@jedbrown.org> Mathieu MORLIGHEM writes: > Hello, > > I am trying to implement a Flux Correction Transport method for advection equations (e.g. http://www.mathematik.uni-dortmund.de/~kuzmin/linfct.pdf). > One of the steps consists of calculating a matrix D which is such that > > d_ij = max{ 0 , -k_ij , -kJi } > > where k_ij are the components of a transport operator K. > Is there a way to do that without serializing K, which could be memory intensive. You can't avoid getting the off-diagonal part of the transpose, but what I would suggest is to just use MatTranspose() and then MatGetRow() to walk through rows and columns of K. This should be very efficient (no searching and good locality) and doesn't use that much memory in the scheme of what else is probably in your code. Anything that doesn't transpose will need a search or a more expensive data structure with worse locality. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jychang48 at gmail.com Wed Aug 6 17:55:44 2014 From: jychang48 at gmail.com (Justin Chang) Date: Wed, 6 Aug 2014 16:55:44 -0600 Subject: [petsc-users] Using DMPlex for Darcys law Message-ID: Hi, So in ex62 of SNES it solves the stokes equation with P2-P1 elements. I want to solve the darcy equation with P2-P1 elements in a similar fashion. The difference between stokes and darcy is that in the weak form of darcy, the velocity-velocity term is v*u whereas in stokes it's grad[v]*grad[u] In ex62, the function g3_uu (lines 172-183) formulates the grad[v]*grad[u] term but how would I do it for Darcy's equation where its simply v*u (assuming drag coefficient is scalar quantity of 1.0)? Thanks, Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From fpoulin at uwaterloo.ca Wed Aug 6 18:50:38 2014 From: fpoulin at uwaterloo.ca (Francis Poulin) Date: Wed, 6 Aug 2014 23:50:38 +0000 Subject: [petsc-users] trying to solve a lot of ksp problems quickly Message-ID: <4C887A7BEDB3D64E9F30EBF58F8D4BDE13D30143@connmbx02> Hello, I am trying to figure out a faster way of doing in petsc4py and thought I would ask to see how this should be done in petsc. If I can figure that out then I think I can figure out how to translate it but I am having issues with the basic algorithm I should be using. I am solving a linear system of ODEs of the form B du/dt = A u using Crank-Nicholson. So the update equation can be written as (B - dt/2*A)*u^(n+1) = (B + dt/2*A)*u^n or, if you don't mind using the backslash operator, u^(n+1) = (B - dt/2*A)\(B + dt/2*A)*u^n The integration is faster of course after I build the matrix C = (B - dt/2*A)\(B + dt/2*A) however building this is very slow and I am not sure how to build it efficiently. At the moment the majority of my code is just doing that. In petsc4py I do the following: (you can find the full code at https://github.com/francispoulin/qg_1L_ts/blob/master/qg_1L_ts.py) AeT = PETSc.Mat().createAIJ([Ny-1,Ny-1]) AeT.setUp(); AeT.assemble() ksp = PETSc.KSP().create(PETSc.COMM_WORLD) ksp.setOperators(B-dto2*A) ksp.setTolerances(1e-16) pc = ksp.getPC() pc.setType('none') ksp.setFromOptions() btemp = B+dto2*A btemp.assemble() bcol = PETSc.Vec().createMPI(Ny-1) xcol = PETSc.Vec().createMPI(Ny-1) bcol.setUp(); xcol.setUp() sc,ec = bcol.getOwnershipRange() for i in range(0,Ny-1): bcol[sc:ec] = btemp[sc:ec,i] bcol.assemble(); xcol.assemble() ksp.solve(bcol,xcol) AeT[sc:ec,i] = xcol[sc:ec] AeT.assemble() We are building the matrix one row at a time and, as accurate as that maybe, it is very slow. Is there perhaps a fast way of doing this kind of operation in petsc? Sorry for the bother but any advice would be greatly appreciated. Cheers, Francis ------------------ Francis Poulin Associate Professor Associate Chair, Undergraduate Studies Department of Applied Mathematics University of Waterloo email: fpoulin at uwaterloo.ca Web: https://uwaterloo.ca/poulin-research-group/ Telephone: +1 519 888 4567 x32637 -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 6 19:27:22 2014 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 6 Aug 2014 19:27:22 -0500 Subject: [petsc-users] Using DMPlex for Darcys law In-Reply-To: References: Message-ID: On Wed, Aug 6, 2014 at 5:55 PM, Justin Chang wrote: > Hi, > > So in ex62 of SNES it solves the stokes equation with P2-P1 elements. I > want to solve the darcy equation with P2-P1 elements in a similar fashion. > > The difference between stokes and darcy is that in the weak form of darcy, > the velocity-velocity term is v*u whereas in stokes it's grad[v]*grad[u] > > In ex62, the function g3_uu (lines 172-183) formulates the grad[v]*grad[u] > term but how would I do it for Darcy's equation where its simply v*u > (assuming drag coefficient is scalar quantity of 1.0)? > So you would want to define g0 instead of g3, since its the u-u term: void g0_uu(const PetscScalar u[], const PetscScalar u_t[], const PetscScalar u_x[], const PetscScalar a[], const PetscScalar a_t[], const PetscScalar a_x[], const PetscReal x[], PetscScalar g3[]) { const PetscInt Ncomp = spatialDim; PetscInt compI; for (compI = 0; compI < Ncomp; ++compI) g0[compI] = u[compI]; } and then register it in SetupProblem: ierr = PetscDSSetJacobian(prob, 0, 0, g0_uu, NULL, NULL, NULL);CHKERRQ(ierr); and do not forget to change the residual definition in f0/f1. Thanks, Matt > Thanks, > Justin > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 6 19:30:39 2014 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 6 Aug 2014 19:30:39 -0500 Subject: [petsc-users] trying to solve a lot of ksp problems quickly In-Reply-To: <4C887A7BEDB3D64E9F30EBF58F8D4BDE13D30143@connmbx02> References: <4C887A7BEDB3D64E9F30EBF58F8D4BDE13D30143@connmbx02> Message-ID: On Wed, Aug 6, 2014 at 6:50 PM, Francis Poulin wrote: > Hello, > > I am trying to figure out a faster way of doing in petsc4py and thought I > would ask to see how this should be done in petsc. If I can figure that > out then I think I can figure out how to translate it but I am having > issues with the basic algorithm I should be using. > > I am solving a linear system of ODEs of the form > > B du/dt = A u > > using Crank-Nicholson. So the update equation can be written as > > (B - dt/2*A)*u^(n+1) = (B + dt/2*A)*u^n > > or, if you don't mind using the backslash operator, > > u^(n+1) = (B - dt/2*A)\(B + dt/2*A)*u^n > > The integration is faster of course after I build the matrix > > C = (B - dt/2*A)\(B + dt/2*A) > > however building this is very slow and I am not sure how to build it > efficiently. At the moment the majority of my code is just doing that. > 1) For this to make sense, you have to be doing many many more than N timesteps, where N is the number of unknowns. Why not just solve this equation at each timestep? > In petsc4py I do the following: > > (you can find the full code at > https://github.com/francispoulin/qg_1L_ts/blob/master/qg_1L_ts.py) > > AeT = PETSc.Mat().createAIJ([Ny-1,Ny-1]) > 2) Storing the inverse in a sparse matrix does not make sense. Its likely dense. Also, you have not preallocated so it will be slow. Use a dense matrix and both problems will go away. Thanks, Matt AeT.setUp(); AeT.assemble() > ksp = PETSc.KSP().create(PETSc.COMM_WORLD) > ksp.setOperators(B-dto2*A) > ksp.setTolerances(1e-16) > pc = ksp.getPC() > pc.setType('none') > ksp.setFromOptions() > > btemp = B+dto2*A > btemp.assemble() > > bcol = PETSc.Vec().createMPI(Ny-1) > xcol = PETSc.Vec().createMPI(Ny-1) > bcol.setUp(); xcol.setUp() > > sc,ec = bcol.getOwnershipRange() > for i in range(0,Ny-1): > bcol[sc:ec] = btemp[sc:ec,i] > bcol.assemble(); xcol.assemble() > ksp.solve(bcol,xcol) > AeT[sc:ec,i] = xcol[sc:ec] > > AeT.assemble() > > We are building the matrix one row at a time and, as accurate as that > maybe, it is very slow. Is there perhaps a fast way of doing this kind of > operation in petsc? > > Sorry for the bother but any advice would be greatly appreciated. > > Cheers, Francis > > ------------------ > Francis Poulin > Associate Professor > Associate Chair, Undergraduate Studies > Department of Applied Mathematics > University of Waterloo > > email: fpoulin at uwaterloo.ca > Web: https://uwaterloo.ca/poulin-research-group/ > Telephone: +1 519 888 4567 x32637 > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From fpoulin at uwaterloo.ca Wed Aug 6 19:52:08 2014 From: fpoulin at uwaterloo.ca (Francis Poulin) Date: Thu, 7 Aug 2014 00:52:08 +0000 Subject: [petsc-users] trying to solve a lot of ksp problems quickly In-Reply-To: References: <4C887A7BEDB3D64E9F30EBF58F8D4BDE13D30143@connmbx02>, Message-ID: <4C887A7BEDB3D64E9F30EBF58F8D4BDE13D3023B@connmbx02> Hello Matt, Thanks for the help. I had some some tests in Matlab using the two methods and because I am trying to compute the growth rates of a system that are very small, it seemed to be faster to find the inverse but I will try both and see what works best. Yes, my inexperience let me forget about what kind of matrix I needed to define. I hope I've learned my lesson for next time. Francis ------------------ Francis Poulin Associate Professor Associate Chair, Undergraduate Studies Department of Applied Mathematics University of Waterloo email: fpoulin at uwaterloo.ca Web: https://uwaterloo.ca/poulin-research-group/ Telephone: +1 519 888 4567 x32637 ________________________________ From: Matthew Knepley [knepley at gmail.com] Sent: Wednesday, August 06, 2014 8:30 PM To: Francis Poulin Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] trying to solve a lot of ksp problems quickly On Wed, Aug 6, 2014 at 6:50 PM, Francis Poulin > wrote: Hello, I am trying to figure out a faster way of doing in petsc4py and thought I would ask to see how this should be done in petsc. If I can figure that out then I think I can figure out how to translate it but I am having issues with the basic algorithm I should be using. I am solving a linear system of ODEs of the form B du/dt = A u using Crank-Nicholson. So the update equation can be written as (B - dt/2*A)*u^(n+1) = (B + dt/2*A)*u^n or, if you don't mind using the backslash operator, u^(n+1) = (B - dt/2*A)\(B + dt/2*A)*u^n The integration is faster of course after I build the matrix C = (B - dt/2*A)\(B + dt/2*A) however building this is very slow and I am not sure how to build it efficiently. At the moment the majority of my code is just doing that. 1) For this to make sense, you have to be doing many many more than N timesteps, where N is the number of unknowns. Why not just solve this equation at each timestep? In petsc4py I do the following: (you can find the full code at https://github.com/francispoulin/qg_1L_ts/blob/master/qg_1L_ts.py) AeT = PETSc.Mat().createAIJ([Ny-1,Ny-1]) 2) Storing the inverse in a sparse matrix does not make sense. Its likely dense. Also, you have not preallocated so it will be slow. Use a dense matrix and both problems will go away. Thanks, Matt AeT.setUp(); AeT.assemble() ksp = PETSc.KSP().create(PETSc.COMM_WORLD) ksp.setOperators(B-dto2*A) ksp.setTolerances(1e-16) pc = ksp.getPC() pc.setType('none') ksp.setFromOptions() btemp = B+dto2*A btemp.assemble() bcol = PETSc.Vec().createMPI(Ny-1) xcol = PETSc.Vec().createMPI(Ny-1) bcol.setUp(); xcol.setUp() sc,ec = bcol.getOwnershipRange() for i in range(0,Ny-1): bcol[sc:ec] = btemp[sc:ec,i] bcol.assemble(); xcol.assemble() ksp.solve(bcol,xcol) AeT[sc:ec,i] = xcol[sc:ec] AeT.assemble() We are building the matrix one row at a time and, as accurate as that maybe, it is very slow. Is there perhaps a fast way of doing this kind of operation in petsc? Sorry for the bother but any advice would be greatly appreciated. Cheers, Francis ------------------ Francis Poulin Associate Professor Associate Chair, Undergraduate Studies Department of Applied Mathematics University of Waterloo email: fpoulin at uwaterloo.ca Web: https://uwaterloo.ca/poulin-research-group/ Telephone: +1 519 888 4567 x32637 -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 6 21:57:03 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 6 Aug 2014 21:57:03 -0500 Subject: [petsc-users] efficiency of parallel convolution In-Reply-To: References: , <9AC612CA-414C-4852-97D5-C47B82050E6E@mcs.anl.gov> Message-ID: <4C7EF83F-F1DB-4E69-8FEC-3401F7E0E4FC@mcs.anl.gov> I believe you very likely should be doing variants of both option1 and option2 at the same time. That is use several processors each computing some of the transforms but use the FFTW "advanced interface computes transforms of multiple or strided arrays.? feature of FFTW to have FFTW do several at the same time http://www.fftw.org/fftw3.pdf. This means you will have to call fftw advanced functions yourself to set up the plan to multiple transforms together instead of using the PETSc MatMult() but I believe it will be likely much faster then doing them one at a time. Barry On Aug 6, 2014, at 1:39 PM, LikunTan wrote: > Hi Barry, > > Thanks for your email. sorry i did not make it clear. Here is a more detailed one: > > int dim, i, j; > int NDOF=3, NX=5, NY=5; > > for(dim=0; dim { > for(i=0; i { > for(j=0; j { > //compute inpx > Set values for vec inpx, which has a dimension of 256*256 > //compute inpw > Set values for vec inpw, which has a dimension of 256*256 > //fast convolution > i am following ex158 in src/mat/examples using the petsc and fftw interface, the mat is created using MatCreateFFT() > } > } > } > > The values of inpx and inpw are changing with the indices dim, i and j, but the lengths are the same all the time and the convolution can be calculated separately. I am thinking about two options: > option1: using MPI to do the fast convolution for each inpx and inpw simulataneously, i.e. , do NDOF*NX*NY convolutions in parallel > option2: in convolution, define an extended matrix and vector to store all the values from the NDOF*NX*NY convolutions, and do MatMult(), VecPointwiseMult(), MatMultTranpose() on the extended objects at the same time. > > I would very much appreciate your comments. Thanks. > > > > > Subject: Re: [petsc-users] efficiency of parallel convolution > > From: bsmith at mcs.anl.gov > > Date: Wed, 6 Aug 2014 10:13:34 -0500 > > CC: petsc-users at mcs.anl.gov > > To: tlk0812 at hotmail.com > > > > > > It is difficult to understand what you are doing here. What is dim? What is NX and NY? Is the length of inpx and inpw 256*256 ? Are you using a PETSc Mat like AIJ to apply the ?fast convolution? or some custom MATSHELL? Is the ?fast convolution? the same for each dim, i and j or is it different ? > > > > Barry > > > > On Aug 5, 2014, at 1:24 AM, LikunTan wrote: > > > > > Hi all, > > > > > > I am calculating the multiplication of matrix and vector using fast convolution, but this has to be done for many times. Here is a brief framework of my code: > > > > > > for(dim=0; dim > > { > > > for(i=0; i > > { > > > for(j=0; j > > { > > > //compute inpx > > > //compute inpw > > > //fast convolution > > > } > > > } > > > } > > > > > > The fast convolution needs to compute multiple times within the for loops. The dimension of the input vector is 256*256. The most time consuming parts are MatMult(), VecPoinstwiseMult() and MatMultTranspose() during fast convolution. The optimal number of processors is 2. Further increase of processor numbers will reduce the efficiency. In this case, would you please suggest a way to improve efficiency and fully make use of parallelization? Thanks. > > From jychang48 at gmail.com Wed Aug 6 22:47:36 2014 From: jychang48 at gmail.com (Justin Chang) Date: Wed, 6 Aug 2014 21:47:36 -0600 Subject: [petsc-users] Using DMPlex for Darcys law In-Reply-To: References: Message-ID: Thank you for the answer, i have a few more questions: 1) In ex62 regarding the functions f0/f1, what's the difference between them? Do f0 correspond with test functions and f1 with the derivatives of the test functions? 2) For darcy's law, the velocity boundary conditions for each surface is simply the normal. i.e. u dot n over Gamma_u = . In DMPlexAddBoundary it seems to me that it constraints every dof corresponding to the mesh point (and field), but is there a way where given a field (say in this case velocity) I only want to prescribe the x velocity on the left and right faces and y velocity on the top and bottom? 3) Is there a way/function for DMPlex to output multiple fields to VTK files? Or would the field solutions have to be manually separated out from the original global solution? Thanks, Justin On Wed, Aug 6, 2014 at 6:27 PM, Matthew Knepley wrote: > On Wed, Aug 6, 2014 at 5:55 PM, Justin Chang wrote: > >> Hi, >> >> So in ex62 of SNES it solves the stokes equation with P2-P1 elements. I >> want to solve the darcy equation with P2-P1 elements in a similar fashion. >> >> The difference between stokes and darcy is that in the weak form of >> darcy, the velocity-velocity term is v*u whereas in stokes it's >> grad[v]*grad[u] >> >> In ex62, the function g3_uu (lines 172-183) formulates the >> grad[v]*grad[u] term but how would I do it for Darcy's equation where its >> simply v*u (assuming drag coefficient is scalar quantity of 1.0)? >> > > So you would want to define g0 instead of g3, since its the u-u term: > > void g0_uu(const PetscScalar u[], const PetscScalar u_t[], const > PetscScalar u_x[], const PetscScalar a[], const PetscScalar a_t[], const > PetscScalar a_x[], const PetscReal x[], PetscScalar g3[]) > { > const PetscInt Ncomp = spatialDim; > PetscInt compI; > > for (compI = 0; compI < Ncomp; ++compI) g0[compI] = u[compI]; > } > > and then register it in SetupProblem: > > ierr = PetscDSSetJacobian(prob, 0, 0, g0_uu, NULL, NULL, > NULL);CHKERRQ(ierr); > > and do not forget to change the residual definition in f0/f1. > > Thanks, > > Matt > > >> Thanks, >> Justin >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jtravs at gmail.com Thu Aug 7 04:39:24 2014 From: jtravs at gmail.com (John Travers) Date: Thu, 7 Aug 2014 11:39:24 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix Message-ID: Hi all, I'm trying to compute a large number of interior complex eigenvalues of a large non-Hermitian matrix. For small test problems I can use a dense matrix, and finding interior eigenvalues worked very well. However, for increasing problem sizes I cannot use this approach as my matrix is not very sparse (about 40% non zero). I need to solve problems with 64000x64000 elements. However my matrix can be very efficiently generated (it contains diagonals and two toeplitz sub matrices), so, by using MatCreateShell etc. I have created a shell matrix with very efficient matrix-vector multiply performance (using FFT for the toeplitz matrices). In this case I can solve for the largest eigenvalues of huge problems very efficiently. However, I now cannot solve for the interior eigenvalues (often closely spaced) well at all (using -eps_target). Is there a well known solution to this? I have tried eps_harmonic etc. Note, I am not an expert in computational linalg, so I maybe being naive. Ideally I'd be able to collect all eigenvalues within a certain region, but the region based solvers (such as ciss) do not seem to be available when using a Shell Matrix, and neither is shift invert, which is what worked very well previously. Does anyone have proposed solutions or pointers to where I can find more literature on this sort of problem. Any help much appreciated! John -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Thu Aug 7 04:53:13 2014 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 7 Aug 2014 11:53:13 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: References: Message-ID: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> El 07/08/2014, a las 11:39, John Travers escribi?: > Hi all, > > I'm trying to compute a large number of interior complex eigenvalues of a large non-Hermitian matrix. For small test problems I can use a dense matrix, and finding interior eigenvalues worked very well. However, for increasing problem sizes I cannot use this approach as my matrix is not very sparse (about 40% non zero). I need to solve problems with 64000x64000 elements. However my matrix can be very efficiently generated (it contains diagonals and two toeplitz sub matrices), so, by using MatCreateShell etc. I have created a shell matrix with very efficient matrix-vector multiply performance (using FFT for the toeplitz matrices). In this case I can solve for the largest eigenvalues of huge problems very efficiently. However, I now cannot solve for the interior eigenvalues (often closely spaced) well at all (using -eps_target). > > Is there a well known solution to this? I have tried eps_harmonic etc. Note, I am not an expert in computational linalg, so I maybe being naive. Ideally I'd be able to collect all eigenvalues within a certain region, but the region based solvers (such as ciss) do not seem to be available when using a Shell Matrix, and neither is shift invert, which is what worked very well previously. > > Does anyone have proposed solutions or pointers to where I can find more literature on this sort of problem. > > Any help much appreciated! > John > You should be able to do inexact shift-and-invert with an iterative linear solver such as gmres or bcgs, although no guarantee it works well for your problem. See section 3.4.1 of the users manual. An alternative is to use a preconditioned eigensolver such as GD or JD. Options for these solvers are described here: http://dx.doi.org/10.1145/2543696 Jose From jtravs at gmail.com Thu Aug 7 05:48:40 2014 From: jtravs at gmail.com (John Travers) Date: Thu, 7 Aug 2014 12:48:40 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> References: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> Message-ID: <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> On 07 Aug 2014, at 11:53, Jose E. Roman wrote: > > El 07/08/2014, a las 11:39, John Travers escribi?: > >> Hi all, >> >> I'm trying to compute a large number of interior complex eigenvalues of a large non-Hermitian matrix. For small test problems I can use a dense matrix, and finding interior eigenvalues worked very well. However, for increasing problem sizes I cannot use this approach as my matrix is not very sparse (about 40% non zero). I need to solve problems with 64000x64000 elements. However my matrix can be very efficiently generated (it contains diagonals and two toeplitz sub matrices), so, by using MatCreateShell etc. I have created a shell matrix with very efficient matrix-vector multiply performance (using FFT for the toeplitz matrices). In this case I can solve for the largest eigenvalues of huge problems very efficiently. However, I now cannot solve for the interior eigenvalues (often closely spaced) well at all (using -eps_target). >> >> Is there a well known solution to this? I have tried eps_harmonic etc. Note, I am not an expert in computational linalg, so I maybe being naive. Ideally I'd be able to collect all eigenvalues within a certain region, but the region based solvers (such as ciss) do not seem to be available when using a Shell Matrix, and neither is shift invert, which is what worked very well previously. >> >> Does anyone have proposed solutions or pointers to where I can find more literature on this sort of problem. >> >> Any help much appreciated! >> John >> > > You should be able to do inexact shift-and-invert with an iterative linear solver such as gmres or bcgs, although no guarantee it works well for your problem. See section 3.4.1 of the users manual. > > An alternative is to use a preconditioned eigensolver such as GD or JD. Options for these solvers are described here: http://dx.doi.org/10.1145/2543696 > > Jose > Hi Jose, Thanks for your fast response. I?m reading through your paper now (though it is a little advanced for me). Some simple trials with the GD solver do not seem to work. Following your paper, I simply tried: -eps_type gd, but get: 0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: gd only works with precond spectral transformation Should I also set other options? Thanks, John From jroman at dsic.upv.es Thu Aug 7 06:30:31 2014 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 7 Aug 2014 13:30:31 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> References: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> Message-ID: <2810DA2B-605C-420F-8AF8-4D6DDC200CED@dsic.upv.es> El 07/08/2014, a las 12:48, John Travers escribi?: > Hi Jose, > > Thanks for your fast response. I?m reading through your paper now (though it is a little advanced for me). Some simple trials with the GD solver do not seem to work. Following your paper, I simply tried: -eps_type gd, but get: > > 0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: gd only works with precond spectral transformation > > Should I also set other options? > > Thanks, > John Add -st_type precond From jtravs at gmail.com Thu Aug 7 07:05:38 2014 From: jtravs at gmail.com (John Travers) Date: Thu, 7 Aug 2014 14:05:38 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: <2810DA2B-605C-420F-8AF8-4D6DDC200CED@dsic.upv.es> References: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> <2810DA2B-605C-420F-8AF8-4D6DDC200CED@dsic.upv.es> Message-ID: <9C6A9C7A-7546-4261-9E6E-DC36ED97CCED@gmail.com> On 07 Aug 2014, at 13:30, Jose E. Roman wrote: > -st_type precond I tried that and got: [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: EPSGD only works with KSPPREONLY So I set: -st_ksp_type preonly and get: [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: ST does not have apply My full command line is currently: -eps_nev 1 -eps_tol 1e-10 -eps_type gd -st_type precond -st_ksp_type preonly I also tried -st_matmode shell But it made no difference. Really, thank you very much for your patience. I?m trying to educate myself about slepc (which is awesome BTW, so thank you), but there are a huge number of options! From jroman at dsic.upv.es Thu Aug 7 07:31:04 2014 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 7 Aug 2014 14:31:04 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: <9C6A9C7A-7546-4261-9E6E-DC36ED97CCED@gmail.com> References: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> <2810DA2B-605C-420F-8AF8-4D6DDC200CED@dsic.upv.es> <9C6A9C7A-7546-4261-9E6E-DC36ED97CCED@gmail.com> Message-ID: El 07/08/2014, a las 14:05, John Travers escribi?: > On 07 Aug 2014, at 13:30, Jose E. Roman wrote: > >> -st_type precond > > I tried that and got: > > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: EPSGD only works with KSPPREONLY > > So I set: > -st_ksp_type preonly > > and get: > > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: ST does not have apply > > My full command line is currently: > > -eps_nev 1 -eps_tol 1e-10 -eps_type gd -st_type precond -st_ksp_type preonly > > I also tried > > -st_matmode shell > > But it made no difference. > > Really, thank you very much for your patience. I?m trying to educate myself > about slepc (which is awesome BTW, so thank you), but there are a huge > number of options! > > These options work well with SLEPc's ex1.c, so you must have something different in your source code. Send the code excerpt that sets EPS/ST options. Jose From jtravs at gmail.com Thu Aug 7 09:43:47 2014 From: jtravs at gmail.com (John Travers) Date: Thu, 7 Aug 2014 16:43:47 +0200 Subject: [petsc-users] Interior eigenvalues with slepc and shell matrix In-Reply-To: References: <754AA3CC-D7D7-44B5-8B57-8388BB20A4F4@dsic.upv.es> <2DE5CA58-03D6-483B-895A-3F9462B4297D@gmail.com> <2810DA2B-605C-420F-8AF8-4D6DDC200CED@dsic.upv.es> <9C6A9C7A-7546-4261-9E6E-DC36ED97CCED@gmail.com> Message-ID: On 07 Aug 2014, at 14:31, Jose E. Roman wrote: > > El 07/08/2014, a las 14:05, John Travers escribi?: > >> On 07 Aug 2014, at 13:30, Jose E. Roman wrote: >> >>> -st_type precond >> >> I tried that and got: >> >> [0]PETSC ERROR: No support for this operation for this object type >> [0]PETSC ERROR: EPSGD only works with KSPPREONLY >> >> So I set: >> -st_ksp_type preonly >> >> and get: >> >> [0]PETSC ERROR: No support for this operation for this object type >> [0]PETSC ERROR: ST does not have apply >> >> My full command line is currently: >> >> -eps_nev 1 -eps_tol 1e-10 -eps_type gd -st_type precond -st_ksp_type preonly >> >> I also tried >> >> -st_matmode shell >> >> But it made no difference. >> >> Really, thank you very much for your patience. I?m trying to educate myself >> about slepc (which is awesome BTW, so thank you), but there are a huge >> number of options! >> >> > > These options work well with SLEPc's ex1.c, so you must have something different in your source code. Send the code excerpt that sets EPS/ST options. > > Jose > Yes, of course you were correct. I was doing something strange with the ST object. It now works. Thanks again for your help! John From danyang.su at gmail.com Thu Aug 7 10:15:20 2014 From: danyang.su at gmail.com (Danyang Su) Date: Thu, 07 Aug 2014 08:15:20 -0700 Subject: [petsc-users] Variable and function reference problem in Windows & Linux Message-ID: <53E39808.8050200@gmail.com> Hi All, I have the codes first developed on Windows OS, it works fine. Now the codes have been ported to Linux, there are some compiling errors regarding some variable and function definition, as shown below. 1. DMDA_BOUNDARY_NONE & DM_BOUNDARY_NONE I should use DMDA_BOUNDARY_NONE on windows and DM_BOUNDARY_NONE on linux, otherwise, there will be like undefined type. 2. DMDAGetGlobalIndicesF90 This function works fine on Windows but results into undefined reference on Linux. The development environment are as follows: Windows: PETSc 3.4.4, Intel Parallel Studio 2013XE (Fortran) Linux: PETSc 3.5.1, Gfortran 4.8.2. How to solver this problem, especially the second one. Thanks and Regards, Danyang From ppate024 at odu.edu Thu Aug 7 11:08:11 2014 From: ppate024 at odu.edu (Priyank Patel) Date: Thu, 7 Aug 2014 12:08:11 -0400 Subject: [petsc-users] Error using scalapack with PETSC Message-ID: Hello, I am working on a C program that includes PETSC and MKL, it is working file with mkl but when I tried to include scalapack function in the same program it is showing me error like below, -------------------------------------------------------------------------------------------------------------------------------------------- blockCG_1.c:365: warning: implicit declaration of function 'numroc_' blockCG_1.c:368: warning: implicit declaration of function 'descinit_' --------------------------------------------------------------------------------------------------------------------------------------------- My makefile is as below --------------------------------------------------------------------------------------------------------------------------------------------- PETSC_DIR=/export/software/petsc-3.3 INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ INTEL_LIB_PATH_64 =/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ MKL_INC_PATH=/export/software/intel/mkl/include/ SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ CLINKER=gcc PKG_INC = -I${MKL_INC_PATH} PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -lmkl_blacs_lp64 -lmkl_\ scalapack_ilp64 -lmkl_blacs_openmpi_lp64 -Wl,-rpath,${INTEL_LIB_PATH_64} -L${INTEL_LIB_PATH_64} -liomp5 -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -blas CFLAGS = FFLAGS = CPPFLAGS = ${PKG_INC} FPPFLAGS = CLEANFILES = include ${PETSC_DIR}/conf/variables include ${PETSC_DIR}/conf/rules blockCG_1: blockCG_1.o chkopts -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} -------------------------------------------------------------------------------------------------------------------------------------------- Can you please guide me that how can I find this functions from my program? I mean how can I include scalapack in my program and compile it? And is there any header file I have to include in the program? I have scalapack installed separately. Thanks for your time, Priyank ppate024 at odu.edu -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 7 11:14:06 2014 From: jed at jedbrown.org (Jed Brown) Date: Thu, 07 Aug 2014 11:14:06 -0500 Subject: [petsc-users] [petsc-maint] Error using scalapack with PETSC In-Reply-To: References: Message-ID: <87bnrwcm5t.fsf@jedbrown.org> Priyank Patel writes: > Hello, > > I am working on a C program that includes PETSC and MKL, it is working file > with mkl but when I tried to include scalapack function in the same program > it is showing me error like below, > > -------------------------------------------------------------------------------------------------------------------------------------------- > blockCG_1.c:365: warning: implicit declaration of function 'numroc_' > blockCG_1.c:368: warning: implicit declaration of function 'descinit_' These are warnings, not errors, and look like they are in your code, not PETSc. This mailing list isn't the right forum, but you might try searching, e.g., https://software.intel.com/en-us/forums/topic/375030 -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jed at jedbrown.org Thu Aug 7 11:27:08 2014 From: jed at jedbrown.org (Jed Brown) Date: Thu, 07 Aug 2014 11:27:08 -0500 Subject: [petsc-users] Variable and function reference problem in Windows & Linux In-Reply-To: <53E39808.8050200@gmail.com> References: <53E39808.8050200@gmail.com> Message-ID: <8738d8clk3.fsf@jedbrown.org> Danyang Su writes: > Hi All, > > I have the codes first developed on Windows OS, it works fine. Now the > codes have been ported to Linux, there are some compiling errors > regarding some variable and function definition, as shown below. > > 1. DMDA_BOUNDARY_NONE & DM_BOUNDARY_NONE > I should use DMDA_BOUNDARY_NONE on windows and DM_BOUNDARY_NONE on > linux, otherwise, there will be like undefined type. Looks like you upgraded PETSc. * DMDABoundaryType has become DMBoundaryType, and all the enumeration values have also been renamed. http://www.mcs.anl.gov/petsc/documentation/changes/35.html > 2. DMDAGetGlobalIndicesF90 > This function works fine on Windows but results into undefined reference > on Linux. * DMDAGetGlobalIndices(DM,PetscInt*,const PetscInt*[]) and DMDARestoreGlobalIndices(DM,PetscInt*,const PetscInt*[]) are removed, use DMGetLocalToGlobalMapping() to get this information http://www.mcs.anl.gov/petsc/documentation/changes/35.html -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From zinlin.zinlin at gmail.com Thu Aug 7 16:36:39 2014 From: zinlin.zinlin at gmail.com (Zin Lin) Date: Thu, 7 Aug 2014 17:36:39 -0400 Subject: [petsc-users] Problem with MATSOLVERPASTIX using KSPSolveTranspose In-Reply-To: <877g315g6u.fsf@jedbrown.org> References: <877g315g6u.fsf@jedbrown.org> Message-ID: Is there any chance that I could implement the transpose solve with PCApplyTranspose etc on my own (rather than using a new KSP and PC context which re-factorizes the transpose matrix)? Thanks Zin On Fri, Jul 25, 2014 at 4:36 PM, Jed Brown wrote: > Zin Lin writes: > > > Hi, > > > > I am having trouble calling KSPSolveTranspose under MATSOLVERPASTIX. > > The following is a very simple C code solving A^T x = b to illustrate the > > issue. The matrix A and vector b are built following the PETSC tutorial. > > KSPSolve works fine but when it comes to KSPSolveTranspose, it spits out > > the error: > > > > [0]PETSC ERROR: --------------------- Error Message > > ------------------------------------ > > [0]PETSC ERROR: No support for this operation for this object type! > > [0]PETSC ERROR: Matrix type mpiaij! > > > > The code runs fine if I change the solver package MATSOLVERPASTIX to > > MATSOLVERMUMPS. > > However, I need the PASTIX solver and the transpose solution for solving > a > > large problem. > > Could you please let me know what is wrong with the PASTIX solver or with > > my usage? > > The contributed PaStiX interface does not include > MatSolveTranspose_PaStiX. If there is a way to do this in PaStiX, it > should be added to the interface. > -- Zin Lin -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 7 20:58:05 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 7 Aug 2014 20:58:05 -0500 Subject: [petsc-users] Problem with MATSOLVERPASTIX using KSPSolveTranspose In-Reply-To: References: <877g315g6u.fsf@jedbrown.org> Message-ID: <98CA4FB5-EE1A-4599-9DF1-8995DB002466@mcs.anl.gov> Yes, you would need to locate MatSolve_PaStiX() in pastix.c make a copy of the function as needed to do the transpose solve and then where you find if (lu->matstruc == DIFFERENT_NONZERO_PATTERN) { (F)->ops->solve = MatSolve_PaStiX; add the function pointer for the transpose solve. See https://bitbucket.org/petsc/petsc/wiki/Home (and follow the link to Read detailed instructions for Git for detailed information) in such a way that you can easily contribute your additions back to PETSc so everyone can benefit from the transpose solve. Barry On Aug 7, 2014, at 4:36 PM, Zin Lin wrote: > Is there any chance that I could implement the transpose solve with PCApplyTranspose etc on my own (rather than using a new KSP and PC context which re-factorizes the transpose matrix)? > > Thanks > Zin > > > > On Fri, Jul 25, 2014 at 4:36 PM, Jed Brown wrote: > Zin Lin writes: > > > Hi, > > > > I am having trouble calling KSPSolveTranspose under MATSOLVERPASTIX. > > The following is a very simple C code solving A^T x = b to illustrate the > > issue. The matrix A and vector b are built following the PETSC tutorial. > > KSPSolve works fine but when it comes to KSPSolveTranspose, it spits out > > the error: > > > > [0]PETSC ERROR: --------------------- Error Message > > ------------------------------------ > > [0]PETSC ERROR: No support for this operation for this object type! > > [0]PETSC ERROR: Matrix type mpiaij! > > > > The code runs fine if I change the solver package MATSOLVERPASTIX to > > MATSOLVERMUMPS. > > However, I need the PASTIX solver and the transpose solution for solving a > > large problem. > > Could you please let me know what is wrong with the PASTIX solver or with > > my usage? > > The contributed PaStiX interface does not include > MatSolveTranspose_PaStiX. If there is a way to do this in PaStiX, it > should be added to the interface. > > > > -- > Zin Lin > From anush at bu.edu Thu Aug 7 22:46:50 2014 From: anush at bu.edu (Anush Krishnan) Date: Thu, 7 Aug 2014 23:46:50 -0400 Subject: [petsc-users] force KSP to perform at least a single iteration In-Reply-To: <87mwbt1okx.fsf@jedbrown.org> References: <87mwbt1okx.fsf@jedbrown.org> Message-ID: Hi Jed, Is there any reason why ATOL needs to be set for transient problems? Are there any references you can point me to? I've been experiencing some issues with transient problems where sometimes the flow stops evolving and the linear solvers exit after zero iterations, and was wondering if this might help. Thanks, Anush On 28 July 2014 11:37, Jed Brown wrote: > Rolf Kuiper writes: > > I need this to e.g. solve a linear system of equations several times > > (as the physical system proceeds in time); during a single call / > > timestep, the system, might not change stronger than the RTOL in use, > > but in the long-run (several hundreds to thousands of calls), the > > system will actually change by several RTOL; nonetheless, the default > > KSP solver stops without doing any iteration (= 0), i.e. the system > > does not change at all. > > When you use -ksp_converged_reason, is it completing due to RTOL or > ATOL? For transient problems, it's often good to set an absolute > tolerance. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From cedric.doucet at inria.fr Fri Aug 8 06:59:29 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Fri, 8 Aug 2014 13:59:29 +0200 (CEST) Subject: [petsc-users] Correct usage of CHKERRXX In-Reply-To: <1772323533.9940458.1407498909537.JavaMail.zimbra@inria.fr> Message-ID: <944854178.9941416.1407499168997.JavaMail.zimbra@inria.fr> Hello, I need to call several functions from Petsc in a C++ code. I would like to handle manage errors from Petsc with exceptions. In Petsc's documentation, I found that there exists a macro to do that : CHKERRXX. How does it work? Which kind of exception does it throw in case of failure? Do you inherit from std::exception? Is there an exception for each error code? Best, C?dric -------------- next part -------------- An HTML attachment was scrubbed... URL: From rupp at iue.tuwien.ac.at Fri Aug 8 07:16:25 2014 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Fri, 8 Aug 2014 14:16:25 +0200 Subject: [petsc-users] Correct usage of CHKERRXX In-Reply-To: <944854178.9941416.1407499168997.JavaMail.zimbra@inria.fr> References: <944854178.9941416.1407499168997.JavaMail.zimbra@inria.fr> Message-ID: <53E4BF99.5020306@iue.tuwien.ac.at> Hi Cedric, > I need to call several functions from Petsc in a C++ code. > I would like to handle manage errors from Petsc with exceptions. > > In Petsc's documentation, I found that there exists a macro to do that : > CHKERRXX. > > How does it work? It checks for a nonzero error code and returns from the function immediately if that is the case. Have a look at the implementation here: http://www.mcs.anl.gov/petsc/petsc-3.5/include/petscerror.h.html > Which kind of exception does it throw in case of failure? > Do you inherit from std::exception? > Is there an exception for each error code? Neither. You would have to write your own wrapper around it, translating the error codes into exceptions. PETSc cannot use exceptions since it is a C library. Some people also argue against exceptions because they tend to bloat the executable for all the roll-back code. Best regards, Karli From cedric.doucet at inria.fr Fri Aug 8 07:29:12 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Fri, 8 Aug 2014 14:29:12 +0200 (CEST) Subject: [petsc-users] Correct usage of CHKERRXX In-Reply-To: <53E4BF99.5020306@iue.tuwien.ac.at> References: <944854178.9941416.1407499168997.JavaMail.zimbra@inria.fr> <53E4BF99.5020306@iue.tuwien.ac.at> Message-ID: <1031632404.9947188.1407500952825.JavaMail.zimbra@inria.fr> Hi Karl, thank you very much for your answer! I will implement a wrapper for handling petsc error codes using the html page you mention. Have a nice day! C?dric ----- Mail original ----- > De: "Karl Rupp" > ?: "Cedric Doucet" , petsc-users at mcs.anl.gov > Envoy?: Vendredi 8 Ao?t 2014 14:16:25 > Objet: Re: [petsc-users] Correct usage of CHKERRXX > > Hi Cedric, > > > I need to call several functions from Petsc in a C++ code. > > I would like to handle manage errors from Petsc with exceptions. > > > > In Petsc's documentation, I found that there exists a macro to do that : > > CHKERRXX. > > > > How does it work? > > It checks for a nonzero error code and returns from the function > immediately if that is the case. Have a look at the implementation here: > http://www.mcs.anl.gov/petsc/petsc-3.5/include/petscerror.h.html > > > Which kind of exception does it throw in case of failure? > > Do you inherit from std::exception? > > Is there an exception for each error code? > > Neither. You would have to write your own wrapper around it, translating > the error codes into exceptions. PETSc cannot use exceptions since it is > a C library. Some people also argue against exceptions because they tend > to bloat the executable for all the roll-back code. > > Best regards, > Karli > > From sghosh2012 at gatech.edu Fri Aug 8 13:19:39 2014 From: sghosh2012 at gatech.edu (Ghosh, Swarnava) Date: Fri, 8 Aug 2014 14:19:39 -0400 (EDT) Subject: [petsc-users] KSPSetUp hanging up with HYPRE preconditioner In-Reply-To: <960209476.46783326.1407521786555.JavaMail.root@mail.gatech.edu> Message-ID: <1753302502.46784884.1407521979961.JavaMail.root@mail.gatech.edu> Hello, I am using petsc 3.4.1 interfaced with hypre 2.9.0b I am using the following lines of code to solve a Poisson equation using KSPGMRES with HYPRE preconditioner. pOfdft->laplaceOpr is a sparse matrix in MATMPIBAIJ format. KSPCreate(PETSC_COMM_WORLD,&pOfdft->ksp); KSPSetType(pOfdft->ksp,KSPGMRES); KSPSetTolerances(pOfdft->ksp,KSPTOL,PETSC_DEFAULT,PETSC_DEFAULT,PETSC_DEFAULT); KSPSetOperators(pOfdft->ksp,pOfdft->laplaceOpr,pOfdft->laplaceOpr,SAME_NONZERO_PATTERN); KSPGetPC(pOfdft->ksp,&pOfdft->pc); PCSetType(pOfdft->pc,PCHYPRE); PCHYPRESetType(pOfdft->pc,"boomeramg"); KSPSetFromOptions(pOfdft->ksp); KSPSetUp(pOfdft->ksp); The code runs fine when the size of matrix is small (4096 X 4096). BUT the code remains stuck in KSPSetUp function when the size of matrix is bigger (262144 x262144) on 64 cores 120 gb ram. Could you please let me know the probable reason the why the code is hanging in KSPSetUp. If possible could you please share some C examples where you use a HYPRE preconditioner for solving a large system Thanks, Swarnava -- Swarnava Ghosh PhD Candidate, Structural Engineering, Mechanics and Materials School of Civil and Environmental Engineering Georgia Institute of Technology Atlanta, GA 30332 From knepley at gmail.com Fri Aug 8 13:24:36 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 8 Aug 2014 13:24:36 -0500 Subject: [petsc-users] Using DMPlex for Darcys law In-Reply-To: References: Message-ID: On Wed, Aug 6, 2014 at 10:47 PM, Justin Chang wrote: > Thank you for the answer, i have a few more questions: > > 1) In ex62 regarding the functions f0/f1, what's the difference between > them? Do f0 correspond with test functions and f1 with the derivatives of > the test functions? > The residual F is calculated using F(u) = \int_\Omega phi f_0(u, grad u) + grad phi . f_1(u, grad u) This formulation is in my slides and also this paper http://arxiv.org/abs/1309.1204. > 2) For darcy's law, the velocity boundary conditions for each surface is > simply the normal. i.e. u dot n over Gamma_u = . In > DMPlexAddBoundary it seems to me that it constraints every dof > corresponding to the mesh point (and field), but is there a way where given > a field (say in this case velocity) I only want to prescribe the x velocity > on the left and right faces and y velocity on the top and bottom? > You are describing a Neumann condition. If you look at ex12, I show both Dirichlet and Neumann conditions. The Neumann conditions end up integrating your function over the boundary (that is what comes out of integration by parts). So you do that AddBoundary() setting isEssential to PETSC_FALSE. > 3) Is there a way/function for DMPlex to output multiple fields to VTK > files? Or would the field solutions have to be manually separated out from > the original global solution? > VTK is very limited. I would switch to using HDF5. The fields are automatically split up and there is a Python script for generating Xdmf files which make the HDF5 usable from Paraview just like VTK. If you do not like that, you can try Jed's VTU but I have not tried it yet. Thanks, Matt > Thanks, > Justin > > > On Wed, Aug 6, 2014 at 6:27 PM, Matthew Knepley wrote: > >> On Wed, Aug 6, 2014 at 5:55 PM, Justin Chang wrote: >> >>> Hi, >>> >>> So in ex62 of SNES it solves the stokes equation with P2-P1 elements. I >>> want to solve the darcy equation with P2-P1 elements in a similar fashion. >>> >>> The difference between stokes and darcy is that in the weak form of >>> darcy, the velocity-velocity term is v*u whereas in stokes it's >>> grad[v]*grad[u] >>> >>> In ex62, the function g3_uu (lines 172-183) formulates the >>> grad[v]*grad[u] term but how would I do it for Darcy's equation where its >>> simply v*u (assuming drag coefficient is scalar quantity of 1.0)? >>> >> >> So you would want to define g0 instead of g3, since its the u-u term: >> >> void g0_uu(const PetscScalar u[], const PetscScalar u_t[], const >> PetscScalar u_x[], const PetscScalar a[], const PetscScalar a_t[], const >> PetscScalar a_x[], const PetscReal x[], PetscScalar g3[]) >> { >> const PetscInt Ncomp = spatialDim; >> PetscInt compI; >> >> for (compI = 0; compI < Ncomp; ++compI) g0[compI] = u[compI]; >> } >> >> and then register it in SetupProblem: >> >> ierr = PetscDSSetJacobian(prob, 0, 0, g0_uu, NULL, NULL, >> NULL);CHKERRQ(ierr); >> >> and do not forget to change the residual definition in f0/f1. >> >> Thanks, >> >> Matt >> >> >>> Thanks, >>> Justin >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 8 13:26:20 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 8 Aug 2014 13:26:20 -0500 Subject: [petsc-users] KSPSetUp hanging up with HYPRE preconditioner In-Reply-To: <1753302502.46784884.1407521979961.JavaMail.root@mail.gatech.edu> References: <960209476.46783326.1407521786555.JavaMail.root@mail.gatech.edu> <1753302502.46784884.1407521979961.JavaMail.root@mail.gatech.edu> Message-ID: On Fri, Aug 8, 2014 at 1:19 PM, Ghosh, Swarnava wrote: > Hello, > > I am using petsc 3.4.1 interfaced with hypre 2.9.0b > > I am using the following lines of code to solve a Poisson equation > using KSPGMRES with HYPRE preconditioner. > pOfdft->laplaceOpr is a sparse matrix in MATMPIBAIJ format. > > KSPCreate(PETSC_COMM_WORLD,&pOfdft->ksp); > KSPSetType(pOfdft->ksp,KSPGMRES); > > KSPSetTolerances(pOfdft->ksp,KSPTOL,PETSC_DEFAULT,PETSC_DEFAULT,PETSC_DEFAULT); > > KSPSetOperators(pOfdft->ksp,pOfdft->laplaceOpr,pOfdft->laplaceOpr,SAME_NONZERO_PATTERN); > KSPGetPC(pOfdft->ksp,&pOfdft->pc); > PCSetType(pOfdft->pc,PCHYPRE); > PCHYPRESetType(pOfdft->pc,"boomeramg"); > KSPSetFromOptions(pOfdft->ksp); > KSPSetUp(pOfdft->ksp); > > The code runs fine when the size of matrix is small (4096 X 4096). > BUT the code remains stuck in KSPSetUp function when the size of > matrix is bigger (262144 x262144) on 64 cores 120 gb ram. > > Could you please let me know the probable reason the why the code is > hanging in KSPSetUp. > If possible could you please share some C examples where you use a > HYPRE preconditioner for solving a large system > To me it sounds like Hypre is not "hanging up", but "taking a long time". Hypre can have a large setup time compared to some other types of MG, for example agglomeration. You could compare using -pc_type gamg. Thanks, Matt > Thanks, > Swarnava > > > -- > Swarnava Ghosh > PhD Candidate, > Structural Engineering, Mechanics and Materials > School of Civil and Environmental Engineering > Georgia Institute of Technology > Atlanta, GA 30332 > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 8 13:27:59 2014 From: jed at jedbrown.org (Jed Brown) Date: Fri, 08 Aug 2014 13:27:59 -0500 Subject: [petsc-users] KSPSetUp hanging up with HYPRE preconditioner In-Reply-To: <1753302502.46784884.1407521979961.JavaMail.root@mail.gatech.edu> References: <1753302502.46784884.1407521979961.JavaMail.root@mail.gatech.edu> Message-ID: <87bnrultu8.fsf@jedbrown.org> "Ghosh, Swarnava" writes: > Hello, > > I am using petsc 3.4.1 interfaced with hypre 2.9.0b > > I am using the following lines of code to solve a Poisson equation using KSPGMRES with HYPRE preconditioner. > pOfdft->laplaceOpr is a sparse matrix in MATMPIBAIJ format. > > KSPCreate(PETSC_COMM_WORLD,&pOfdft->ksp); > KSPSetType(pOfdft->ksp,KSPGMRES); > KSPSetTolerances(pOfdft->ksp,KSPTOL,PETSC_DEFAULT,PETSC_DEFAULT,PETSC_DEFAULT); > KSPSetOperators(pOfdft->ksp,pOfdft->laplaceOpr,pOfdft->laplaceOpr,SAME_NONZERO_PATTERN); > KSPGetPC(pOfdft->ksp,&pOfdft->pc); > PCSetType(pOfdft->pc,PCHYPRE); > PCHYPRESetType(pOfdft->pc,"boomeramg"); > KSPSetFromOptions(pOfdft->ksp); > KSPSetUp(pOfdft->ksp); > > The code runs fine when the size of matrix is small (4096 X 4096). > BUT the code remains stuck in KSPSetUp function when the size of matrix is bigger (262144 x262144) on 64 cores 120 gb ram. Use a debugger to get a stack trace of where it "hangs". > Could you please let me know the probable reason the why the code is hanging in KSPSetUp. > If possible could you please share some C examples where you use a HYPRE preconditioner for solving a large system src/ksp/ksp/examples/tutorials/ex2.c ./ex2 -m 1000 -n 1000 -pc_type hypre -ksp_monitor has a million degrees of freedom. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jed at jedbrown.org Fri Aug 8 15:19:24 2014 From: jed at jedbrown.org (Jed Brown) Date: Fri, 08 Aug 2014 15:19:24 -0500 Subject: [petsc-users] force KSP to perform at least a single iteration In-Reply-To: References: <87mwbt1okx.fsf@jedbrown.org> Message-ID: <87tx5mka43.fsf@jedbrown.org> Anush Krishnan writes: > Hi Jed, > > Is there any reason why ATOL needs to be set for transient problems? If the solution does not change for a step, the initial algebraic residual will be as small as it was at convergence on the last time step. If you solve to an RTOL, the solve will be much more accurate than it needs to be. With ATOL, you solve only as accurately as needed and know when to exit early from slowly-changing solutions. Similarly, when the solution changes rapidly on a time step (e.g., from 1 to 1e10), a very accurate relative tolerance might be needed. In general, it's best to non-dimensionalize your problem and understand the scales so that you can write a suitable absolute tolerance. > Are there any references you can point me to? I've been experiencing > some issues with transient problems where sometimes the flow stops > evolving and the linear solvers exit after zero iterations, and was > wondering if this might help. Exiting after 0 iterations might be correct. Check the converged reason. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From hk at discardmail.de Sat Aug 9 18:24:40 2014 From: hk at discardmail.de (organization-un) Date: Sun, 10 Aug 2014 01:24:40 +0200 Subject: [petsc-users] Respond to the information in the letter Message-ID: <20140809232518.8B7FC526616@mailhub.siol.net> A non-text attachment was scrubbed... Name: UNO payment Draft Notification.rtf Type: application/octet-stream Size: 3303 bytes Desc: not available URL: From wumengda at gmail.com Mon Aug 11 08:24:00 2014 From: wumengda at gmail.com (Mengda Wu) Date: Mon, 11 Aug 2014 09:24:00 -0400 Subject: [petsc-users] Petsc compilation with -MDd using visual studio c++ 2008 In-Reply-To: References: Message-ID: Hi Satish, I think this problem happens in the latest 3.5.1 version. On windows 7 with VS2012, I configured with (under Cygwin): ./config/configure.py --with-cc='cl' --with-fc=0 --with-cxx='cl' --with-mpi=0 --with-debugging=1 --download-f2cblaslapack=/cygdrive/d/Library/PETSc/download/f2cblaslapack-3.4.2.q1.tar.gz --with-sowing=0 --with-c2html=0 -CFLAGS='-MDd -wd4996' -CXXFLAGS='-MDd -wd4996' After configure, in petsc-3.5.1\arch-mswin-c-debug\externalpackages\f2cblaslapack-3.4.2.q1 CC = /cygdrive/d/Library/PETSc/petsc-3.5.1/bin/win32fe/win32fe cl COPTFLAGS = -MDd -wd4996 -Z7 CNOOPT = -MD So CNOOPT does not get correct "-MDd", which causes the VC dll mismatch after compilation of Petsc debug. There was no problem with petsc-3.4.3. I am trying to upgrade to 3.5.1 and the problem came out. Could you please take a look? Thanks, Mengda On Sun, Dec 18, 2011 at 2:14 PM, Satish Balay wrote: > On Sun, 18 Dec 2011, Mengda Wu wrote: > > > Hi all, > > > > I am trying to compile with a debug version of Petsc with -MDd options > > using visual studio c++ 2008. The following options are used. > > > > ./config/configure.py --with-cc='cl' --with-fc=0 --with-cxx='cl' > > --with-mpi=0 --with-debugging=1 > > --download-f2cblaslapack=/path/to/f2cblaslapack-3.1.1.q.tar.gz > > -CFLAGS='-MDd -wd4996' -CXXFLAGS='-MDd -wd4996' > > > > But it seems that f2cblaslapack does not recognize "-MDd" completely. > Some > > files are still compiled with '-MD' instead of "-MDd". This will lead to > a > > problem that not all libraries are linked with the same MS C library. I > > think it may be caused by the variable "CNOOPT" is not set properly in > > config/BuildSystem/config/packages/f2cblaslapack.py and > > config/BuildSystem/config/packages/BlasLapack.py. Only '-MD' is present > > there. See > > > > def getWindowsNonOptFlags(self,cflags): > > for flag in ['-MT','-MTd','-MD','-threads']: > > if cflags.find(flag) >=0: return flag > > return '' > > > > If I substitute '-MD' with '-MDd', then it works. But this will lead to > > problem when '-MD' is preferred. > > > > You can just add 'MDd' to that list. > > i.e > > for flag in ['-MT','-MTd','-MD','-MDd','-threads']: > > Will add this for the next patch update to petsc-3.2 > > Satish > > > I am wondering if anyone can fix this problem. > > > > Thanks, > > Mengda > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From khaipham at utexas.edu Mon Aug 11 09:23:57 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Mon, 11 Aug 2014 09:23:57 -0500 Subject: [petsc-users] Error to TaoSolve() call Message-ID: Hello, I call TaosSolve() in my code. The solution vector is a nested and Jacobian matrix is nested too. It shows me the error: [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors [1]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in stack below [0]PETSC ERROR: --------------------- Stack Frames ------------------------------------ [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, [0]PETSC ERROR: INSTEAD the line number of the start of the function [0]PETSC ERROR: is given. [0]PETSC ERROR: [0] VecRestoreArray_Nest line 731 /home/khp/bin/petsc-3.5.1/src/vec/vec/impls/nest/vecnest.c [0]PETSC ERROR: [0] VecRestoreArray line 1656 /home/khp/bin/petsc-3.5.1/src/vec/vec/interface/rvector.c [0]PETSC ERROR: [0] VecMedian line 806 /home/khp/bin/petsc-3.5.1/src/vec/vec/utils/projection.c [0]PETSC ERROR: [0] TaoSolve_SSILS line 52 /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c [0]PETSC ERROR: [0] TaoSolve line 171 /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c I debugged with valgrind and received the following message: ==19424== Invalid read of size 8 ==19424== at 0x54089E4: VecRestoreArray_Nest (vecnest.c:746) ==19424== by 0x53F5F6F: VecRestoreArray (rvector.c:1666) ==19424== by 0x54BE874: VecMedian (projection.c:855) ==19424== by 0x6247B74: TaoSolve_SSILS (ssils.c:59) ==19424== by 0x620739E: TaoSolve (taosolver.c:188) ==19424== by 0x40491C: main (main.cpp:265) ==19424== Address 0x0 is not stack'd, malloc'd or (recently) free'd It looks like the bug relates to the nested vector. Could you please give me a hint to locate the bug? Thanks. Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From jason.sarich at gmail.com Mon Aug 11 10:17:28 2014 From: jason.sarich at gmail.com (Jason Sarich) Date: Mon, 11 Aug 2014 10:17:28 -0500 Subject: [petsc-users] Error to TaoSolve() call In-Reply-To: <91b107a901ec4e4ea8ac49e346397c5e@LUCKMAN.anl.gov> References: <91b107a901ec4e4ea8ac49e346397c5e@LUCKMAN.anl.gov> Message-ID: Hello Khai The likely culprit is in petsc/src/vec/vec/utils/projection.c, at the end of the VecMedian() there are three calls to VecRestore(), the last of which is wrong and needs to be corrected and recompiled: @@ -852,7 +852,7 @@ PetscErrorCode VecMedian(Vec Vec1, Vec Vec2, Vec Vec3, Vec VMedian) ierr = VecRestoreArray(Vec1,&v1);CHKERRQ(ierr); ierr = VecRestoreArray(Vec2,&v2);CHKERRQ(ierr); - ierr = VecRestoreArray(Vec3,&v2);CHKERRQ(ierr); + ierr = VecRestoreArray(Vec3,&v3);CHKERRQ(ierr); if (VMedian!=Vec1 && VMedian != Vec2 && VMedian != Vec3){ ierr = VecRestoreArray(VMedian,&vmed);CHKERRQ(ierr); Jason Sarich On Mon, Aug 11, 2014 at 9:23 AM, Khai Hong Pham wrote: > Hello, > > I call TaosSolve() in my code. The solution vector is a nested and Jacobian > matrix is nested too. It shows me the error: > > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > [0]PETSC ERROR: or see > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC ERROR: > or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory > corruption errors > [1]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in stack > below > [0]PETSC ERROR: --------------------- Stack Frames > ------------------------------------ > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, > [0]PETSC ERROR: INSTEAD the line number of the start of the function > [0]PETSC ERROR: is given. > [0]PETSC ERROR: [0] VecRestoreArray_Nest line 731 > /home/khp/bin/petsc-3.5.1/src/vec/vec/impls/nest/vecnest.c > [0]PETSC ERROR: [0] VecRestoreArray line 1656 > /home/khp/bin/petsc-3.5.1/src/vec/vec/interface/rvector.c > [0]PETSC ERROR: [0] VecMedian line 806 > /home/khp/bin/petsc-3.5.1/src/vec/vec/utils/projection.c > [0]PETSC ERROR: [0] TaoSolve_SSILS line 52 > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > [0]PETSC ERROR: [0] TaoSolve line 171 > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > > I debugged with valgrind and received the following message: > > ==19424== Invalid read of size 8 > ==19424== at 0x54089E4: VecRestoreArray_Nest (vecnest.c:746) > ==19424== by 0x53F5F6F: VecRestoreArray (rvector.c:1666) > ==19424== by 0x54BE874: VecMedian (projection.c:855) > ==19424== by 0x6247B74: TaoSolve_SSILS (ssils.c:59) > ==19424== by 0x620739E: TaoSolve (taosolver.c:188) > ==19424== by 0x40491C: main (main.cpp:265) > ==19424== Address 0x0 is not stack'd, malloc'd or (recently) free'd > > It looks like the bug relates to the nested vector. Could you please give me > a hint to locate the bug? Thanks. > > Khai From khaipham at utexas.edu Mon Aug 11 10:28:12 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Mon, 11 Aug 2014 10:28:12 -0500 Subject: [petsc-users] Error to TaoSolve() call In-Reply-To: References: <91b107a901ec4e4ea8ac49e346397c5e@LUCKMAN.anl.gov> Message-ID: Hi Jason, Thank you for your help. I corrected ,recompiled the code and the error has gone. Khai On Mon, Aug 11, 2014 at 10:17 AM, Jason Sarich wrote: > Hello Khai > > The likely culprit is in petsc/src/vec/vec/utils/projection.c, at the > end of the VecMedian() there are three calls to VecRestore(), the last > of which is wrong and needs to be corrected and recompiled: > > @@ -852,7 +852,7 @@ PetscErrorCode VecMedian(Vec Vec1, Vec Vec2, Vec > Vec3, Vec VMedian) > > ierr = VecRestoreArray(Vec1,&v1);CHKERRQ(ierr); > ierr = VecRestoreArray(Vec2,&v2);CHKERRQ(ierr); > - ierr = VecRestoreArray(Vec3,&v2);CHKERRQ(ierr); > + ierr = VecRestoreArray(Vec3,&v3);CHKERRQ(ierr); > > if (VMedian!=Vec1 && VMedian != Vec2 && VMedian != Vec3){ > ierr = VecRestoreArray(VMedian,&vmed);CHKERRQ(ierr); > > Jason Sarich > > > On Mon, Aug 11, 2014 at 9:23 AM, Khai Hong Pham > wrote: > > Hello, > > > > I call TaosSolve() in my code. The solution vector is a nested and > Jacobian > > matrix is nested too. It shows me the error: > > > > [0]PETSC ERROR: > > ------------------------------------------------------------------------ > > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > > probably memory access out of range > > [0]PETSC ERROR: Try option -start_in_debugger or > -on_error_attach_debugger > > [0]PETSC ERROR: or see > > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC > ERROR: > > or try http://valgrind.org on GNU/linux and Apple Mac OS X to find > memory > > corruption errors > > [1]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in stack > > below > > [0]PETSC ERROR: --------------------- Stack Frames > > ------------------------------------ > > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not > available, > > [0]PETSC ERROR: INSTEAD the line number of the start of the > function > > [0]PETSC ERROR: is given. > > [0]PETSC ERROR: [0] VecRestoreArray_Nest line 731 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/impls/nest/vecnest.c > > [0]PETSC ERROR: [0] VecRestoreArray line 1656 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/interface/rvector.c > > [0]PETSC ERROR: [0] VecMedian line 806 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/utils/projection.c > > [0]PETSC ERROR: [0] TaoSolve_SSILS line 52 > > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > > [0]PETSC ERROR: [0] TaoSolve line 171 > > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > > > > I debugged with valgrind and received the following message: > > > > ==19424== Invalid read of size 8 > > ==19424== at 0x54089E4: VecRestoreArray_Nest (vecnest.c:746) > > ==19424== by 0x53F5F6F: VecRestoreArray (rvector.c:1666) > > ==19424== by 0x54BE874: VecMedian (projection.c:855) > > ==19424== by 0x6247B74: TaoSolve_SSILS (ssils.c:59) > > ==19424== by 0x620739E: TaoSolve (taosolver.c:188) > > ==19424== by 0x40491C: main (main.cpp:265) > > ==19424== Address 0x0 is not stack'd, malloc'd or (recently) free'd > > > > It looks like the bug relates to the nested vector. Could you please > give me > > a hint to locate the bug? Thanks. > > > > Khai > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Mon Aug 11 11:44:41 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Mon, 11 Aug 2014 11:44:41 -0500 Subject: [petsc-users] Petsc compilation with -MDd using visual studio c++ 2008 In-Reply-To: References: Message-ID: Can you try the attached patch? patch -Np1 < win-f2cblas.patch Satish On Mon, 11 Aug 2014, Mengda Wu wrote: > Hi Satish, > > I think this problem happens in the latest 3.5.1 version. On windows 7 > with VS2012, I configured with (under Cygwin): > > ./config/configure.py --with-cc='cl' --with-fc=0 --with-cxx='cl' > --with-mpi=0 --with-debugging=1 > --download-f2cblaslapack=/cygdrive/d/Library/PETSc/download/f2cblaslapack-3.4.2.q1.tar.gz > --with-sowing=0 --with-c2html=0 -CFLAGS='-MDd -wd4996' -CXXFLAGS='-MDd > -wd4996' > > After configure, in > petsc-3.5.1\arch-mswin-c-debug\externalpackages\f2cblaslapack-3.4.2.q1 > CC = /cygdrive/d/Library/PETSc/petsc-3.5.1/bin/win32fe/win32fe cl > COPTFLAGS = -MDd -wd4996 -Z7 > CNOOPT = -MD > > So CNOOPT does not get correct "-MDd", which causes the VC dll mismatch > after compilation of Petsc debug. There was no problem with petsc-3.4.3. I > am trying to upgrade to 3.5.1 and the problem came out. Could you please > take a look? > > Thanks, > Mengda > > On Sun, Dec 18, 2011 at 2:14 PM, Satish Balay wrote: > > > On Sun, 18 Dec 2011, Mengda Wu wrote: > > > > > Hi all, > > > > > > I am trying to compile with a debug version of Petsc with -MDd options > > > using visual studio c++ 2008. The following options are used. > > > > > > ./config/configure.py --with-cc='cl' --with-fc=0 --with-cxx='cl' > > > --with-mpi=0 --with-debugging=1 > > > --download-f2cblaslapack=/path/to/f2cblaslapack-3.1.1.q.tar.gz > > > -CFLAGS='-MDd -wd4996' -CXXFLAGS='-MDd -wd4996' > > > > > > But it seems that f2cblaslapack does not recognize "-MDd" completely. > > Some > > > files are still compiled with '-MD' instead of "-MDd". This will lead to > > a > > > problem that not all libraries are linked with the same MS C library. I > > > think it may be caused by the variable "CNOOPT" is not set properly in > > > config/BuildSystem/config/packages/f2cblaslapack.py and > > > config/BuildSystem/config/packages/BlasLapack.py. Only '-MD' is present > > > there. See > > > > > > def getWindowsNonOptFlags(self,cflags): > > > for flag in ['-MT','-MTd','-MD','-threads']: > > > if cflags.find(flag) >=0: return flag > > > return '' > > > > > > If I substitute '-MD' with '-MDd', then it works. But this will lead to > > > problem when '-MD' is preferred. > > > > > > > You can just add 'MDd' to that list. > > > > i.e > > > > for flag in ['-MT','-MTd','-MD','-MDd','-threads']: > > > > Will add this for the next patch update to petsc-3.2 > > > > Satish > > > > > I am wondering if anyone can fix this problem. > > > > > > Thanks, > > > Mengda > > > > > > > > -------------- next part -------------- diff --git a/config/BuildSystem/config/package.py b/config/BuildSystem/config/package.py index 281450f..66ac42e 100644 --- a/config/BuildSystem/config/package.py +++ b/config/BuildSystem/config/package.py @@ -141,9 +141,11 @@ class Package(config.base.Configure): return '' def getWindowsNonOptFlags(self,cflags): - for flag in ['-MT','-MTd','-MD','-MDd','-threads']: - if cflags.find(flag) >=0: return flag - return '' + outflags = [] + for flag in cflags.split(): + if flag in ['-MT','-MTd','-MD','-MDd','-threads']: + outflags.append(flag) + return ' '.join(outflags) def getDefaultLanguage(self): '''The language in which to run tests''' From khaipham at utexas.edu Mon Aug 11 12:05:38 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Mon, 11 Aug 2014 12:05:38 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix Message-ID: Hello Petsc-Users, In the MatGetSubMatrix, if the matrix mat is a nested matrix, for example [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the isrow and iscol will be the index of the subblock matrix which is (1,0) or it must be the index of all rows, columns of the submat in the mat (like in MatGetSubMatrix). Please help me to clarify this. Thanks Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 11 12:34:39 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 11 Aug 2014 12:34:39 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: On Mon, Aug 11, 2014 at 12:05 PM, Khai Hong Pham wrote: > Hello Petsc-Users, > > In the MatGetSubMatrix, if the matrix mat is a nested matrix, for example > [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the isrow and > iscol will be the index of the subblock matrix which is (1,0) or it must be > the index of all rows, columns of the submat in the mat (like in > MatGetSubMatrix). Please help me to clarify this. > It is the later (the list of rows/cols) Thsnks, Matt > Thanks > > Khai > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From ckhuangf at gmail.com Mon Aug 11 14:50:50 2014 From: ckhuangf at gmail.com (Chung-Kan Huang) Date: Mon, 11 Aug 2014 14:50:50 -0500 Subject: [petsc-users] Non zero entries Message-ID: Hi, I have some confusion related to NONZERO in the matrix. In my application I created Matrix using following procedure. MatCreate(* comm_, & J_); PetscInt * d_nnz = NULL; PetscInt * o_nnz = NULL; PetscMalloc(local_size * sizeof(PetscInt), & d_nnz); PetscMalloc(local_size * sizeof(PetscInt), & o_nnz); for (int i = 0; i < local_size; i++) { d_nnz[i] = d_nnz_v[i]; o_nnz[i] = o_nnz_v[i]; } MatSetType(J_, MATAIJ); MatSetSizes(J_, local_size, local_size, PETSC_DECIDE, PETSC_DECIDE); if (comm_->Get_size() > 1) { // MPI MatMPIAIJSetPreallocation(J_, max_d_nz, d_nnz, max_o_nz, o_nnz); } else { // Seq MatSeqAIJSetPreallocation(J_, PETSC_DEFAULT, d_nnz); } PetscFree(d_nnz); PetscFree(o_nnz); The sructure of the matrix changes from time to time during the application (as the connectivity list is varying) however o_nnz d_nnz are made based on the densest possible scenario. In a recently test I noticed that matrix consturcion time become extremely long when the sturucture changes (form less dense to denser). I dug a little and found out it become very slow in MatSetValues(J_, NumRows, idxm, NumCols, idxn, data, ADD_VALUES); and it becomes normal again after the first chanaged matrix has been assembled. In my case I didn't do MatSetValues for the connection doesn't exisit in on time connectivity list although I count them in d_nnz and o_nnz but I started to suspect that PETSC was allocating memory for the new additional entries base on previous matrix structure. Any suggestions? *Cheers* -------------- next part -------------- An HTML attachment was scrubbed... URL: From agrayver at gfz-potsdam.de Mon Aug 11 14:53:16 2014 From: agrayver at gfz-potsdam.de (Alexander Grayver) Date: Mon, 11 Aug 2014 21:53:16 +0200 Subject: [petsc-users] KSPSolve crashes with petsc-3.5.1 Message-ID: An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 11 15:07:48 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 11 Aug 2014 15:07:48 -0500 Subject: [petsc-users] Non zero entries In-Reply-To: References: Message-ID: 1) you can call both MatMPIAIJSetPreallocation() and MatSeqAIJSetPreallocation() BOTH, the one that is not needed gets ignored so you don?t need that ugly if in your code. 2) unfortunately PETSc removes any excessive space that was not needed during the first MatAssemblyBegin/End() thus when you add the additional entries later it needs to reallocate all new space. The way to make it always fast is to make sure that the first set of calls to MatSetValues and MatAssemblyBegin/End include all possible nonzero locations (just put zeros in any place that is not immediately needed) then PETSc will keep that space around and the later calls will be fast. Barry On Aug 11, 2014, at 2:50 PM, Chung-Kan Huang wrote: > Hi, > > I have some confusion related to NONZERO in the matrix. > In my application I created Matrix using following procedure. > > MatCreate(* comm_, & J_); > PetscInt * d_nnz = NULL; > PetscInt * o_nnz = NULL; > PetscMalloc(local_size * sizeof(PetscInt), & d_nnz); > PetscMalloc(local_size * sizeof(PetscInt), & o_nnz); > for (int i = 0; i < local_size; i++) { > d_nnz[i] = d_nnz_v[i]; > o_nnz[i] = o_nnz_v[i]; > } > MatSetType(J_, MATAIJ); > MatSetSizes(J_, > local_size, > local_size, > PETSC_DECIDE, > PETSC_DECIDE); > > > if (comm_->Get_size() > 1) { > // MPI > MatMPIAIJSetPreallocation(J_, > max_d_nz, > d_nnz, > max_o_nz, > o_nnz); > } else { > // Seq > MatSeqAIJSetPreallocation(J_, > PETSC_DEFAULT, > d_nnz); > } > PetscFree(d_nnz); > PetscFree(o_nnz); > > The sructure of the matrix changes from time to time during the application (as the connectivity list is varying) however o_nnz d_nnz are made based on the densest possible scenario. > > In a recently test I noticed that matrix consturcion time become extremely long when the sturucture changes (form less dense to denser). I dug a little and found out it become very slow in > MatSetValues(J_, > NumRows, > idxm, > NumCols, > idxn, > data, > ADD_VALUES); > and it becomes normal again after the first chanaged matrix has been assembled. > > In my case I didn't do MatSetValues for the connection doesn't exisit in on time connectivity list although I count them in d_nnz and o_nnz but I started to suspect that PETSC was allocating memory for the new additional entries base on previous matrix structure. > > Any suggestions? > > Cheers > From knepley at gmail.com Mon Aug 11 15:15:28 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 11 Aug 2014 15:15:28 -0500 Subject: [petsc-users] KSPSolve crashes with petsc-3.5.1 In-Reply-To: References: Message-ID: On Mon, Aug 11, 2014 at 2:53 PM, Alexander Grayver wrote: > Dear PETSc devs, > > I am getting the following error with petsc-3.5.1: > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Null argument, when expecting valid pointer > [0]PETSC ERROR: Null Object: Parameter # 1 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 > [0]PETSC ERROR: /build/main on a openmpi-gcc-double-debug-c-shared named > e1334 by ag Mon Aug 11 18:42:07 2014 > [0]PETSC ERROR: Configure options > --with-petsc-arch=openmpi-gcc-double-debug-c-shared --with-x=0 > --download-mumps --download-metis --download-scalapack --download-blacs > --with-scalar-type=real --download-blas-lapack --with-precision=double > --download-parmetis --with-shared-libraries=1 --with-debugging=1 > --with-hypre-dir=/lib/hypre-2.9.1a --download-fblaslapack=1 > [0]PETSC ERROR: #1 PetscObjectStateGet() line 38 in > /lib/petsc-3.5.1/src/sys/objects/state.c > [0]PETSC ERROR: #2 PCSetUp() line 875 in > /lib/petsc-3.5.1/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #3 KSPSetUp() line 305 in > /lib/petsc-3.5.1/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: #4 KSPSolve() line 417 in > /lib/petsc-3.5.1/src/ksp/ksp/interface/itfunc.c > > I have used LSQR here which was setup in the following way: > > KSPCreate(communicator, &ksp); > KSPSetType(ksp, KSPLSQR); > KSPSetTolerances(ksp, tol, PETSC_DEFAULT, PETSC_DEFAULT, max_iterations); > KSPSetFromOptions(ksp); > KSPGetPC(ksp, &pc); > PCSetType(pc, PCNONE); > KSPSetOperators(ksp, A, PETSC_NULL); > You want 'A' instead of 'PETSC_NULL' above. We just had no check before. Thanks, Matt > KSPSolve(ksp, b, x); > > The code works fine with petsc-3.4.4 (provided that I pass > DIFFERENT_NONZERO_PATTERN to the KSPSetFromOptions). Any idea? > > Regards, > Alexander > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From khaipham at utexas.edu Mon Aug 11 15:53:36 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Mon, 11 Aug 2014 15:53:36 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: Matt, I've the following error as I tried to get the sub block matrix. I check the isrow and iscol that are passed to MatGetSubMatrix and they look ok to me. The line 110 of ISStrideGetInfo() calls to PetscValidHeaderSpecific. [0]PETSC ERROR: Null argument, when expecting valid pointer [0]PETSC ERROR: Null Object: Parameter # 1 [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 [0]PETSC ERROR: [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug named khp by khp Mon Aug 11 15:26:47 2014 Null argument, when expecting valid pointer [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 --download-metis --download-parmetis [1]PETSC ERROR: Null Object: Parameter # 1 [1]PETSC ERROR: [0]PETSC ERROR: #1 ISStrideGetInfo() line 110 in /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [1]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug named khp by khp Mon Aug 11 15:26:47 2014 [1]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 --download-metis --download-parmetis [1]PETSC ERROR: #1 ISStrideGetInfo() line 110 in /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c [0]PETSC ERROR: #2 MatNestFindSubMat() line 357 in /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c [0]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c [0]PETSC ERROR: #4 MatGetLocalSubMatrix() line 9224 in /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c [1]PETSC ERROR: #2 MatNestFindSubMat() line 357 in /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c [0]PETSC ERROR: #5 jacobian_comp() line 49 in src/assembly.cpp [1]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c [0]PETSC ERROR: [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c #4 MatGetLocalSubMatrix() line 9224 in /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c [0]PETSC ERROR: [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c #5 jacobian_comp() line 49 in src/assembly.cpp [0]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c [0]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c [0]PETSC ERROR: #10 TaoSolve() line 188 in /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c [1]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c [0]PETSC ERROR: #11 main() line 286 in src/main.cpp [1]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- [1]PETSC ERROR: #10 TaoSolve() line 188 in /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c [1]PETSC ERROR: #11 main() line 286 in src/main.cpp [1]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- On Mon, Aug 11, 2014 at 12:34 PM, Matthew Knepley wrote: > On Mon, Aug 11, 2014 at 12:05 PM, Khai Hong Pham > wrote: > >> Hello Petsc-Users, >> >> In the MatGetSubMatrix, if the matrix mat is a nested matrix, for example >> [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the isrow and >> iscol will be the index of the subblock matrix which is (1,0) or it must be >> the index of all rows, columns of the submat in the mat (like in >> MatGetSubMatrix). Please help me to clarify this. >> > > It is the later (the list of rows/cols) > > Thsnks, > > Matt > > >> Thanks >> >> Khai >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 11 16:16:38 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 11 Aug 2014 16:16:38 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: On Mon, Aug 11, 2014 at 3:53 PM, Khai Hong Pham wrote: > Matt, > > I've the following error as I tried to get the sub block matrix. I check > the isrow and iscol that are passed to MatGetSubMatrix and they look ok > to me. The line 110 of ISStrideGetInfo() calls > to PetscValidHeaderSpecific. > You have something corrupt in the MatNest. Quit using MatNest. This is just an optimization that should only be turned on by -mat_type nest. It is not a top level interface. This causes so many problems that we should remove it from the documentation. Thanks, Matt > > [0]PETSC ERROR: Null argument, when expecting valid pointer > [0]PETSC ERROR: Null Object: Parameter # 1 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 > [0]PETSC ERROR: [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug > named khp by khp Mon Aug 11 15:26:47 2014 > Null argument, when expecting valid pointer > [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ > --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 > --download-metis --download-parmetis > [1]PETSC ERROR: Null Object: Parameter # 1 > [1]PETSC ERROR: [0]PETSC ERROR: #1 ISStrideGetInfo() line 110 in > /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c > See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble > shooting. > [1]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 > [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug named khp by khp > Mon Aug 11 15:26:47 2014 > [1]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ > --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 > --download-metis --download-parmetis > [1]PETSC ERROR: #1 ISStrideGetInfo() line 110 in > /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c > [0]PETSC ERROR: #2 MatNestFindSubMat() line 357 in > /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c > [0]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in > /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c > [0]PETSC ERROR: #4 MatGetLocalSubMatrix() line 9224 in > /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c > [1]PETSC ERROR: #2 MatNestFindSubMat() line 357 in > /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c > [0]PETSC ERROR: #5 jacobian_comp() line 49 in src/assembly.cpp > [1]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in > /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c > [0]PETSC ERROR: [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c > #4 MatGetLocalSubMatrix() line 9224 in > /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c > [0]PETSC ERROR: [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c > #5 jacobian_comp() line 49 in src/assembly.cpp > [0]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in > /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c > [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c > [0]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c > [0]PETSC ERROR: #10 TaoSolve() line 188 in > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > [1]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in > /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c > [0]PETSC ERROR: #11 main() line 286 in src/main.cpp > [1]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > [0]PETSC ERROR: ----------------End of Error Message -------send entire > error message to petsc-maint at mcs.anl.gov---------- > [1]PETSC ERROR: #10 TaoSolve() line 188 in > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > [1]PETSC ERROR: #11 main() line 286 in src/main.cpp > [1]PETSC ERROR: ----------------End of Error Message -------send entire > error message to petsc-maint at mcs.anl.gov---------- > > > > On Mon, Aug 11, 2014 at 12:34 PM, Matthew Knepley > wrote: > >> On Mon, Aug 11, 2014 at 12:05 PM, Khai Hong Pham >> wrote: >> >>> Hello Petsc-Users, >>> >>> In the MatGetSubMatrix, if the matrix mat is a nested matrix, for >>> example [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the >>> isrow and iscol will be the index of the subblock matrix which is (1,0) or >>> it must be the index of all rows, columns of the submat in the mat (like in >>> MatGetSubMatrix). Please help me to clarify this. >>> >> >> It is the later (the list of rows/cols) >> >> Thsnks, >> >> Matt >> >> >>> Thanks >>> >>> Khai >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From khaipham at utexas.edu Mon Aug 11 16:22:20 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Mon, 11 Aug 2014 16:22:20 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: Thank you for your information, Matt. I'm using both nested matrix and nested vector. Is the nested vector good to use ? Khai. On Mon, Aug 11, 2014 at 4:16 PM, Matthew Knepley wrote: > On Mon, Aug 11, 2014 at 3:53 PM, Khai Hong Pham > wrote: > >> Matt, >> >> I've the following error as I tried to get the sub block matrix. I check >> the isrow and iscol that are passed to MatGetSubMatrix and they look ok >> to me. The line 110 of ISStrideGetInfo() calls >> to PetscValidHeaderSpecific. >> > > You have something corrupt in the MatNest. Quit using MatNest. This is > just an optimization that should > only be turned on by -mat_type nest. It is not a top level interface. This > causes so many problems that we > should remove it from the documentation. > > Thanks, > > Matt > > >> >> [0]PETSC ERROR: Null argument, when expecting valid pointer >> [0]PETSC ERROR: Null Object: Parameter # 1 >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [0]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 >> [0]PETSC ERROR: [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug >> named khp by khp Mon Aug 11 15:26:47 2014 >> Null argument, when expecting valid pointer >> [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ >> --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 >> --download-metis --download-parmetis >> [1]PETSC ERROR: Null Object: Parameter # 1 >> [1]PETSC ERROR: [0]PETSC ERROR: #1 ISStrideGetInfo() line 110 in >> /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c >> See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >> shooting. >> [1]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 >> [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug named khp by khp >> Mon Aug 11 15:26:47 2014 >> [1]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ >> --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 >> --download-metis --download-parmetis >> [1]PETSC ERROR: #1 ISStrideGetInfo() line 110 in >> /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c >> [0]PETSC ERROR: #2 MatNestFindSubMat() line 357 in >> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >> [0]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in >> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >> [0]PETSC ERROR: #4 MatGetLocalSubMatrix() line 9224 in >> /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c >> [1]PETSC ERROR: #2 MatNestFindSubMat() line 357 in >> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >> [0]PETSC ERROR: #5 jacobian_comp() line 49 in src/assembly.cpp >> [1]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in >> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >> [0]PETSC ERROR: [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in >> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c >> #4 MatGetLocalSubMatrix() line 9224 in >> /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c >> [0]PETSC ERROR: [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in >> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c >> #5 jacobian_comp() line 49 in src/assembly.cpp >> [0]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in >> /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c >> [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in >> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c >> [0]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in >> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c >> [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in >> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c >> [0]PETSC ERROR: #10 TaoSolve() line 188 in >> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c >> [1]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 in >> /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c >> [0]PETSC ERROR: #11 main() line 286 in src/main.cpp >> [1]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in >> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c >> [0]PETSC ERROR: ----------------End of Error Message -------send entire >> error message to petsc-maint at mcs.anl.gov---------- >> [1]PETSC ERROR: #10 TaoSolve() line 188 in >> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c >> [1]PETSC ERROR: #11 main() line 286 in src/main.cpp >> [1]PETSC ERROR: ----------------End of Error Message -------send entire >> error message to petsc-maint at mcs.anl.gov---------- >> >> >> >> On Mon, Aug 11, 2014 at 12:34 PM, Matthew Knepley >> wrote: >> >>> On Mon, Aug 11, 2014 at 12:05 PM, Khai Hong Pham >>> wrote: >>> >>>> Hello Petsc-Users, >>>> >>>> In the MatGetSubMatrix, if the matrix mat is a nested matrix, for >>>> example [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the >>>> isrow and iscol will be the index of the subblock matrix which is (1,0) or >>>> it must be the index of all rows, columns of the submat in the mat (like in >>>> MatGetSubMatrix). Please help me to clarify this. >>>> >>> >>> It is the later (the list of rows/cols) >>> >>> Thsnks, >>> >>> Matt >>> >>> >>>> Thanks >>>> >>>> Khai >>>> >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 11 16:23:47 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 11 Aug 2014 16:23:47 -0500 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: On Mon, Aug 11, 2014 at 4:22 PM, Khai Hong Pham wrote: > Thank you for your information, Matt. I'm using both nested matrix and > nested vector. Is the nested vector good to use ? > Again, these are implementation classes. Always test with the simple version, and then switch dynamically to these when you want better performance. The whole point of PETSc is that you can do this, rather than hardcoding a particular type. Thanks, Matt > Khai. > > > On Mon, Aug 11, 2014 at 4:16 PM, Matthew Knepley > wrote: > >> On Mon, Aug 11, 2014 at 3:53 PM, Khai Hong Pham >> wrote: >> >>> Matt, >>> >>> I've the following error as I tried to get the sub block matrix. I check >>> the isrow and iscol that are passed to MatGetSubMatrix and they look ok >>> to me. The line 110 of ISStrideGetInfo() calls >>> to PetscValidHeaderSpecific. >>> >> >> You have something corrupt in the MatNest. Quit using MatNest. This is >> just an optimization that should >> only be turned on by -mat_type nest. It is not a top level interface. >> This causes so many problems that we >> should remove it from the documentation. >> >> Thanks, >> >> Matt >> >> >>> >>> [0]PETSC ERROR: Null argument, when expecting valid pointer >>> [0]PETSC ERROR: Null Object: Parameter # 1 >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [0]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 >>> [0]PETSC ERROR: [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug >>> named khp by khp Mon Aug 11 15:26:47 2014 >>> Null argument, when expecting valid pointer >>> [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ >>> --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 >>> --download-metis --download-parmetis >>> [1]PETSC ERROR: Null Object: Parameter # 1 >>> [1]PETSC ERROR: [0]PETSC ERROR: #1 ISStrideGetInfo() line 110 in >>> /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c >>> See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> [1]PETSC ERROR: Petsc Release Version 3.5.1, Jul, 24, 2014 >>> [1]PETSC ERROR: ./PFFEM2DSolver on a arch-linux2-c-debug named khp by >>> khp Mon Aug 11 15:26:47 2014 >>> [1]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ >>> --with-fc=gfortran --download-fblaslapack --download-mpich --download-hdf5 >>> --download-metis --download-parmetis >>> [1]PETSC ERROR: #1 ISStrideGetInfo() line 110 in >>> /home/khp/bin/petsc-3.5.1/src/vec/is/is/impls/stride/stride.c >>> [0]PETSC ERROR: #2 MatNestFindSubMat() line 357 in >>> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >>> [0]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in >>> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >>> [0]PETSC ERROR: #4 MatGetLocalSubMatrix() line 9224 in >>> /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c >>> [1]PETSC ERROR: #2 MatNestFindSubMat() line 357 in >>> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >>> [0]PETSC ERROR: #5 jacobian_comp() line 49 in src/assembly.cpp >>> [1]PETSC ERROR: #3 MatGetLocalSubMatrix_Nest() line 411 in >>> /home/khp/bin/petsc-3.5.1/src/mat/impls/nest/matnest.c >>> [0]PETSC ERROR: [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in >>> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c >>> #4 MatGetLocalSubMatrix() line 9224 in >>> /home/khp/bin/petsc-3.5.1/src/mat/interface/matrix.c >>> [0]PETSC ERROR: [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 >>> in /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c >>> #5 jacobian_comp() line 49 in src/assembly.cpp >>> [0]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 >>> in /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c >>> [1]PETSC ERROR: #6 TaoComputeJacobian() line 153 in >>> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver_hj.c >>> [0]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in >>> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c >>> [1]PETSC ERROR: #7 Tao_SSLS_FunctionGradient() line 63 in >>> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssls.c >>> [0]PETSC ERROR: #10 TaoSolve() line 188 in >>> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c >>> [1]PETSC ERROR: #8 TaoLineSearchComputeObjectiveAndGradient() line 941 >>> in /home/khp/bin/petsc-3.5.1/src/tao/linesearch/interface/taolinesearch.c >>> [0]PETSC ERROR: #11 main() line 286 in src/main.cpp >>> [1]PETSC ERROR: #9 TaoSolve_SSILS() line 65 in >>> /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c >>> [0]PETSC ERROR: ----------------End of Error Message -------send entire >>> error message to petsc-maint at mcs.anl.gov---------- >>> [1]PETSC ERROR: #10 TaoSolve() line 188 in >>> /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c >>> [1]PETSC ERROR: #11 main() line 286 in src/main.cpp >>> [1]PETSC ERROR: ----------------End of Error Message -------send entire >>> error message to petsc-maint at mcs.anl.gov---------- >>> >>> >>> >>> On Mon, Aug 11, 2014 at 12:34 PM, Matthew Knepley >>> wrote: >>> >>>> On Mon, Aug 11, 2014 at 12:05 PM, Khai Hong Pham >>>> wrote: >>>> >>>>> Hello Petsc-Users, >>>>> >>>>> In the MatGetSubMatrix, if the matrix mat is a nested matrix, for >>>>> example [ A00 A01 | A10 A11], and I'd like to get submat A10. Then the >>>>> isrow and iscol will be the index of the subblock matrix which is (1,0) or >>>>> it must be the index of all rows, columns of the submat in the mat (like in >>>>> MatGetSubMatrix). Please help me to clarify this. >>>>> >>>> >>>> It is the later (the list of rows/cols) >>>> >>>> Thsnks, >>>> >>>> Matt >>>> >>>> >>>>> Thanks >>>>> >>>>> Khai >>>>> >>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their >>>> experiments is infinitely more interesting than any results to which their >>>> experiments lead. >>>> -- Norbert Wiener >>>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jychang48 at gmail.com Mon Aug 11 17:31:00 2014 From: jychang48 at gmail.com (Justin Chang) Date: Mon, 11 Aug 2014 17:31:00 -0500 Subject: [petsc-users] Error configuring with Parmetis and HDF5 on iMac Message-ID: Hi all, I am trying to install petsc-3.5.1 onto my school's iMac (version 10.9.2) and I have run configure with the following options: ./configure --with-cc=gcc --with-cxx=g++ --with-f2c=gfortran --download-f2cblaslapack --download-mpich --with-debugging=1 --download-ctetgen --download-triangle --with-valgrind=1 -with-cmake=cmake --download-metis --download-parmetis --download-netcdf --download-hdf5 --download-exodusii Then when I run 'make all test' I get the following errors: Undefined symbols for architecture x86_64: "_MatPartitioningCreate_Parmetis", referenced from: import-atom in libpetsc.dylib "_PETSC_VIEWER_HDF5_", referenced from: import-atom in libpetsc.dylib "_PetscViewerCreate_HDF5", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5GetFileId", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5GetGroup", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5GetTimestep", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5HasAttribute", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5PopGroup", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5PushGroup", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5ReadAttribute", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5SetTimestep", referenced from: import-atom in libpetsc.dylib "_PetscViewerHDF5WriteAttribute", referenced from: import-atom in libpetsc.dylib ld: symbol(s) not found for architecture x86_64 clang: error: linker command failed with exit code 1 (use -v to see invocation) make[3]: [ex19] Error 1 (ignored) /bin/rm -f ex19.o Any help appreciated, thanks Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 11 17:36:07 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 11 Aug 2014 17:36:07 -0500 Subject: [petsc-users] Error configuring with Parmetis and HDF5 on iMac In-Reply-To: References: Message-ID: Send configure.log and make.log Delete the entire PETSc directory and trying again without the --download-f2cblaslapack but with ?with-fc=gfortran (not f2c) I suspect you made multiple attempts to install and some undesirable files got in place that are causing the difficultly. If the clean install does not work then Send configure.log and make.log Barry On Aug 11, 2014, at 5:31 PM, Justin Chang wrote: > Hi all, > > I am trying to install petsc-3.5.1 onto my school's iMac (version 10.9.2) and I have run configure with the following options: > > ./configure --with-cc=gcc --with-cxx=g++ --with-f2c=gfortran --download-f2cblaslapack--download-mpich --with-debugging=1 --download-ctetgen --download-triangle --with-valgrind=1 -with-cmake=cmake --download-metis --download-parmetis --download-netcdf --download-hdf5 --download-exodusii > > Then when I run 'make all test' I get the following errors: > > Undefined symbols for architecture x86_64: > "_MatPartitioningCreate_Parmetis", referenced from: > import-atom in libpetsc.dylib > "_PETSC_VIEWER_HDF5_", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerCreate_HDF5", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5GetFileId", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5GetGroup", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5GetTimestep", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5HasAttribute", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5PopGroup", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5PushGroup", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5ReadAttribute", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5SetTimestep", referenced from: > import-atom in libpetsc.dylib > "_PetscViewerHDF5WriteAttribute", referenced from: > import-atom in libpetsc.dylib > ld: symbol(s) not found for architecture x86_64 > clang: error: linker command failed with exit code 1 (use -v to see invocation) > make[3]: [ex19] Error 1 (ignored) > /bin/rm -f ex19.o > > Any help appreciated, thanks > > Justin From jychang48 at gmail.com Mon Aug 11 17:40:59 2014 From: jychang48 at gmail.com (Justin Chang) Date: Mon, 11 Aug 2014 17:40:59 -0500 Subject: [petsc-users] Error configuring with Parmetis and HDF5 on iMac In-Reply-To: References: Message-ID: Attached are the configure.log and make.log files Thanks, Justin On Mon, Aug 11, 2014 at 5:36 PM, Barry Smith wrote: > > Send configure.log and make.log > > Delete the entire PETSc directory and trying again without the > --download-f2cblaslapack but with ?with-fc=gfortran (not f2c) I suspect > you made multiple attempts to install and some undesirable files got in > place that are causing the difficultly. > > If the clean install does not work then Send configure.log and make.log > > Barry > > On Aug 11, 2014, at 5:31 PM, Justin Chang wrote: > > > Hi all, > > > > I am trying to install petsc-3.5.1 onto my school's iMac (version > 10.9.2) and I have run configure with the following options: > > > > ./configure --with-cc=gcc --with-cxx=g++ --with-f2c=gfortran > --download-f2cblaslapack--download-mpich --with-debugging=1 > --download-ctetgen --download-triangle --with-valgrind=1 -with-cmake=cmake > --download-metis --download-parmetis --download-netcdf --download-hdf5 > --download-exodusii > > > > Then when I run 'make all test' I get the following errors: > > > > Undefined symbols for architecture x86_64: > > "_MatPartitioningCreate_Parmetis", referenced from: > > import-atom in libpetsc.dylib > > "_PETSC_VIEWER_HDF5_", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerCreate_HDF5", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5GetFileId", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5GetGroup", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5GetTimestep", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5HasAttribute", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5PopGroup", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5PushGroup", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5ReadAttribute", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5SetTimestep", referenced from: > > import-atom in libpetsc.dylib > > "_PetscViewerHDF5WriteAttribute", referenced from: > > import-atom in libpetsc.dylib > > ld: symbol(s) not found for architecture x86_64 > > clang: error: linker command failed with exit code 1 (use -v to see > invocation) > > make[3]: [ex19] Error 1 (ignored) > > /bin/rm -f ex19.o > > > > Any help appreciated, thanks > > > > Justin > > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: application/octet-stream Size: 3000500 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: application/octet-stream Size: 58294 bytes Desc: not available URL: From balay at mcs.anl.gov Mon Aug 11 17:56:53 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Mon, 11 Aug 2014 17:56:53 -0500 Subject: [petsc-users] Error configuring with Parmetis and HDF5 on iMac In-Reply-To: References: Message-ID: Hm - a bunch of sourcefiles are not getting compiled. I'm not sure why. can you try the following - and see if the problem goes away? make allclean all If not - try: make allclean all-cmake Satish On Mon, 11 Aug 2014, Justin Chang wrote: > Attached are the configure.log and make.log files > > Thanks, > Justin > > > On Mon, Aug 11, 2014 at 5:36 PM, Barry Smith wrote: > > > > > Send configure.log and make.log > > > > Delete the entire PETSc directory and trying again without the > > --download-f2cblaslapack but with ?with-fc=gfortran (not f2c) I suspect > > you made multiple attempts to install and some undesirable files got in > > place that are causing the difficultly. > > > > If the clean install does not work then Send configure.log and make.log > > > > Barry > > > > On Aug 11, 2014, at 5:31 PM, Justin Chang wrote: > > > > > Hi all, > > > > > > I am trying to install petsc-3.5.1 onto my school's iMac (version > > 10.9.2) and I have run configure with the following options: > > > > > > ./configure --with-cc=gcc --with-cxx=g++ --with-f2c=gfortran > > --download-f2cblaslapack--download-mpich --with-debugging=1 > > --download-ctetgen --download-triangle --with-valgrind=1 -with-cmake=cmake > > --download-metis --download-parmetis --download-netcdf --download-hdf5 > > --download-exodusii > > > > > > Then when I run 'make all test' I get the following errors: > > > > > > Undefined symbols for architecture x86_64: > > > "_MatPartitioningCreate_Parmetis", referenced from: > > > import-atom in libpetsc.dylib > > > "_PETSC_VIEWER_HDF5_", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerCreate_HDF5", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5GetFileId", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5GetGroup", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5GetTimestep", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5HasAttribute", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5PopGroup", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5PushGroup", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5ReadAttribute", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5SetTimestep", referenced from: > > > import-atom in libpetsc.dylib > > > "_PetscViewerHDF5WriteAttribute", referenced from: > > > import-atom in libpetsc.dylib > > > ld: symbol(s) not found for architecture x86_64 > > > clang: error: linker command failed with exit code 1 (use -v to see > > invocation) > > > make[3]: [ex19] Error 1 (ignored) > > > /bin/rm -f ex19.o > > > > > > Any help appreciated, thanks > > > > > > Justin > > > > > From jychang48 at gmail.com Mon Aug 11 18:16:40 2014 From: jychang48 at gmail.com (Justin Chang) Date: Mon, 11 Aug 2014 18:16:40 -0500 Subject: [petsc-users] Error configuring with Parmetis and HDF5 on iMac In-Reply-To: References: Message-ID: I did what Barry suggested: deleting the directory and all. And it works fine now. Thanks all On Mon, Aug 11, 2014 at 5:56 PM, Satish Balay wrote: > Hm - a bunch of sourcefiles are not getting compiled. I'm not sure why. > > can you try the following - and see if the problem goes away? > > make allclean all > > If not - try: > > make allclean all-cmake > > Satish > > On Mon, 11 Aug 2014, Justin Chang wrote: > > > Attached are the configure.log and make.log files > > > > Thanks, > > Justin > > > > > > On Mon, Aug 11, 2014 at 5:36 PM, Barry Smith wrote: > > > > > > > > Send configure.log and make.log > > > > > > Delete the entire PETSc directory and trying again without the > > > --download-f2cblaslapack but with ?with-fc=gfortran (not f2c) I > suspect > > > you made multiple attempts to install and some undesirable files got in > > > place that are causing the difficultly. > > > > > > If the clean install does not work then Send configure.log and > make.log > > > > > > Barry > > > > > > On Aug 11, 2014, at 5:31 PM, Justin Chang wrote: > > > > > > > Hi all, > > > > > > > > I am trying to install petsc-3.5.1 onto my school's iMac (version > > > 10.9.2) and I have run configure with the following options: > > > > > > > > ./configure --with-cc=gcc --with-cxx=g++ --with-f2c=gfortran > > > --download-f2cblaslapack--download-mpich --with-debugging=1 > > > --download-ctetgen --download-triangle --with-valgrind=1 > -with-cmake=cmake > > > --download-metis --download-parmetis --download-netcdf --download-hdf5 > > > --download-exodusii > > > > > > > > Then when I run 'make all test' I get the following errors: > > > > > > > > Undefined symbols for architecture x86_64: > > > > "_MatPartitioningCreate_Parmetis", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PETSC_VIEWER_HDF5_", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerCreate_HDF5", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5GetFileId", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5GetGroup", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5GetTimestep", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5HasAttribute", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5PopGroup", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5PushGroup", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5ReadAttribute", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5SetTimestep", referenced from: > > > > import-atom in libpetsc.dylib > > > > "_PetscViewerHDF5WriteAttribute", referenced from: > > > > import-atom in libpetsc.dylib > > > > ld: symbol(s) not found for architecture x86_64 > > > > clang: error: linker command failed with exit code 1 (use -v to see > > > invocation) > > > > make[3]: [ex19] Error 1 (ignored) > > > > /bin/rm -f ex19.o > > > > > > > > Any help appreciated, thanks > > > > > > > > Justin > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From hku at discardmail.de Mon Aug 11 19:47:09 2014 From: hku at discardmail.de (organization-un) Date: Tue, 12 Aug 2014 02:47:09 +0200 Subject: [petsc-users] Open the letter and respond with the payment code Message-ID: <20140812004728.32BF852C0AA@mailhub.siol.net> A non-text attachment was scrubbed... Name: UN Letter of Compensation.rtf Type: application/octet-stream Size: 3303 bytes Desc: not available URL: From pecha.mari at gmail.com Tue Aug 12 08:53:33 2014 From: pecha.mari at gmail.com (Mari Pecha) Date: Tue, 12 Aug 2014 15:53:33 +0200 Subject: [petsc-users] Data Distribution from zero-rank process Message-ID: <53EA1C5D.1000309@gmail.com> Good morning, I'm Mari and I'm beginner PETSc user and I'd like to ask about tough problem, especially for me. I solve problem of data-set distribution, which are saved only on zero-rank process, to DMDA global vector. It means that every process stores a appropriate subset of data-set. I used DMDAGlobalToNaturalAllCreate and DMDANaturalAllToGlobalCreate function, and then VecScatterBegin and VecScatterEnd functions ... see please code below ... ierr = DMDAGlobalToNaturalAllCreate( da, &tolocalall ); CHKERRQ(ierr); ierr = DMDANaturalAllToGlobalCreate( da, &fromlocalall ); CHKERRQ(ierr); if( rank == 0 ) { ierr = VecCreateSeq( PETSC_COMM_SELF, SIZE, &localall ); ierr = VecScatterBegin( tolocalall, x, localall, ADD_VALUES, SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); ierr = VecScatterEnd( tolocalall, x, localall, ADD_VALUES, SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); ierr = VecGetArray( x, &vlocal ); CHKERRQ(ierr); PetscInt s; VecGetSize( localall, &s ); ierr = VecView( localall, PETSC_VIEWER_STDOUT_SELF ); CHKERRQ( ierr ); //create data on zero rank process for ( int i = 0; i < s; i++) *vlocal++ = i; ierr = VecRestoreArray( localall, &vlocal ); CHKERRQ(ierr); ierr = VecScatterBegin(fromlocalall, localall, x, ADD_VALUES, SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); ierr = VecScatterEnd( fromlocalall, localall, x, ADD_VALUES, SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); } .... But the piece of code gets and distributes only vector-values belong to zero-rank process. So, I haven't any idea how can I solve my problem only with PETSc functions. I'd like to get all values from global vector to zero-rank process and put back all data-set only from zero-rank to global vector. Can you help me, please? Thanks for your response Mari From knepley at gmail.com Tue Aug 12 09:12:06 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 12 Aug 2014 09:12:06 -0500 Subject: [petsc-users] Data Distribution from zero-rank process In-Reply-To: <53EA1C5D.1000309@gmail.com> References: <53EA1C5D.1000309@gmail.com> Message-ID: On Tue, Aug 12, 2014 at 8:53 AM, Mari Pecha wrote: > Good morning, > > I'm Mari and I'm beginner PETSc user and I'd like to ask about tough > problem, especially for me. > I solve problem of data-set distribution, which are saved only on > zero-rank process, to DMDA global vector. It means that every process > stores a appropriate subset of data-set. I used > DMDAGlobalToNaturalAllCreate and DMDANaturalAllToGlobalCreate function, and > then VecScatterBegin and VecScatterEnd functions ... see please code below > I have no idea what you really want to do. How about describing your problem with 2 procs and 3 values per proc. > ... > > ierr = DMDAGlobalToNaturalAllCreate( da, &tolocalall ); > CHKERRQ(ierr); > ierr = DMDANaturalAllToGlobalCreate( da, &fromlocalall ); > CHKERRQ(ierr); > > if( rank == 0 ) > { > > ierr = VecCreateSeq( PETSC_COMM_SELF, SIZE, &localall ); > > ierr = VecScatterBegin( tolocalall, x, localall, ADD_VALUES, > SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); > ierr = VecScatterEnd( tolocalall, x, localall, ADD_VALUES, > SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); > This will not work since you have a collective call (VecScatterBegin) inside if(!rank) Matt > ierr = VecGetArray( x, &vlocal ); CHKERRQ(ierr); > > PetscInt s; > VecGetSize( localall, &s ); > > ierr = VecView( localall, PETSC_VIEWER_STDOUT_SELF ); CHKERRQ( > ierr ); > > //create data on zero rank process > for ( int i = 0; i < s; i++) *vlocal++ = i; > > ierr = VecRestoreArray( localall, &vlocal ); CHKERRQ(ierr); > > ierr = VecScatterBegin(fromlocalall, localall, x, ADD_VALUES, > SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); > ierr = VecScatterEnd( fromlocalall, localall, x, ADD_VALUES, > SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); > } > > .... > > But the piece of code gets and distributes only vector-values belong to > zero-rank process. So, I haven't any idea how can I solve my problem only > with PETSc functions. I'd like to get all values from global vector to > zero-rank process and put back all data-set only from zero-rank to global > vector. Can you help me, please? > > Thanks for your response > Mari > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 12 10:53:40 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 12 Aug 2014 10:53:40 -0500 Subject: [petsc-users] Data Distribution from zero-rank process In-Reply-To: <53EA2334.1060209@gmail.com> References: <53EA1C5D.1000309@gmail.com> <53EA2334.1060209@gmail.com> Message-ID: On Tue, Aug 12, 2014 at 9:22 AM, Mari Pecha wrote: > Okay. I understand my explanation it sees to be chaotic. I try to > describe my problem on simple simple. > > Process with rank zero loads grayscale image from OpenCV library then I'd > like to distribute values of pixels to grid (DMDA). And I can't find any > solution for this problem. > The right thing to do is to create a custom scatter for this case. However, you can do this in two parts. First, read it in on proc 0, and then scatter to all procs using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/VecScatterCreateToZero.html where you SCATTER_BACKWARD. Then use http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/DM/DMDANaturalToGlobalBegin.html to permute from the natural ordering that you read in to the PETSc ordering. You could do this in one step if you allow each process to read its piece of the vector independently. Thanks, Matt > > Thank you > Mari > > On 12.8.2014 16:12, Matthew Knepley wrote: > > On Tue, Aug 12, 2014 at 8:53 AM, Mari Pecha wrote: > >> Good morning, >> >> I'm Mari and I'm beginner PETSc user and I'd like to ask about tough >> problem, especially for me. >> I solve problem of data-set distribution, which are saved only on >> zero-rank process, to DMDA global vector. It means that every process >> stores a appropriate subset of data-set. I used >> DMDAGlobalToNaturalAllCreate and DMDANaturalAllToGlobalCreate function, and >> then VecScatterBegin and VecScatterEnd functions ... see please code below >> > > I have no idea what you really want to do. How about describing your > problem with > 2 procs and 3 values per proc. > > >> ... >> >> ierr = DMDAGlobalToNaturalAllCreate( da, &tolocalall ); >> CHKERRQ(ierr); >> ierr = DMDANaturalAllToGlobalCreate( da, &fromlocalall ); >> CHKERRQ(ierr); >> >> if( rank == 0 ) >> { >> >> ierr = VecCreateSeq( PETSC_COMM_SELF, SIZE, &localall ); >> >> ierr = VecScatterBegin( tolocalall, x, localall, ADD_VALUES, >> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >> ierr = VecScatterEnd( tolocalall, x, localall, ADD_VALUES, >> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >> > > This will not work since you have a collective call (VecScatterBegin) > inside if(!rank) > > Matt > > >> ierr = VecGetArray( x, &vlocal ); CHKERRQ(ierr); >> >> PetscInt s; >> VecGetSize( localall, &s ); >> >> ierr = VecView( localall, PETSC_VIEWER_STDOUT_SELF ); CHKERRQ( >> ierr ); >> >> //create data on zero rank process >> for ( int i = 0; i < s; i++) *vlocal++ = i; >> >> ierr = VecRestoreArray( localall, &vlocal ); CHKERRQ(ierr); >> >> ierr = VecScatterBegin(fromlocalall, localall, x, ADD_VALUES, >> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >> ierr = VecScatterEnd( fromlocalall, localall, x, ADD_VALUES, >> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >> } >> >> .... >> >> But the piece of code gets and distributes only vector-values belong to >> zero-rank process. So, I haven't any idea how can I solve my problem only >> with PETSc functions. I'd like to get all values from global vector to >> zero-rank process and put back all data-set only from zero-rank to global >> vector. Can you help me, please? >> >> Thanks for your response >> Mari >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 12 11:40:09 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 12 Aug 2014 11:40:09 -0500 Subject: [petsc-users] Data Distribution from zero-rank process In-Reply-To: <53EA411B.4060502@gmail.com> References: <53EA1C5D.1000309@gmail.com> <53EA2334.1060209@gmail.com> <53EA411B.4060502@gmail.com> Message-ID: On Tue, Aug 12, 2014 at 11:30 AM, Mari Pecha wrote: > So, I've tried options with VecScatterCreateToZero but I got error > message > > [0]PETSC ERROR: Nonconforming object sizes > [0]PETSC ERROR: Vector wrong size 10 for scatter 2 (scatter reverse and > vector to != ctx from size) > > I'm not sure what is wrong. Could you help me? My code I've add to > attachements. > Your vector arguments for the scatter are reversed. You are scattering from the local vector with pixel data to the global vector. > Thank you for your time > Mari > > P.S: I use PETSc 3.5 and SCATTER_BACKWARD is changed to SCATTER_REVERSE. > Yes, that is right. Matt > On 12.8.2014 17:53, Matthew Knepley wrote: > > On Tue, Aug 12, 2014 at 9:22 AM, Mari Pecha wrote: > >> Okay. I understand my explanation it sees to be chaotic. I try to >> describe my problem on simple simple. >> >> Process with rank zero loads grayscale image from OpenCV library then I'd >> like to distribute values of pixels to grid (DMDA). And I can't find any >> solution for this problem. >> > > The right thing to do is to create a custom scatter for this case. > However, you can do this in two parts. First, > read it in on proc 0, and then scatter to all procs using > > > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/VecScatterCreateToZero.html > > where you SCATTER_BACKWARD. Then use > > > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/DM/DMDANaturalToGlobalBegin.html > > to permute from the natural ordering that you read in to the PETSc > ordering. You could do this in one > step if you allow each process to read its piece of the vector > independently. > > Thanks, > > Matt > > >> >> Thank you >> Mari >> >> On 12.8.2014 16:12, Matthew Knepley wrote: >> >> On Tue, Aug 12, 2014 at 8:53 AM, Mari Pecha >> wrote: >> >>> Good morning, >>> >>> I'm Mari and I'm beginner PETSc user and I'd like to ask about tough >>> problem, especially for me. >>> I solve problem of data-set distribution, which are saved only on >>> zero-rank process, to DMDA global vector. It means that every process >>> stores a appropriate subset of data-set. I used >>> DMDAGlobalToNaturalAllCreate and DMDANaturalAllToGlobalCreate function, and >>> then VecScatterBegin and VecScatterEnd functions ... see please code below >>> >> >> I have no idea what you really want to do. How about describing your >> problem with >> 2 procs and 3 values per proc. >> >> >>> ... >>> >>> ierr = DMDAGlobalToNaturalAllCreate( da, &tolocalall ); >>> CHKERRQ(ierr); >>> ierr = DMDANaturalAllToGlobalCreate( da, &fromlocalall ); >>> CHKERRQ(ierr); >>> >>> if( rank == 0 ) >>> { >>> >>> ierr = VecCreateSeq( PETSC_COMM_SELF, SIZE, &localall ); >>> >>> ierr = VecScatterBegin( tolocalall, x, localall, ADD_VALUES, >>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>> ierr = VecScatterEnd( tolocalall, x, localall, ADD_VALUES, >>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>> >> >> This will not work since you have a collective call (VecScatterBegin) >> inside if(!rank) >> >> Matt >> >> >>> ierr = VecGetArray( x, &vlocal ); CHKERRQ(ierr); >>> >>> PetscInt s; >>> VecGetSize( localall, &s ); >>> >>> ierr = VecView( localall, PETSC_VIEWER_STDOUT_SELF ); CHKERRQ( >>> ierr ); >>> >>> //create data on zero rank process >>> for ( int i = 0; i < s; i++) *vlocal++ = i; >>> >>> ierr = VecRestoreArray( localall, &vlocal ); CHKERRQ(ierr); >>> >>> ierr = VecScatterBegin(fromlocalall, localall, x, ADD_VALUES, >>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>> ierr = VecScatterEnd( fromlocalall, localall, x, ADD_VALUES, >>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>> } >>> >>> .... >>> >>> But the piece of code gets and distributes only vector-values belong to >>> zero-rank process. So, I haven't any idea how can I solve my problem only >>> with PETSc functions. I'd like to get all values from global vector to >>> zero-rank process and put back all data-set only from zero-rank to global >>> vector. Can you help me, please? >>> >>> Thanks for your response >>> Mari >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Tue Aug 12 11:54:35 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 12 Aug 2014 09:54:35 -0700 Subject: [petsc-users] Error to TaoSolve() call In-Reply-To: References: Message-ID: <87tx5hejhw.fsf@jedbrown.org> Khai Hong Pham writes: > Hello, > > I call TaosSolve() in my code. The solution vector is a nested and Jacobian > matrix is nested too. It shows me the error: > > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > [0]PETSC ERROR: or see > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC ERROR: > or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory > corruption errors > [1]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in stack > below > [0]PETSC ERROR: --------------------- Stack Frames > ------------------------------------ > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, > [0]PETSC ERROR: INSTEAD the line number of the start of the function > [0]PETSC ERROR: is given. > [0]PETSC ERROR: [0] VecRestoreArray_Nest line 731 > /home/khp/bin/petsc-3.5.1/src/vec/vec/impls/nest/vecnest.c > [0]PETSC ERROR: [0] VecRestoreArray line 1656 > /home/khp/bin/petsc-3.5.1/src/vec/vec/interface/rvector.c > [0]PETSC ERROR: [0] VecMedian line 806 > /home/khp/bin/petsc-3.5.1/src/vec/vec/utils/projection.c > [0]PETSC ERROR: [0] TaoSolve_SSILS line 52 > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > [0]PETSC ERROR: [0] TaoSolve line 171 > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > > I debugged with valgrind and received the following message: > > ==19424== Invalid read of size 8 > ==19424== at 0x54089E4: VecRestoreArray_Nest (vecnest.c:746) > ==19424== by 0x53F5F6F: VecRestoreArray (rvector.c:1666) > ==19424== by 0x54BE874: VecMedian (projection.c:855) Can you try 'next'? I think this bad restore has been fixed. I *strongly* recommend *not* using VecNest. 99% of people that think they should use it definitely should not use it. Just use contiguous storage for your vectors. VecNest creates a lot of problems that are almost always larger than the perceived concern that people try to avoid by using VecNest. > ==19424== by 0x6247B74: TaoSolve_SSILS (ssils.c:59) > ==19424== by 0x620739E: TaoSolve (taosolver.c:188) > ==19424== by 0x40491C: main (main.cpp:265) > ==19424== Address 0x0 is not stack'd, malloc'd or (recently) free'd > > It looks like the bug relates to the nested vector. Could you please give > me a hint to locate the bug? Thanks. > > Khai -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From knepley at gmail.com Tue Aug 12 12:10:38 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 12 Aug 2014 12:10:38 -0500 Subject: [petsc-users] Data Distribution from zero-rank process In-Reply-To: <53EA46EE.4090604@gmail.com> References: <53EA1C5D.1000309@gmail.com> <53EA2334.1060209@gmail.com> <53EA411B.4060502@gmail.com> <53EA46EE.4090604@gmail.com> Message-ID: On Tue, Aug 12, 2014 at 11:55 AM, Mari Pecha wrote: > Heurekaaaa, it works!!!!! Thank you so much! :) > Cool. > My final code I've add to attachements for checking. > > So, can I ask now how can I create my own scatter? > I would not worry about that until after you have profiled your code to see what takes the most time, using -log_summary. Thanks, Matt > > Thank you for your time > Mari > > On 12.8.2014 18:40, Matthew Knepley wrote: > > On Tue, Aug 12, 2014 at 11:30 AM, Mari Pecha > wrote: > >> So, I've tried options with VecScatterCreateToZero but I got error >> message >> >> [0]PETSC ERROR: Nonconforming object sizes >> [0]PETSC ERROR: Vector wrong size 10 for scatter 2 (scatter reverse and >> vector to != ctx from size) >> >> I'm not sure what is wrong. Could you help me? My code I've add to >> attachements. >> > > Your vector arguments for the scatter are reversed. You are scattering > from the local vector with pixel data > to the global vector. > > >> Thank you for your time >> Mari >> >> P.S: I use PETSc 3.5 and SCATTER_BACKWARD is changed to SCATTER_REVERSE. >> > > Yes, that is right. > > Matt > > >> On 12.8.2014 17:53, Matthew Knepley wrote: >> >> On Tue, Aug 12, 2014 at 9:22 AM, Mari Pecha >> wrote: >> >>> Okay. I understand my explanation it sees to be chaotic. I try to >>> describe my problem on simple simple. >>> >>> Process with rank zero loads grayscale image from OpenCV library then >>> I'd like to distribute values of pixels to grid (DMDA). And I can't find >>> any solution for this problem. >>> >> >> The right thing to do is to create a custom scatter for this case. >> However, you can do this in two parts. First, >> read it in on proc 0, and then scatter to all procs using >> >> >> http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/VecScatterCreateToZero.html >> >> where you SCATTER_BACKWARD. Then use >> >> >> http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/DM/DMDANaturalToGlobalBegin.html >> >> to permute from the natural ordering that you read in to the PETSc >> ordering. You could do this in one >> step if you allow each process to read its piece of the vector >> independently. >> >> Thanks, >> >> Matt >> >> >>> >>> Thank you >>> Mari >>> >>> On 12.8.2014 16:12, Matthew Knepley wrote: >>> >>> On Tue, Aug 12, 2014 at 8:53 AM, Mari Pecha >>> wrote: >>> >>>> Good morning, >>>> >>>> I'm Mari and I'm beginner PETSc user and I'd like to ask about tough >>>> problem, especially for me. >>>> I solve problem of data-set distribution, which are saved only on >>>> zero-rank process, to DMDA global vector. It means that every process >>>> stores a appropriate subset of data-set. I used >>>> DMDAGlobalToNaturalAllCreate and DMDANaturalAllToGlobalCreate function, and >>>> then VecScatterBegin and VecScatterEnd functions ... see please code below >>>> >>> >>> I have no idea what you really want to do. How about describing your >>> problem with >>> 2 procs and 3 values per proc. >>> >>> >>>> ... >>>> >>>> ierr = DMDAGlobalToNaturalAllCreate( da, &tolocalall ); >>>> CHKERRQ(ierr); >>>> ierr = DMDANaturalAllToGlobalCreate( da, &fromlocalall ); >>>> CHKERRQ(ierr); >>>> >>>> if( rank == 0 ) >>>> { >>>> >>>> ierr = VecCreateSeq( PETSC_COMM_SELF, SIZE, &localall ); >>>> >>>> ierr = VecScatterBegin( tolocalall, x, localall, ADD_VALUES, >>>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>>> ierr = VecScatterEnd( tolocalall, x, localall, ADD_VALUES, >>>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>>> >>> >>> This will not work since you have a collective call (VecScatterBegin) >>> inside if(!rank) >>> >>> Matt >>> >>> >>>> ierr = VecGetArray( x, &vlocal ); CHKERRQ(ierr); >>>> >>>> PetscInt s; >>>> VecGetSize( localall, &s ); >>>> >>>> ierr = VecView( localall, PETSC_VIEWER_STDOUT_SELF ); CHKERRQ( >>>> ierr ); >>>> >>>> //create data on zero rank process >>>> for ( int i = 0; i < s; i++) *vlocal++ = i; >>>> >>>> ierr = VecRestoreArray( localall, &vlocal ); CHKERRQ(ierr); >>>> >>>> ierr = VecScatterBegin(fromlocalall, localall, x, ADD_VALUES, >>>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>>> ierr = VecScatterEnd( fromlocalall, localall, x, ADD_VALUES, >>>> SCATTER_FORWARD_LOCAL ); CHKERRQ(ierr); >>>> } >>>> >>>> .... >>>> >>>> But the piece of code gets and distributes only vector-values belong to >>>> zero-rank process. So, I haven't any idea how can I solve my problem only >>>> with PETSc functions. I'd like to get all values from global vector to >>>> zero-rank process and put back all data-set only from zero-rank to global >>>> vector. Can you help me, please? >>>> >>>> Thanks for your response >>>> Mari >>>> >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From khaipham at utexas.edu Tue Aug 12 12:13:02 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Tue, 12 Aug 2014 12:13:02 -0500 Subject: [petsc-users] Error to TaoSolve() call In-Reply-To: <87tx5hejhw.fsf@jedbrown.org> References: <87tx5hejhw.fsf@jedbrown.org> Message-ID: Jed, Thank you for your advise. I'm solving multi-field problem which were solved by static-splitting schema. I tried to reused my code, that's why I tried to use the nested matrix and vector. I'm trying to use the contiguous vector and matrix storage now. I appreciate if you could give me any advise on managing the matrix and vector (based on the skeleton of the existed code for separate problems) to get good performance. Khai On Tue, Aug 12, 2014 at 11:54 AM, Jed Brown wrote: > Khai Hong Pham writes: > > > Hello, > > > > I call TaosSolve() in my code. The solution vector is a nested and > Jacobian > > matrix is nested too. It shows me the error: > > > > [0]PETSC ERROR: > > ------------------------------------------------------------------------ > > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > > probably memory access out of range > > [0]PETSC ERROR: Try option -start_in_debugger or > -on_error_attach_debugger > > [0]PETSC ERROR: or see > > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC > ERROR: > > or try http://valgrind.org on GNU/linux and Apple Mac OS X to find > memory > > corruption errors > > [1]PETSC ERROR: [0]PETSC ERROR: likely location of problem given in stack > > below > > [0]PETSC ERROR: --------------------- Stack Frames > > ------------------------------------ > > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not > available, > > [0]PETSC ERROR: INSTEAD the line number of the start of the > function > > [0]PETSC ERROR: is given. > > [0]PETSC ERROR: [0] VecRestoreArray_Nest line 731 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/impls/nest/vecnest.c > > [0]PETSC ERROR: [0] VecRestoreArray line 1656 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/interface/rvector.c > > [0]PETSC ERROR: [0] VecMedian line 806 > > /home/khp/bin/petsc-3.5.1/src/vec/vec/utils/projection.c > > [0]PETSC ERROR: [0] TaoSolve_SSILS line 52 > > /home/khp/bin/petsc-3.5.1/src/tao/complementarity/impls/ssls/ssils.c > > [0]PETSC ERROR: [0] TaoSolve line 171 > > /home/khp/bin/petsc-3.5.1/src/tao/interface/taosolver.c > > > > I debugged with valgrind and received the following message: > > > > ==19424== Invalid read of size 8 > > ==19424== at 0x54089E4: VecRestoreArray_Nest (vecnest.c:746) > > ==19424== by 0x53F5F6F: VecRestoreArray (rvector.c:1666) > > ==19424== by 0x54BE874: VecMedian (projection.c:855) > > Can you try 'next'? I think this bad restore has been fixed. > > I *strongly* recommend *not* using VecNest. 99% of people that think > they should use it definitely should not use it. Just use contiguous > storage for your vectors. VecNest creates a lot of problems that are > almost always larger than the perceived concern that people try to avoid > by using VecNest. > > > ==19424== by 0x6247B74: TaoSolve_SSILS (ssils.c:59) > > ==19424== by 0x620739E: TaoSolve (taosolver.c:188) > > ==19424== by 0x40491C: main (main.cpp:265) > > ==19424== Address 0x0 is not stack'd, malloc'd or (recently) free'd > > > > It looks like the bug relates to the nested vector. Could you please give > > me a hint to locate the bug? Thanks. > > > > Khai > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Tue Aug 12 12:17:48 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 12 Aug 2014 10:17:48 -0700 Subject: [petsc-users] MatGetSubMatrix for a Nested matrix In-Reply-To: References: Message-ID: <87d2c5eif7.fsf@jedbrown.org> Khai Hong Pham writes: > Thank you for your information, Matt. I'm using both nested matrix and > nested vector. Is the nested vector good to use ? VecNest is far worse than MatNest. Do not use it under any circumstances. Less than 1% of people that think they have run out of options and absolutely must use VecNest have any business using it. Always make your code work without MatNest first. Check that the answers make sense, then profile to see where memory and time is spent. If you are preconditioning with fieldsplit and excessive memory and time is spent in MatGetSubMatrix(), use -prefix_mat_type nest as an optimization. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jed at jedbrown.org Tue Aug 12 12:29:51 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 12 Aug 2014 10:29:51 -0700 Subject: [petsc-users] Error to TaoSolve() call In-Reply-To: References: <87tx5hejhw.fsf@jedbrown.org> Message-ID: <871tslehv4.fsf@jedbrown.org> Khai Hong Pham writes: > Jed, > > Thank you for your advise. I'm solving multi-field problem which were > solved by static-splitting schema. I tried to reused my code, that's why I > tried to use the nested matrix and vector. I'm trying to use the contiguous > vector and matrix storage now. I appreciate if you could give me any advise > on managing the matrix and vector (based on the skeleton of the existed > code for separate problems) to get good performance. I recommend using MatGetLocalSubMatrix() similar to src/snes/examples/tutorials/ex28.c. That way your old assembly should work (provided you use local indices instead of global, but local indices are better for this purpose anyway). -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From khaipham at utexas.edu Tue Aug 12 16:12:33 2014 From: khaipham at utexas.edu (Khai Hong Pham) Date: Tue, 12 Aug 2014 16:12:33 -0500 Subject: [petsc-users] Variational Inequality and semi-smooth problem Message-ID: Hello, I have to solve a nonlinear problem with the box constraints on the variables. The SNESVI is an ideal candidate. But I have an issue with calling to SNESVISetVariableBounds which are reported by Abhyankar and Que at https://www.mail-archive.com/petsc-users at mcs.anl.gov/msg22094.html. Could anyone know what happens as we call to this routine? I also rely on the penalization method as a way to impose the box contraints. But, with adding the penalization term, the original smooth problem becomes semi-smooth and will have problem with line search. Is there any solver type in Petsc which can deal with semi-smooth problem? Thanks, Khai -------------- next part -------------- An HTML attachment was scrubbed... URL: From ppate024 at odu.edu Tue Aug 12 20:02:36 2014 From: ppate024 at odu.edu (Priyank Patel) Date: Tue, 12 Aug 2014 21:02:36 -0400 Subject: [petsc-users] problem in using MatCreateMPIAIJWithArrays routine Message-ID: Hello, I am trying to do sparse - dense matrix multiplication and for that I am using a CSR Matrix(that are three array) in PETSC using the function MatCreateMPIAIJWithArrays() to create a petsc matrix. My call to routine is as below ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ //Initialize PETSC MPI_Init(&argc, &argv); PetscInitialize(&argc, &argv, (char*) 0, help); MPI_Comm_rank(PETSC_COMM_WORLD, &taskid); MPI_Comm_size(PETSC_COMM_WORLD, &numtasks); //Create A Sparse Matrix fro the files ierr = MatCreateMPIAIJWithArrays(PETSC_COMM_WORLD, m, m, PETSC_DETERMINE, PETSC_DETERMINE, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); //ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_WORLD, m, m, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); MatView(A,PETSC_VIEWER_STDOUT_WORLD); ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ My make file is as below ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ PETSC_DIR=/export/software/petsc-3.3 INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ INTEL_LIB_PATH_64=/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ MKL_INC_PATH=/export/software/intel/mkl/include/ SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ SCALAPACK_INC_PATH=/export/software/scalapack-2.0.2/ GENERAL_LIB_PATH=/export/software/lib/ CLINKER=mpicc PKG_INC = -I${MKL_INC_PATH} PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -Wl,-rpath,${INTEL_LIB_PATH_64} -L${INTEL_LIB_PATH_64} -liomp5 -Wl,-rpath,${SCALAPACK_LIB_PATH} -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -lblas CFLAGS = FFLAGS = CPPFLAGS = ${PKG_INC} FPPFLAGS = CLEANFILES = include ${PETSC_DIR}/conf/variables include ${PETSC_DIR}/conf/rules blockCG_1: blockCG_1.o chkopts -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ And I tried to run the program with following command ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ /opt/openmpi/bin/mpirun -np 3 ./blockCG_1 /home/ppatel/MPI/LF10_2 ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ but the routine is not distributing the matrix and give me the result as below. ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. loading matrix from : /home/ppatel/MPI/LF10_2 nRows: 18, nCoefs: 82. Matrix Object: 1 MPI processes type: mpiaij row 0: (0, 3.53448) (1, -477.155) (2, 1.76724) row 1: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 2: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 3: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 4: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 5: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 6: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 7: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 8: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 9: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 10: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 11: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 12: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 13: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 14: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 15: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 16: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 17: (15, 477.155) (16, 1.76724) (17, 3.53448) row 18: (0, 3.53448) (1, -477.155) (2, 1.76724) row 19: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 20: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 21: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 22: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 23: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 24: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 25: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 26: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 27: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 28: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 29: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 30: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 31: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 32: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 33: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 34: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 35: (15, 477.155) (16, 1.76724) (17, 3.53448) row 36: (0, 3.53448) (1, -477.155) (2, 1.76724) row 37: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 38: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 39: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 40: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 41: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 42: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 43: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 44: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 45: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 46: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 47: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 48: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 49: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 50: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 51: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 52: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 53: (15, 477.155) (16, 1.76724) (17, 3.53448) row 54: (0, 3.53448) (1, -477.155) (2, 1.76724) row 55: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 56: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 57: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 58: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 59: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 60: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 61: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 62: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 63: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 64: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 65: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 66: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 67: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 68: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 69: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 70: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 71: (15, 477.155) (16, 1.76724) (17, 3.53448) row 72: (0, 3.53448) (1, -477.155) (2, 1.76724) row 73: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 74: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 75: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 76: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 77: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 78: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 79: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 80: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 81: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 82: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 83: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 84: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 85: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 86: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 87: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 88: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 89: (15, 477.155) (16, 1.76724) (17, 3.53448) row 90: (0, 3.53448) (1, -477.155) (2, 1.76724) row 91: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) row 92: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) row 93: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) row 94: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) row 95: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) row 96: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) row 97: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) row 98: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) row 99: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) row 100: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) row 101: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) row 102: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) row 103: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) row 104: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) row 105: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) row 106: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) row 107: (15, 477.155) (16, 1.76724) (17, 3.53448) ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ that is creating a matrix with rows repeated 6 times instead of distributed over 6 process. Can you please tell me where I am doing wrong?? Thanks for your time Priyank Patel ppate024 at odu.edu -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 12 20:20:49 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 12 Aug 2014 20:20:49 -0500 Subject: [petsc-users] problem in using MatCreateMPIAIJWithArrays routine In-Reply-To: References: Message-ID: On each process you should only pass the row and column indices for the rows you want on that process. In other words do not pass the entire matrix on each process. Take a look at the example matrix in the manual page http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatCreateMPIAIJWithArrays.html Barry On Aug 12, 2014, at 8:02 PM, Priyank Patel wrote: > Hello, > I am trying to do sparse - dense matrix multiplication and for that I am using a CSR Matrix(that are three array) in PETSC using the function MatCreateMPIAIJWithArrays() to create a petsc matrix. > My call to routine is as below > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > //Initialize PETSC > MPI_Init(&argc, &argv); > PetscInitialize(&argc, &argv, (char*) 0, help); > > MPI_Comm_rank(PETSC_COMM_WORLD, &taskid); > MPI_Comm_size(PETSC_COMM_WORLD, &numtasks); > > //Create A Sparse Matrix fro the files > ierr = MatCreateMPIAIJWithArrays(PETSC_COMM_WORLD, m, m, PETSC_DETERMINE, PETSC_DETERMINE, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); > > //ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_WORLD, m, m, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); > > MatView(A,PETSC_VIEWER_STDOUT_WORLD); > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > My make file is as below > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > PETSC_DIR=/export/software/petsc-3.3 > > INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ > MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ > INTEL_LIB_PATH_64=/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ > MKL_INC_PATH=/export/software/intel/mkl/include/ > SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ > SCALAPACK_INC_PATH=/export/software/scalapack-2.0.2/ > GENERAL_LIB_PATH=/export/software/lib/ > > CLINKER=mpicc > > PKG_INC = -I${MKL_INC_PATH} > PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -Wl,-rpath,${INTEL_LIB_PATH_64} -L${INTEL_LIB_PATH_64} -liomp5 -Wl,-rpath,${SCALAPACK_LIB_PATH} -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -lblas > > CFLAGS = > FFLAGS = > CPPFLAGS = ${PKG_INC} > FPPFLAGS = > CLEANFILES = > > include ${PETSC_DIR}/conf/variables > include ${PETSC_DIR}/conf/rules > > blockCG_1: blockCG_1.o chkopts > -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} > > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > And I tried to run the program with following command > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > /opt/openmpi/bin/mpirun -np 3 ./blockCG_1 /home/ppatel/MPI/LF10_2 > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > but the routine is not distributing the matrix and give me the result as below. > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > Matrix Object: 1 MPI processes > type: mpiaij > row 0: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 1: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 2: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 3: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 4: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 5: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 6: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 7: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 8: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 9: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 10: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 11: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 12: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 13: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 14: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 15: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 16: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 17: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 18: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 19: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 20: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 21: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 22: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 23: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 24: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 25: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 26: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 27: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 28: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 29: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 30: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 31: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 32: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 33: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 34: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 35: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 36: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 37: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 38: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 39: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 40: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 41: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 42: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 43: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 44: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 45: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 46: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 47: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 48: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 49: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 50: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 51: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 52: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 53: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 54: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 55: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 56: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 57: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 58: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 59: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 60: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 61: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 62: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 63: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 64: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 65: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 66: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 67: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 68: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 69: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 70: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 71: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 72: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 73: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 74: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 75: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 76: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 77: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 78: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 79: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 80: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 81: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 82: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 83: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 84: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 85: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 86: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 87: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 88: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 89: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 90: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 91: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 92: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 93: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) > row 94: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 95: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) > row 96: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 97: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) > row 98: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) > row 99: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) > row 100: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) > row 101: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) > row 102: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) > row 103: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) > row 104: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) > row 105: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 106: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 107: (15, 477.155) (16, 1.76724) (17, 3.53448) > > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > that is creating a matrix with rows repeated 6 times instead of distributed over 6 process. > > Can you please tell me where I am doing wrong?? > > Thanks for your time > > Priyank Patel > ppate024 at odu.edu > > > > > From danyang.su at gmail.com Tue Aug 12 22:38:55 2014 From: danyang.su at gmail.com (Danyang Su) Date: Tue, 12 Aug 2014 22:38:55 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler Message-ID: Hi All, Does any one know how to use the preprocessor definition flags for IBM XL Compiler on IBM BG/Q system? I can use FPPFLAGS (below) for Intel fortran compiler and Gfortran, but IBM XL Fortran compiler cannot recognise it. I also tried to use FPPFLAGS_IBMXL (below) but without success. How can I set the FPPFLAGS for IBM XL Compiler? It seems a little painful to support it. Thanks, Danyang #makefile include ${PETSC_DIR}/conf/variables include ${PETSC_DIR}/conf/rules SRC =./../../ FPPFLAGS = -DLINUX -DRELEASE -DPETSC -DMPI FPPFLAGS_IBMXL = -WF,-DLINUX -WF,-DRELEASE -WF,-DPETSC -WF,-DMPI DLIB = # Note: Order of the following code files is the same with that in visual fortran project buildlog SOURCES = $(SRC)common.o\ $(SRC)input.o\ $(SRC)model.o\ ...... example: $(SOURCES) chkopts -${FLINKER} $(FPPFLAGS_IBMXL) -o example $(SOURCES) ${PETSC_LIB} ${DLIB} -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Tue Aug 12 22:46:06 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Tue, 12 Aug 2014 22:46:06 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: On Tue, 12 Aug 2014, Danyang Su wrote: > Hi All, > > Does any one know how to use the preprocessor definition flags for IBM XL > Compiler on IBM BG/Q system? > > I can use FPPFLAGS (below) for Intel fortran compiler and Gfortran, but IBM > XL Fortran compiler cannot recognise it. I also tried to use FPPFLAGS_IBMXL > (below) but without success. > > How can I set the FPPFLAGS for IBM XL Compiler? It seems a little painful > to support it. > > Thanks, > > Danyang > > #makefile > include ${PETSC_DIR}/conf/variables > include ${PETSC_DIR}/conf/rules > SRC =./../../ > FPPFLAGS = -DLINUX -DRELEASE -DPETSC -DMPI > FPPFLAGS_IBMXL = -WF,-DLINUX -WF,-DRELEASE -WF,-DPETSC -WF,-DMPI I don't understand. Doesn't the following work? What compile commands does make invoke with it? FPPFLAGS = -WF,-DLINUX -WF,-DRELEASE -WF,-DPETSC -WF,-DMPI > DLIB = > # Note: Order of the following code files is the same with that in visual > fortran project buildlog > SOURCES = $(SRC)common.o\ > $(SRC)input.o\ > $(SRC)model.o\ > ...... > example: $(SOURCES) chkopts > -${FLINKER} $(FPPFLAGS_IBMXL) -o example $(SOURCES) ${PETSC_LIB} FPPFLAGS_IBMXL shouldn't be used at link time [they are compile/preprocessing flags] Satish > ${DLIB} > From danyang.su at gmail.com Tue Aug 12 23:00:50 2014 From: danyang.su at gmail.com (Danyang Su) Date: Tue, 12 Aug 2014 23:00:50 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: On Tue, Aug 12, 2014 at 10:46 PM, Satish Balay wrote: > On Tue, 12 Aug 2014, Danyang Su wrote: > > > Hi All, > > > > Does any one know how to use the preprocessor definition flags for IBM XL > > Compiler on IBM BG/Q system? > > > > I can use FPPFLAGS (below) for Intel fortran compiler and Gfortran, but > IBM > > XL Fortran compiler cannot recognise it. I also tried to use > FPPFLAGS_IBMXL > > (below) but without success. > > > > How can I set the FPPFLAGS for IBM XL Compiler? It seems a little painful > > to support it. > > > > Thanks, > > > > Danyang > > > > #makefile > > include ${PETSC_DIR}/conf/variables > > include ${PETSC_DIR}/conf/rules > > SRC =./../../ > > FPPFLAGS = -DLINUX -DRELEASE -DPETSC -DMPI > > FPPFLAGS_IBMXL = -WF,-DLINUX -WF,-DRELEASE -WF,-DPETSC -WF,-DMPI > > I don't understand. Doesn't the following work? What compile commands does > make invoke with it? > Yes, the following doesn't work. I just use "make example &> log.txt" to compile it. From the log file, it shows that the FPP FLAGS are not recongised. The machine is Vesta and I have add +mpiwrapper-xl to .soft file and resoft it. > > FPPFLAGS = -WF,-DLINUX -WF,-DRELEASE -WF,-DPETSC -WF,-DMPI > > > DLIB = > > # Note: Order of the following code files is the same with that in visual > > fortran project buildlog > > SOURCES = $(SRC)common.o\ > > $(SRC)input.o\ > > $(SRC)model.o\ > > ...... > > example: $(SOURCES) chkopts > > -${FLINKER} $(FPPFLAGS_IBMXL) -o example $(SOURCES) ${PETSC_LIB} > > FPPFLAGS_IBMXL shouldn't be used at link time [they are > compile/preprocessing flags] > > Satish > > > ${DLIB} > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Tue Aug 12 23:11:09 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Tue, 12 Aug 2014 23:11:09 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: On Tue, 12 Aug 2014, Danyang Su wrote: > On Tue, Aug 12, 2014 at 10:46 PM, Satish Balay wrote: > > I don't understand. Doesn't the following work? What compile commands does > > make invoke with it? > > > Yes, the following doesn't work. I just use "make example &> log.txt" to > compile it. From the log file, it shows that the FPP FLAGS are not > recongised. > The machine is Vesta and I have add +mpiwrapper-xl to .soft file and > resoft it. I wanted to see the contents of log.text. Anyway - here is how it works on vesta.. Satish ----------- [balay at vestalac1 test]$ ls ex1f.F makefile [balay at vestalac1 test]$ cat makefile CFLAGS = FFLAGS = CPPFLAGS = FPPFLAGS = -WF,-DDUMMY_FLAG CLEANFILES = include ${PETSC_DIR}/conf/variables include ${PETSC_DIR}/conf/rules ex1f: ex1f.o chkopts -${FLINKER} -o ex1f ex1f.o ${PETSC_KSP_LIB} ${RM} ex1f.o [balay at vestalac1 test]$ make ex1f mpixlf77_r -qnosave -c -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict -qstrict_induction -I/soft/libraries/petsc/3.4.4/xl-opt/include -I/soft/libraries/petsc/3.4.4/xl-opt/include -WF,-DDUMMY_FLAG -o ex1f.o ex1f.F ** main === End of Compilation 1 === 1501-510 Compilation successful for file ex1f.F. mpixlf77_r -qnosave -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict -qstrict_induction -o ex1f ex1f.o -L/soft/libraries/petsc/3.4.4/xl-opt/lib -lpetsc -Wl,-rpath,/soft/libraries/petsc/3.4.4/xl-opt/lib -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -Wl,-rpath,/soft/libraries/alcf/current/xl/SCALAPACK/lib -L/soft/libraries/alcf/current/xl/SCALAPACK/lib -lscalapack -lsuperlu_4.3 -lsuperlu_dist_3.3 -lHYPRE -lspai -lumfpack -lamd -L/soft/libraries/alcf/current/xl/LAPACK/lib -llapack -L/soft/libraries/alcf/current/xl/BLAS/lib -lblas -ltriangle -lchaco -lparmetis -lmetis -lpthread -ldl -lmpichcxx-gcc -lmpichf77-gcc -L/soft/compilers/ibmcmp-nov2013/vacpp/bg/12.1/bglib64 -libmc++ -L/soft/compilers/ibmcmp-nov2013/xlf/bg/14.1/bglib64 -lxlf90_r -lxlomp_ser -lxlfmath /bin/rm -f ex1f.o [balay at vestalac1 test]$ From danyang.su at gmail.com Tue Aug 12 23:25:29 2014 From: danyang.su at gmail.com (Danyang Su) Date: Tue, 12 Aug 2014 23:25:29 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: Hi Satish, The log file is attached. There are errors like below: "../../min3p/welcome_pc.F90", line 151.16: 1516-036 (S) Entity iargc has undefined type. "../../min3p/welcome_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** welcome === End of Compilation 1 === I use preprocessor definition so as to exclude these non-standard fortran calling like iargc. Thanks, Danyang On Tue, Aug 12, 2014 at 11:11 PM, Satish Balay wrote: > On Tue, 12 Aug 2014, Danyang Su wrote: > > > On Tue, Aug 12, 2014 at 10:46 PM, Satish Balay > wrote: > > > > I don't understand. Doesn't the following work? What compile commands > does > > > make invoke with it? > > > > > Yes, the following doesn't work. I just use "make example &> log.txt" to > > compile it. From the log file, it shows that the FPP FLAGS are not > > recongised. > > The machine is Vesta and I have add +mpiwrapper-xl to .soft file and > > resoft it. > > I wanted to see the contents of log.text. Anyway - here is how it > works on vesta.. > > Satish > > ----------- > > [balay at vestalac1 test]$ ls > ex1f.F makefile > [balay at vestalac1 test]$ cat makefile > CFLAGS = > FFLAGS = > CPPFLAGS = > FPPFLAGS = -WF,-DDUMMY_FLAG > CLEANFILES = > > include ${PETSC_DIR}/conf/variables > include ${PETSC_DIR}/conf/rules > > ex1f: ex1f.o chkopts > -${FLINKER} -o ex1f ex1f.o ${PETSC_KSP_LIB} > ${RM} ex1f.o > > [balay at vestalac1 test]$ make ex1f > mpixlf77_r -qnosave -c -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict > -qstrict_induction -I/soft/libraries/petsc/3.4.4/xl-opt/include > -I/soft/libraries/petsc/3.4.4/xl-opt/include -WF,-DDUMMY_FLAG -o ex1f.o > ex1f.F > ** main === End of Compilation 1 === > 1501-510 Compilation successful for file ex1f.F. > mpixlf77_r -qnosave -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict > -qstrict_induction -o ex1f ex1f.o > -L/soft/libraries/petsc/3.4.4/xl-opt/lib -lpetsc > -Wl,-rpath,/soft/libraries/petsc/3.4.4/xl-opt/lib -lcmumps -ldmumps > -lsmumps -lzmumps -lmumps_common -lpord > -Wl,-rpath,/soft/libraries/alcf/current/xl/SCALAPACK/lib > -L/soft/libraries/alcf/current/xl/SCALAPACK/lib -lscalapack -lsuperlu_4.3 > -lsuperlu_dist_3.3 -lHYPRE -lspai -lumfpack -lamd > -L/soft/libraries/alcf/current/xl/LAPACK/lib -llapack > -L/soft/libraries/alcf/current/xl/BLAS/lib -lblas -ltriangle -lchaco > -lparmetis -lmetis -lpthread -ldl -lmpichcxx-gcc -lmpichf77-gcc > -L/soft/compilers/ibmcmp-nov2013/vacpp/bg/12.1/bglib64 -libmc++ > -L/soft/compilers/ibmcmp-nov2013/xlf/bg/14.1/bglib64 -lxlf90_r -lxlomp_ser > -lxlfmath > /bin/rm -f ex1f.o > [balay at vestalac1 test]$ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totsorb.o ../../min3p/totsorb.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totsorb.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totsorb === End of Compilation 1 === 1501-510 Compilation successful for file totsorb.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/storheat.o ../../min3p/storheat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/storheat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** stordheat === End of Compilation 1 === 1501-510 Compilation successful for file storheat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rhsvs.o ../../min3p/rhsvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rhsvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rhsvs === End of Compilation 1 === 1501-510 Compilation successful for file rhsvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxdd.o ../../min3p/fluxdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxdd === End of Compilation 1 === 1501-510 Compilation successful for file fluxdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/relperm_ovendry.o ../../min3p/relperm_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/relperm_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** relperm_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file relperm_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/int3a_ovendry.o ../../min3p/int3a_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/int3a_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** int3a_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file int3a_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/g_ovendry.o ../../min3p/g_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/g_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** g_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file g_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/findstrg.o ../../min3p/findstrg.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/findstrg.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findstrg === End of Compilation 1 === "../../min3p/findstrg.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findstrginzone === End of Compilation 2 === 1501-510 Compilation successful for file findstrg.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/alkcalc.o ../../min3p/alkcalc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/alkcalc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** alkcalc === End of Compilation 1 === 1501-510 Compilation successful for file alkcalc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/giups_brt.o ../../gas_advection/giups_brt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/giups_brt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** giups_brt === End of Compilation 1 === 1501-510 Compilation successful for file giups_brt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxheat.o ../../min3p/fluxheat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxheat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxheat === End of Compilation 1 === 1501-510 Compilation successful for file fluxheat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/diffcoff.o ../../min3p/diffcoff.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/diffcoff.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** diffcoff === End of Compilation 1 === 1501-510 Compilation successful for file diffcoff.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rhsrt.o ../../min3p/rhsrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rhsrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rhsrt === End of Compilation 1 === 1501-510 Compilation successful for file rhsrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/int_h_ovendry.o ../../min3p/int_h_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/int_h_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** int_h_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file int_h_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxd.o ../../min3p/fluxd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxd === End of Compilation 1 === 1501-510 Compilation successful for file fluxd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/bulkconc.o ../../min3p/bulkconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/bulkconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** bulkconc === End of Compilation 1 === 1501-510 Compilation successful for file bulkconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/zero_r8.o ../../min3p/zero_r8.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/zero_r8.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** zero_r8 === End of Compilation 1 === 1501-510 Compilation successful for file zero_r8.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/acoff.o ../../min3p/acoff.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/acoff.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** acoff === End of Compilation 1 === 1501-510 Compilation successful for file acoff.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dtotcong.o ../../min3p/dtotcong.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dtotcong.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dtotcong === End of Compilation 1 === 1501-510 Compilation successful for file dtotcong.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/diff_vapour.o ../../min3p/diff_vapour.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/diff_vapour.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** diff_energybal === End of Compilation 1 === 1501-510 Compilation successful for file diff_vapour.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/storddfs.o ../../min3p/storddfs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/storddfs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** storddfs === End of Compilation 1 === 1501-510 Compilation successful for file storddfs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/int3b_ovendry.o ../../min3p/int3b_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/int3b_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** int3b_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file int3b_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readbloc.o ../../min3p/readbloc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readbloc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readbloc === End of Compilation 1 === 1501-510 Compilation successful for file readbloc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxvs.o ../../min3p/fluxvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxvs === End of Compilation 1 === 1501-510 Compilation successful for file fluxvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/findname.o ../../min3p/findname.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/findname.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findname === End of Compilation 1 === 1501-510 Compilation successful for file findname.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/vhoff.o ../../min3p/vhoff.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/vhoff.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** vhoff === End of Compilation 1 === 1501-510 Compilation successful for file vhoff.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dhconst.o ../../min3p/dhconst.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dhconst.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dhconst === End of Compilation 1 === 1501-510 Compilation successful for file dhconst.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/cos_function.o ../../min3p/cos_function.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/cos_function.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** cos_function === End of Compilation 1 === 1501-510 Compilation successful for file cos_function.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/stordd.o ../../min3p/stordd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/stordd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** stordd === End of Compilation 1 === 1501-510 Compilation successful for file stordd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/soilprdd.o ../../min3p/soilprdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/soilprdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** soilprdd === End of Compilation 1 === 1501-510 Compilation successful for file soilprdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/porosity_flow.o ../../min3p/porosity_flow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/porosity_flow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** porosity_flow === End of Compilation 1 === 1501-510 Compilation successful for file porosity_flow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/lubksb.o ../../phase_class/tools/lubksb.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/lubksb.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** lubksb === End of Compilation 1 === 1501-510 Compilation successful for file lubksb.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/gasm.o ../../gas_advection/gasm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/gasm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasm === End of Compilation 1 === 1501-510 Compilation successful for file gasm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/zero_i4.o ../../min3p/zero_i4.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/zero_i4.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** zero_i4 === End of Compilation 1 === 1501-510 Compilation successful for file zero_i4.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/secspec.o ../../min3p/secspec.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/secspec.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** secspec === End of Compilation 1 === 1501-510 Compilation successful for file secspec.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/h_ovendry.o ../../min3p/h_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/h_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** h_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file h_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/fluxvg.o ../../gas_advection/fluxvg.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/fluxvg.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxvg === End of Compilation 1 === 1501-510 Compilation successful for file fluxvg.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/findkey.o ../../min3p/findkey.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/findkey.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findkey === End of Compilation 1 === 1501-510 Compilation successful for file findkey.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/wgpropd.o ../../gas_advection/wgpropd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/wgpropd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** wgpropd === End of Compilation 1 === 1501-510 Compilation successful for file wgpropd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rsort.o ../../min3p/rsort.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rsort.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rsort === End of Compilation 1 === 1501-510 Compilation successful for file rsort.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/relpfsat_g.o ../../gas_advection/relpfsat_g.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/relpfsat_g.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** relpfsat_g === End of Compilation 1 === 1501-510 Compilation successful for file relpfsat_g.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddtds_1.o ../../min3p/ddtds_1.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddtds_1.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rhonew === End of Compilation 1 === 1501-510 Compilation successful for file ddtds_1.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/satindex.o ../../min3p/satindex.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/satindex.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** satindex === End of Compilation 1 === 1501-510 Compilation successful for file satindex.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/wgprop.o ../../gas_advection/wgprop.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/wgprop.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** wgprop === End of Compilation 1 === 1501-510 Compilation successful for file wgprop.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/storheatevap.o ../../min3p/storheatevap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/storheatevap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** storevap === End of Compilation 1 === 1501-510 Compilation successful for file storheatevap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ionstr.o ../../min3p/ionstr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ionstr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ionstr === End of Compilation 1 === 1501-510 Compilation successful for file ionstr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/icnvrt.o ../../min3p/icnvrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/icnvrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** icnvrt === End of Compilation 1 === 1501-510 Compilation successful for file icnvrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxfs.o ../../min3p/fluxfs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxfs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxfs === End of Compilation 1 === 1501-510 Compilation successful for file fluxfs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/dfluxvg.o ../../gas_advection/dfluxvg.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/dfluxvg.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dfluxvg === End of Compilation 1 === 1501-510 Compilation successful for file dfluxvg.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/concsort.o ../../min3p/concsort.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/concsort.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** concsort === End of Compilation 1 === 1501-510 Compilation successful for file concsort.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/zoutput.o ../../min3p/zoutput.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/zoutput.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** zoutput === End of Compilation 1 === 1501-510 Compilation successful for file zoutput.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/simq.o ../../min3p/simq.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/simq.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** simq === End of Compilation 1 === 1501-510 Compilation successful for file simq.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/relpfsat.o ../../min3p/relpfsat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/relpfsat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** relpfsat === End of Compilation 1 === 1501-510 Compilation successful for file relpfsat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/findzone.o ../../min3p/findzone.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/findzone.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findzone === End of Compilation 1 === 1501-510 Compilation successful for file findzone.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/xh_ovendry.o ../../min3p/xh_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/xh_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** xh_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file xh_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/w_ovendry.o ../../min3p/w_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/w_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** w_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file w_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/satfpres.o ../../min3p/satfpres.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/satfpres.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** satfpres === End of Compilation 1 === 1501-510 Compilation successful for file satfpres.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/gs_ovendry.o ../../min3p/gs_ovendry.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/gs_ovendry.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gs_ovendry === End of Compilation 1 === 1501-510 Compilation successful for file gs_ovendry.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxv.o ../../min3p/fluxv.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxv.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxv === End of Compilation 1 === 1501-510 Compilation successful for file fluxv.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/darcy_energybal.o ../../min3p/darcy_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/darcy_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** darcy_energybal === End of Compilation 1 === 1501-510 Compilation successful for file darcy_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_charset.o ../../phase_class/tools/xmlreader/m_charset.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_charset.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_charset === End of Compilation 1 === 1501-510 Compilation successful for file m_charset.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/petsc_mpi_common.o ../../solver/petsc_mpi_common.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../solver/petsc_mpi_common.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** petsc_mpi_common === End of Compilation 1 === 1501-510 Compilation successful for file petsc_mpi_common.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/parm.o ../../min3p/parm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/parm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** parm === End of Compilation 1 === 1501-510 Compilation successful for file parm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_debug.o ../../phase_class/tools/xmlreader/m_debug.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_debug.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_debug === End of Compilation 1 === 1501-510 Compilation successful for file m_debug.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../version/Version.o ../../version/Version.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../version/Version.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** version === End of Compilation 1 === 1501-510 Compilation successful for file Version.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_snes_common.o ../../solver/solver_snes_common.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. 1517-020: (E) Source file is empty. ** ../../solver/solver_snes_common.F90 === End of Compilation 1 === "../../solver/solver_snes_common.F90", 1500-030 (I) INFORMATION: (block data)__1: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 0. 1501-510 Compilation successful for file solver_snes_common.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/constants/m_constants_cheproo.o ../../phase_class/constants/m_constants_cheproo.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/constants/m_constants_cheproo.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_constants_cheproo === End of Compilation 1 === 1501-510 Compilation successful for file m_constants_cheproo.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dens.o ../../min3p/dens.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dens.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dens === End of Compilation 1 === 1501-510 Compilation successful for file dens.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../icesheet/m_ice_sheet.o ../../icesheet/m_ice_sheet.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../icesheet/m_ice_sheet.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_ice_sheet === End of Compilation 1 === 1501-510 Compilation successful for file m_ice_sheet.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/multidiff.o ../../min3p/multidiff.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/multidiff.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** multidiff === End of Compilation 1 === 1501-510 Compilation successful for file multidiff.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_buffer.o ../../phase_class/tools/xmlreader/m_buffer.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_buffer.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_buffer === End of Compilation 1 === 1501-510 Compilation successful for file m_buffer.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../energy_balance/m_heat_transport.o ../../energy_balance/m_heat_transport.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../energy_balance/m_heat_transport.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_heat_transport === End of Compilation 1 === 1501-510 Compilation successful for file m_heat_transport.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_dictionary.o ../../phase_class/tools/xmlreader/m_dictionary.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_dictionary.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_dictionary === End of Compilation 1 === 1501-510 Compilation successful for file m_dictionary.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../version/writeversion.o ../../version/writeversion.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../version/writeversion.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** writeversion === End of Compilation 1 === 1501-510 Compilation successful for file writeversion.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_io.o ../../phase_class/tools/xmlreader/m_io.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_io.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_io === End of Compilation 1 === 1501-510 Compilation successful for file m_io.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/gen.o ../../min3p/gen.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/gen.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gen === End of Compilation 1 === 1501-510 Compilation successful for file gen.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_snes_interface.o ../../solver/solver_snes_interface.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. 1517-020: (E) Source file is empty. ** ../../solver/solver_snes_interface.F90 === End of Compilation 1 === "../../solver/solver_snes_interface.F90", 1500-030 (I) INFORMATION: (block data)__1: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 0. 1501-510 Compilation successful for file solver_snes_interface.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_reader.o ../../phase_class/tools/xmlreader/m_reader.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_reader.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_reader === End of Compilation 1 === 1501-510 Compilation successful for file m_reader.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/m_general_tools_cheproo.o ../../phase_class/tools/m_general_tools_cheproo.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/m_general_tools_cheproo.F90", line 2288.30: 1512-053 (E) Edit descriptor in literal FMT specifier is invalid and will be ignored. "../../phase_class/tools/m_general_tools_cheproo.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_general_tools_cheproo === End of Compilation 1 === 1501-510 Compilation successful for file m_general_tools_cheproo.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_snes_function.o ../../solver/solver_snes_function.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. 1517-020: (E) Source file is empty. ** ../../solver/solver_snes_function.F90 === End of Compilation 1 === "../../solver/solver_snes_function.F90", 1500-030 (I) INFORMATION: (block data)__1: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 0. 1501-510 Compilation successful for file solver_snes_function.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_converters.o ../../phase_class/tools/xmlreader/m_converters.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_converters.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_converters === End of Compilation 1 === 1501-510 Compilation successful for file m_converters.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/file_utility.o ../../min3p/file_utility.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/file_utility.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** file_utility === End of Compilation 1 === 1501-510 Compilation successful for file file_utility.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/phys.o ../../min3p/phys.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/phys.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** phys === End of Compilation 1 === 1501-510 Compilation successful for file phys.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/matrix_utility.o ../../solver/matrix_utility.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../solver/matrix_utility.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** matrix_utility === End of Compilation 1 === 1501-510 Compilation successful for file matrix_utility.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dual.o ../../min3p/dual.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dual.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dual === End of Compilation 1 === 1501-510 Compilation successful for file dual.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_entities.o ../../phase_class/tools/xmlreader/m_entities.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_entities.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_entities === End of Compilation 1 === 1501-510 Compilation successful for file m_entities.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_runtime.o ../../solver/solver_runtime.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../solver/solver_runtime.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** solver_runtime === End of Compilation 1 === 1501-510 Compilation successful for file solver_runtime.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_elstack.o ../../phase_class/tools/xmlreader/m_elstack.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_elstack.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_elstack === End of Compilation 1 === 1501-510 Compilation successful for file m_elstack.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -o ../../solver/solver_results.o ../../solver/solver_results.f90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. ** solver_results === End of Compilation 1 === 1501-510 Compilation successful for file solver_results.f90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_pardiso.o ../../solver/solver_pardiso.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. 1517-020: (E) Source file is empty. ** ../../solver/solver_pardiso.F90 === End of Compilation 1 === "../../solver/solver_pardiso.F90", 1500-030 (I) INFORMATION: (block data)__1: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 0. 1501-510 Compilation successful for file solver_pardiso.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver_ddmethod.o ../../solver/solver_ddmethod.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. 1517-020: (E) Source file is empty. ** ../../solver/solver_ddmethod.F90 === End of Compilation 1 === "../../solver/solver_ddmethod.F90", 1500-030 (I) INFORMATION: (block data)__1: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 0. 1501-510 Compilation successful for file solver_ddmethod.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_fsm.o ../../phase_class/tools/xmlreader/m_fsm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_fsm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_fsm === End of Compilation 1 === 1501-510 Compilation successful for file m_fsm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_xml_error.o ../../phase_class/tools/xmlreader/m_xml_error.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_xml_error.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_xml_error === End of Compilation 1 === 1501-510 Compilation successful for file m_xml_error.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_xml_parser.o ../../phase_class/tools/xmlreader/m_xml_parser.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_xml_parser.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_xml_parser === End of Compilation 1 === 1501-510 Compilation successful for file m_xml_parser.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/flib_sax.o ../../phase_class/tools/xmlreader/flib_sax.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/flib_sax.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** flib_sax === End of Compilation 1 === 1501-510 Compilation successful for file flib_sax.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xpath/m_path.o ../../phase_class/tools/xpath/m_path.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xpath/m_path.F90", line 548.15: 1506-342 (W) "/*" detected in comment. "../../phase_class/tools/xpath/m_path.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_path === End of Compilation 1 === 1501-510 Compilation successful for file m_path.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xmlreader/m_handlers.o ../../phase_class/tools/xmlreader/m_handlers.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xmlreader/m_handlers.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_handlers === End of Compilation 1 === 1501-510 Compilation successful for file m_handlers.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/tools/xpath/flib_xpath.o ../../phase_class/tools/xpath/flib_xpath.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/tools/xpath/flib_xpath.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** flib_xpath === End of Compilation 1 === 1501-510 Compilation successful for file flib_xpath.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/species/m_species.o ../../phase_class/species/m_species.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/species/m_species.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_species === End of Compilation 1 === 1501-510 Compilation successful for file m_species.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_parentphase.o ../../phase_class/phase/m_parentphase.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_parentphase.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_parentphase === End of Compilation 1 === 1501-510 Compilation successful for file m_parentphase.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_parentaqueousphase.o ../../phase_class/phase/m_parentaqueousphase.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_parentaqueousphase.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_parentaqueousphase === End of Compilation 1 === 1501-510 Compilation successful for file m_parentaqueousphase.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_aqueousphasepitzer.o ../../phase_class/phase/m_aqueousphasepitzer.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_aqueousphasepitzer.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_aqueousphasepitzer === End of Compilation 1 === "../../phase_class/phase/m_aqueousphasepitzer.F90", 1500-030 (I) INFORMATION: __m_aqueousphasepitzer_NMOD_create_aqphpitzer: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file m_aqueousphasepitzer.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_aqueousphaseideal.o ../../phase_class/phase/m_aqueousphaseideal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_aqueousphaseideal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_aqueousphaseideal === End of Compilation 1 === 1501-510 Compilation successful for file m_aqueousphaseideal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_aqueousphasedavis.o ../../phase_class/phase/m_aqueousphasedavis.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_aqueousphasedavis.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_aqueousphasedavis === End of Compilation 1 === 1501-510 Compilation successful for file m_aqueousphasedavis.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_aqueousphasebdot.o ../../phase_class/phase/m_aqueousphasebdot.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_aqueousphasebdot.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_aqueousphasebdot === End of Compilation 1 === 1501-510 Compilation successful for file m_aqueousphasebdot.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_aqueousphase.o ../../phase_class/phase/m_aqueousphase.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_aqueousphase.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_aqueousphase === End of Compilation 1 === 1501-510 Compilation successful for file m_aqueousphase.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../phase_class/phase/m_phase.o ../../phase_class/phase/m_phase.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../phase_class/phase/m_phase.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** m_phase === End of Compilation 1 === 1501-510 Compilation successful for file m_phase.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/chem.o ../../min3p/chem.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/chem.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** chem === End of Compilation 1 === 1501-510 Compilation successful for file chem.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/solver.o ../../solver/solver.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../solver/solver.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** solver === End of Compilation 1 === 1501-510 Compilation successful for file solver.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/welcome_pc.o ../../min3p/welcome_pc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/welcome_pc.F90", line 151.16: 1516-036 (S) Entity iargc has undefined type. "../../min3p/welcome_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** welcome === End of Compilation 1 === 1501-511 Compilation failed for file welcome_pc.F90. make: [../../min3p/welcome_pc.o] Error 1 (ignored) mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/velovapour.o ../../min3p/velovapour.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/velovapour.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** velovapour === End of Compilation 1 === 1501-510 Compilation successful for file velovapour.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updatelc.o ../../min3p/updatelc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updatelc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updatelc === End of Compilation 1 === 1501-510 Compilation successful for file updatelc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readmin.o ../../min3p/readmin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readmin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readmin === End of Compilation 1 === 1501-510 Compilation successful for file readmin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rategas.o ../../min3p/rategas.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rategas.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rategas === End of Compilation 1 === 1501-510 Compilation successful for file rategas.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnmbfls_mcd.o ../../min3p/opnmbfls_mcd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnmbfls_mcd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnmbfls_mcd === End of Compilation 1 === 1501-510 Compilation successful for file opnmbfls_mcd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_vs.o ../../min3p/mem_vs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_vs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_vs === End of Compilation 1 === "../../min3p/mem_vs.F90", 1500-030 (I) INFORMATION: mem_vs: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_vs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_dd.o ../../min3p/mem_dd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_dd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_dd === End of Compilation 1 === 1501-510 Compilation successful for file mem_dd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/intpolt.o ../../min3p/intpolt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/intpolt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** intpolt === End of Compilation 1 === 1501-510 Compilation successful for file intpolt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/pitzer/initpitzer_pc.o ../../min3p/pitzer/initpitzer_pc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/pitzer/initpitzer_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initpitzer === End of Compilation 1 === 1501-510 Compilation successful for file initpitzer_pc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initbcenergybal.o ../../min3p/initbcenergybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initbcenergybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initbcenergybal === End of Compilation 1 === "../../min3p/initbcenergybal.F90", 1500-030 (I) INFORMATION: initbcenergybal: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file initbcenergybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/icbcrt.o ../../min3p/icbcrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/icbcrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** icbcrt === End of Compilation 1 === "../../min3p/icbcrt.F90", 1500-030 (I) INFORMATION: icbcrt: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file icbcrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/gasv.o ../../gas_advection/gasv.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/gasv.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasv === End of Compilation 1 === 1501-510 Compilation successful for file gasv.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dratemin_new.o ../../min3p/dratemin_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dratemin_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dratemin_new === End of Compilation 1 === 1501-510 Compilation successful for file dratemin_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/compute_sensible.o ../../min3p/compute_sensible.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/compute_sensible.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** compute_sensible === End of Compilation 1 === 1501-510 Compilation successful for file compute_sensible.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/cbalance.o ../../min3p/cbalance.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/cbalance.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** cbalance === End of Compilation 1 === 1501-510 Compilation successful for file cbalance.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/zero_r8_parallel.o ../../min3p/zero_r8_parallel.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/zero_r8_parallel.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** zero_r8_parallel === End of Compilation 1 === 1501-510 Compilation successful for file zero_r8_parallel.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/vapor_prop.o ../../min3p/vapor_prop.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/vapor_prop.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** vapor_prop === End of Compilation 1 === 1501-510 Compilation successful for file vapor_prop.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/trddflow.o ../../min3p/trddflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/trddflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** trddflow === End of Compilation 1 === 1501-510 Compilation successful for file trddflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totconcg.o ../../min3p/totconcg.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totconcg.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totconcg === End of Compilation 1 === 1501-510 Compilation successful for file totconcg.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/sptldisc.o ../../min3p/sptldisc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/sptldisc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** sptldisc === End of Compilation 1 === "../../min3p/sptldisc.F90", 1500-030 (I) INFORMATION: sptldisc: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file sptldisc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/setsize.o ../../min3p/setsize.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/setsize.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** setsize === End of Compilation 1 === 1501-510 Compilation successful for file setsize.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/phpe.o ../../min3p/phpe.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/phpe.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** phpe === End of Compilation 1 === 1501-510 Compilation successful for file phpe.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/nexttime.o ../../min3p/nexttime.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/nexttime.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** nexttime === End of Compilation 1 === 1501-510 Compilation successful for file nexttime.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nmx.o ../../min3p/mem_nmx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nmx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nmx === End of Compilation 1 === 1501-510 Compilation successful for file mem_nmx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacrt.o ../../min3p/jacrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacrt === End of Compilation 1 === 1501-510 Compilation successful for file jacrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initgeom.o ../../min3p/initgeom.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initgeom.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initgeom === End of Compilation 1 === 1501-510 Compilation successful for file initgeom.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infcvs.o ../../min3p/infcvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infcvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcvs === End of Compilation 1 === 1501-510 Compilation successful for file infcvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/i2upfind_heat.o ../../min3p/i2upfind_heat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/i2upfind_heat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** i2upfind_heat === End of Compilation 1 === 1501-510 Compilation successful for file i2upfind_heat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/drateint.o ../../min3p/drateint.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/drateint.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** drateint === End of Compilation 1 === 1501-510 Compilation successful for file drateint.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddfsflow.o ../../min3p/ddfsflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddfsflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddfsflow === End of Compilation 1 === 1501-510 Compilation successful for file ddfsflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/vsflow.o ../../min3p/vsflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/vsflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** vsflow === End of Compilation 1 === 1501-510 Compilation successful for file vsflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtbcvs.o ../../min3p/updtbcvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtbcvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtbcvs === End of Compilation 1 === 1501-510 Compilation successful for file updtbcvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rtrvpprm.o ../../min3p/rtrvpprm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rtrvpprm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rtrvpprm === End of Compilation 1 === 1501-510 Compilation successful for file rtrvpprm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readredx_new.o ../../min3p/readredx_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readredx_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readredx_new === End of Compilation 1 === 1501-510 Compilation successful for file readredx_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ratemin_new.o ../../min3p/ratemin_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ratemin_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ratemin_new === End of Compilation 1 === 1501-510 Compilation successful for file ratemin_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/outputlc.o ../../min3p/outputlc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/outputlc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** outputlc === End of Compilation 1 === 1501-510 Compilation successful for file outputlc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_naq.o ../../min3p/mem_naq.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_naq.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_naq === End of Compilation 1 === "../../min3p/mem_naq.F90", 1500-030 (I) INFORMATION: mem_naq: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_naq.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacbvs_energybal.o ../../min3p/jacbvs_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacbvs_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacbvs_energybal === End of Compilation 1 === 1501-510 Compilation successful for file jacbvs_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initppvs.o ../../min3p/initppvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initppvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initppvs === End of Compilation 1 === 1501-510 Compilation successful for file initppvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcpevaporation.o ../../min3p/initcpevaporation.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcpevaporation.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcpevaporation === End of Compilation 1 === 1501-510 Compilation successful for file initcpevaporation.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infcrt_g.o ../../min3p/infcrt_g.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infcrt_g.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcrt_g === End of Compilation 1 === 1501-510 Compilation successful for file infcrt_g.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dtotdyvisc.o ../../min3p/dtotdyvisc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dtotdyvisc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dtotdyvisc === End of Compilation 1 === 1501-510 Compilation successful for file dtotdyvisc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/cvolume.o ../../min3p/cvolume.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/cvolume.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** cvolume === End of Compilation 1 === 1501-510 Compilation successful for file cvolume.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/chrgcorr.o ../../min3p/chrgcorr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/chrgcorr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** chrgcorr === End of Compilation 1 === 1501-510 Compilation successful for file chrgcorr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/velodd.o ../../min3p/velodd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/velodd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** velodd === End of Compilation 1 === 1501-510 Compilation successful for file velodd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updatedd_energybalance.o ../../min3p/updatedd_energybalance.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updatedd_energybalance.F90", line 164.11: 1516-036 (S) Entity isnan has undefined type. "../../min3p/updatedd_energybalance.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updatedd_energybalance === End of Compilation 1 === 1501-511 Compilation failed for file updatedd_energybalance.F90. make: [../../min3p/updatedd_energybalance.o] Error 1 (ignored) mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totredx.o ../../min3p/totredx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totredx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totredx === End of Compilation 1 === 1501-510 Compilation successful for file totredx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/storfs.o ../../min3p/storfs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/storfs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** storfs === End of Compilation 1 === 1501-510 Compilation successful for file storfs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readint_new.o ../../min3p/readint_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readint_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readint_new === End of Compilation 1 === 1501-510 Compilation successful for file readint_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/raoult.o ../../min3p/raoult.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/raoult.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** raoult === End of Compilation 1 === 1501-510 Compilation successful for file raoult.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnmbfls.o ../../min3p/opnmbfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnmbfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnmbfls === End of Compilation 1 === "../../min3p/opnmbfls.F90", 1500-030 (I) INFORMATION: opnmbfls: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file opnmbfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_rt.o ../../min3p/mem_rt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_rt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_rt === End of Compilation 1 === "../../min3p/mem_rt.F90", 1500-030 (I) INFORMATION: mem_rt: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_rt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mbalvs.o ../../min3p/mbalvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mbalvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mbalvs === End of Compilation 1 === 1501-510 Compilation successful for file mbalvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initopgs.o ../../min3p/initopgs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initopgs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initopgs === End of Compilation 1 === 1501-510 Compilation successful for file initopgs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initbcdd.o ../../min3p/initbcdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initbcdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initbcdd === End of Compilation 1 === "../../min3p/initbcdd.F90", 1500-030 (I) INFORMATION: initbcdd: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file initbcdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/iajavs_energybal.o ../../min3p/iajavs_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/iajavs_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** iajavs_energybal === End of Compilation 1 === 1501-510 Compilation successful for file iajavs_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/gasp_m.o ../../gas_advection/gasp_m.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/gasp_m.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasp_m === End of Compilation 1 === 1501-510 Compilation successful for file gasp_m.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/delcmigfunc.o ../../min3p/delcmigfunc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/delcmigfunc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** delcmigfunc === End of Compilation 1 === 1501-510 Compilation successful for file delcmigfunc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/comptotc.o ../../min3p/comptotc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/comptotc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** comptotc === End of Compilation 1 === 1501-510 Compilation successful for file comptotc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtsvmp.o ../../min3p/updtsvmp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtsvmp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtsvmp === End of Compilation 1 === 1501-510 Compilation successful for file updtsvmp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tranunit.o ../../min3p/tranunit.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tranunit.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tranunit === End of Compilation 1 === 1501-510 Compilation successful for file tranunit.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totconc.o ../../min3p/totconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totconc === End of Compilation 1 === 1501-510 Compilation successful for file totconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/sortcomp.o ../../min3p/sortcomp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/sortcomp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** sortcomp === End of Compilation 1 === 1501-510 Compilation successful for file sortcomp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/seepfdd.o ../../min3p/seepfdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/seepfdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** seepfdd === End of Compilation 1 === 1501-510 Compilation successful for file seepfdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readzone.o ../../min3p/readzone.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readzone.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readzone === End of Compilation 1 === 1501-510 Compilation successful for file readzone.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/phcorr.o ../../min3p/phcorr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/phcorr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** phcorr === End of Compilation 1 === 1501-510 Compilation successful for file phcorr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nm.o ../../min3p/mem_nm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nm === End of Compilation 1 === "../../min3p/mem_nm.F90", 1500-030 (I) INFORMATION: mem_nm: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_nm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jaclc.o ../../min3p/jaclc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jaclc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jaclc === End of Compilation 1 === 1501-510 Compilation successful for file jaclc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initweed.o ../../min3p/initweed.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initweed.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initweed === End of Compilation 1 === 1501-510 Compilation successful for file initweed.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcsys.o ../../min3p/initcsys.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcsys.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcsys === End of Compilation 1 === "../../min3p/initcsys.F90", 1500-030 (I) INFORMATION: initcsys: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file initcsys.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infcrtdd.o ../../min3p/infcrtdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infcrtdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcrtdd === End of Compilation 1 === 1501-510 Compilation successful for file infcrtdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/i2upfind.o ../../min3p/i2upfind.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/i2upfind.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** i2upfind === End of Compilation 1 === 1501-510 Compilation successful for file i2upfind.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fsflow.o ../../min3p/fsflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fsflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fsflow === End of Compilation 1 === 1501-510 Compilation successful for file fsflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/findpath.o ../../min3p/findpath.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/findpath.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findpath === End of Compilation 1 === 1501-510 Compilation successful for file findpath.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/evap.o ../../min3p/evap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/evap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** evap === End of Compilation 1 === 1501-510 Compilation successful for file evap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/drategdd.o ../../min3p/drategdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/drategdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** drategdd === End of Compilation 1 === 1501-510 Compilation successful for file drategdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddbdflux_energybal.o ../../min3p/ddbdflux_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddbdflux_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddbdflux_energybal === End of Compilation 1 === 1501-510 Compilation successful for file ddbdflux_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../solver/ws209.o ../../solver/ws209.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../solver/ws209.F90", line 232.13: 1516-036 (S) Entity isnan has undefined type. "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ws209 === End of Compilation 1 === "../../solver/ws209.F90", line 472.18: 1516-036 (S) Entity isnan has undefined type. "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** bicgstab === End of Compilation 2 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** loweruppersolve === End of Compilation 3 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** matrixvectormultiply === End of Compilation 4 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dotproduct === End of Compilation 5 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** idamax1 === End of Compilation 6 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** incompletefactorization === End of Compilation 7 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** symbolicfactorization === End of Compilation 8 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** naturalordering === End of Compilation 9 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rcmordering === End of Compilation 10 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** findperipheralnode === End of Compilation 11 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rootedlevelstructure === End of Compilation 12 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** reversecuthillmckee === End of Compilation 13 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** degree === End of Compilation 14 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** bubblesort === End of Compilation 15 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** binaryfind === End of Compilation 16 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** check === End of Compilation 17 === "../../solver/ws209.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** residual_norm2 === End of Compilation 18 === 1501-511 Compilation failed for file ws209.F90. make: [../../solver/ws209.o] Error 1 (ignored) mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/visconew.o ../../min3p/visconew.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/visconew.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** visconew === End of Compilation 1 === 1501-510 Compilation successful for file visconew.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtbcdd.o ../../min3p/updtbcdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtbcdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtbcdd === End of Compilation 1 === 1501-510 Compilation successful for file updtbcdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/surfcomp.o ../../min3p/surfcomp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/surfcomp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** surfcomp === End of Compilation 1 === 1501-510 Compilation successful for file surfcomp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rstatlc.o ../../min3p/rstatlc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rstatlc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rstatlc === End of Compilation 1 === 1501-510 Compilation successful for file rstatlc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readredx.o ../../min3p/readredx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readredx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readredx === End of Compilation 1 === 1501-510 Compilation successful for file readredx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ratemin.o ../../min3p/ratemin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ratemin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ratemin === End of Compilation 1 === 1501-510 Compilation successful for file ratemin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/outputdd.o ../../min3p/outputdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/outputdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** outputdd === End of Compilation 1 === "../../min3p/outputdd.F90", 1500-030 (I) INFORMATION: outputdd: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file outputdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/msysdd.o ../../min3p/msysdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/msysdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** msysdd === End of Compilation 1 === 1501-510 Compilation successful for file msysdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_mat.o ../../min3p/mem_mat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_mat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_mat === End of Compilation 1 === "../../min3p/mem_mat.F90", 1500-030 (I) INFORMATION: mem_mat: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_mat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacbvs.o ../../min3p/jacbvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacbvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacbvs === End of Compilation 1 === 1501-510 Compilation successful for file jacbvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initpprt.o ../../min3p/initpprt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initpprt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initpprt === End of Compilation 1 === 1501-510 Compilation successful for file initpprt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcpenergybal.o ../../min3p/initcpenergybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcpenergybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcpenergybal === End of Compilation 1 === 1501-510 Compilation successful for file initcpenergybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infcrt_a.o ../../min3p/infcrt_a.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infcrt_a.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcrt_a === End of Compilation 1 === 1501-510 Compilation successful for file infcrt_a.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/giups.o ../../gas_advection/giups.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/giups.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** giups === End of Compilation 1 === 1501-510 Compilation successful for file giups.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/cputime_pc.o ../../min3p/cputime_pc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/cputime_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** cputime === End of Compilation 1 === 1501-510 Compilation successful for file cputime_pc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/velocity_g.o ../../gas_advection/velocity_g.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/velocity_g.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** velocity_g === End of Compilation 1 === 1501-510 Compilation successful for file velocity_g.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updatedd.o ../../min3p/updatedd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updatedd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updatedd === End of Compilation 1 === 1501-510 Compilation successful for file updatedd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totmin.o ../../min3p/totmin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totmin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totmin === End of Compilation 1 === 1501-510 Compilation successful for file totmin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/restart_w.o ../../min3p/restart_w.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/restart_w.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** restart_w === End of Compilation 1 === 1501-510 Compilation successful for file restart_w.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readint.o ../../min3p/readint.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readint.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readint === End of Compilation 1 === 1501-510 Compilation successful for file readint.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/radiation.o ../../min3p/radiation.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/radiation.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** radiation === End of Compilation 1 === 1501-510 Compilation successful for file radiation.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnmbfdd.o ../../min3p/opnmbfdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnmbfdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnmbfdd === End of Compilation 1 === "../../min3p/opnmbfdd.F90", 1500-030 (I) INFORMATION: opnmbfdd: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file opnmbfdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nx.o ../../min3p/mem_nx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nx === End of Compilation 1 === "../../min3p/mem_nx.F90", 1500-030 (I) INFORMATION: mem_nx: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_nx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mbalrt.o ../../min3p/mbalrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mbalrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mbalrt === End of Compilation 1 === 1501-510 Compilation successful for file mbalrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initicvs.o ../../min3p/initicvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initicvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initicvs === End of Compilation 1 === 1501-510 Compilation successful for file initicvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infheat_d.o ../../min3p/infheat_d.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infheat_d.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infheat_d === End of Compilation 1 === 1501-510 Compilation successful for file infheat_d.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/iajavs_dp.o ../../min3p/iajavs_dp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/iajavs_dp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** iajavs_dp === End of Compilation 1 === 1501-510 Compilation successful for file iajavs_dp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/gasp.o ../../gas_advection/gasp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/gasp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasp === End of Compilation 1 === 1501-510 Compilation successful for file gasp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/flux_calc.o ../../min3p/flux_calc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/flux_calc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** flux_calc === End of Compilation 1 === 1501-510 Compilation successful for file flux_calc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddvsflow.o ../../min3p/ddvsflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddvsflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddvsflow === End of Compilation 1 === 1501-510 Compilation successful for file ddvsflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../icesheet/comp_bc_ice_sheet.o ../../icesheet/comp_bc_ice_sheet.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../icesheet/comp_bc_ice_sheet.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** compute_bc_ice_sheet === End of Compilation 1 === 1501-510 Compilation successful for file comp_bc_ice_sheet.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/bdryflux.o ../../min3p/bdryflux.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/bdryflux.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** bdryflux === End of Compilation 1 === 1501-510 Compilation successful for file bdryflux.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/zero_i4_parallel.o ../../min3p/zero_i4_parallel.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/zero_i4_parallel.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** zero_i4_parallel === End of Compilation 1 === 1501-510 Compilation successful for file zero_i4_parallel.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtsvgp.o ../../min3p/updtsvgp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtsvgp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtsvgp === End of Compilation 1 === 1501-510 Compilation successful for file updtsvgp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/trans_evap_info.o ../../min3p/trans_evap_info.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/trans_evap_info.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** trans_evap_info === End of Compilation 1 === 1501-510 Compilation successful for file trans_evap_info.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totcona.o ../../min3p/totcona.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totcona.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totcona === End of Compilation 1 === 1501-510 Compilation successful for file totcona.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/sorbspc.o ../../min3p/sorbspc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/sorbspc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** sorbspc === End of Compilation 1 === "../../min3p/sorbspc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** sorbspc_m === End of Compilation 2 === 1501-510 Compilation successful for file sorbspc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/seepface.o ../../min3p/seepface.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/seepface.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** seepface === End of Compilation 1 === 1501-510 Compilation successful for file seepface.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readtime.o ../../min3p/readtime.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readtime.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readtime === End of Compilation 1 === 1501-510 Compilation successful for file readtime.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/msysvs.o ../../min3p/msysvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/msysvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** msysvs === End of Compilation 1 === 1501-510 Compilation successful for file msysvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_njavs.o ../../min3p/mem_njavs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_njavs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_njavs === End of Compilation 1 === "../../min3p/mem_njavs.F90", 1500-030 (I) INFORMATION: mem_njavs: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_njavs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacfs.o ../../min3p/jacfs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacfs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacfs === End of Compilation 1 === 1501-510 Compilation successful for file jacfs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/inittsgs.o ../../min3p/inittsgs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/inittsgs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** inittsgs === End of Compilation 1 === 1501-510 Compilation successful for file inittsgs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcpvs.o ../../min3p/initcpvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcpvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcpvs === End of Compilation 1 === 1501-510 Compilation successful for file initcpvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/hydrostatic_pitzerdens.o ../../min3p/hydrostatic_pitzerdens.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/hydrostatic_pitzerdens.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** hydrostatic_pitzerdens === End of Compilation 1 === 1501-510 Compilation successful for file hydrostatic_pitzerdens.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/energysys.o ../../min3p/energysys.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/energysys.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** energysys === End of Compilation 1 === 1501-510 Compilation successful for file energysys.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/drategas.o ../../min3p/drategas.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/drategas.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** drategas === End of Compilation 1 === 1501-510 Compilation successful for file drategas.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddbdflux.o ../../min3p/ddbdflux.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddbdflux.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddbdflux === End of Compilation 1 === 1501-510 Compilation successful for file ddbdflux.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtbcatm.o ../../min3p/updtbcatm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtbcatm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtbcatm === End of Compilation 1 === 1501-510 Compilation successful for file updtbcatm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/surf_tens_prop.o ../../min3p/surf_tens_prop.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/surf_tens_prop.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** surf_tens_prop === End of Compilation 1 === 1501-510 Compilation successful for file surf_tens_prop.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rstatgs.o ../../min3p/rstatgs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rstatgs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rstatgs === End of Compilation 1 === 1501-510 Compilation successful for file rstatgs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readminx_new.o ../../min3p/readminx_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readminx_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readminx_new === End of Compilation 1 === 1501-510 Compilation successful for file readminx_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rateint_new.o ../../min3p/rateint_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rateint_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rateint_new === End of Compilation 1 === 1501-510 Compilation successful for file rateint_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opntemp.o ../../min3p/opntemp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opntemp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opntemp === End of Compilation 1 === 1501-510 Compilation successful for file opntemp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/molconc.o ../../min3p/molconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/molconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** molconc === End of Compilation 1 === 1501-510 Compilation successful for file molconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_hmcd.o ../../min3p/mem_hmcd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_hmcd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_hmcd === End of Compilation 1 === 1501-510 Compilation successful for file mem_hmcd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacbrt.o ../../min3p/jacbrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacbrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacbrt === End of Compilation 1 === 1501-510 Compilation successful for file jacbrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initpppm.o ../../min3p/initpppm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initpppm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initpppm === End of Compilation 1 === 1501-510 Compilation successful for file initpppm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcpdd.o ../../min3p/initcpdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcpdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcpdd === End of Compilation 1 === "../../min3p/initcpdd.F90", 1500-030 (I) INFORMATION: initcpdd: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file initcpdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/indextec.o ../../min3p/indextec.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/indextec.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** indextec === End of Compilation 1 === 1501-510 Compilation successful for file indextec.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dtotconc.o ../../min3p/dtotconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dtotconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dtotconc === End of Compilation 1 === 1501-510 Compilation successful for file dtotconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/checksat.o ../../min3p/checksat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/checksat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** checksat === End of Compilation 1 === 1501-510 Compilation successful for file checksat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/velocity_a.o ../../min3p/velocity_a.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/velocity_a.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** velocity_a === End of Compilation 1 === 1501-510 Compilation successful for file velocity_a.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tstepvs.o ../../min3p/tstepvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tstepvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tstepvs === End of Compilation 1 === 1501-510 Compilation successful for file tstepvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totint.o ../../min3p/totint.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totint.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totint === End of Compilation 1 === 1501-510 Compilation successful for file totint.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/restart_r.o ../../min3p/restart_r.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/restart_r.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** restart_r === End of Compilation 1 === 1501-510 Compilation successful for file restart_r.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readgses.o ../../min3p/readgses.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readgses.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readgses === End of Compilation 1 === 1501-510 Compilation successful for file readgses.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opngfls.o ../../min3p/opngfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opngfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opngfls === End of Compilation 1 === 1501-510 Compilation successful for file opngfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_ntmp.o ../../min3p/mem_ntmp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_ntmp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_ntmp === End of Compilation 1 === 1501-510 Compilation successful for file mem_ntmp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mbaldd.o ../../min3p/mbaldd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mbaldd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mbaldd === End of Compilation 1 === 1501-510 Compilation successful for file mbaldd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initicrt.o ../../min3p/initicrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initicrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initicrt === End of Compilation 1 === 1501-510 Compilation successful for file initicrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infheat_c.o ../../min3p/infheat_c.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infheat_c.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infheat_c === End of Compilation 1 === 1501-510 Compilation successful for file infheat_c.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/iajavs.o ../../min3p/iajavs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/iajavs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** iajavs === End of Compilation 1 === 1501-510 Compilation successful for file iajavs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddtds_energybal.o ../../min3p/ddtds_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddtds_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddtds_energybal === End of Compilation 1 === 1501-510 Compilation successful for file ddtds_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/clstpfls.o ../../min3p/clstpfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/clstpfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** clstpfls === End of Compilation 1 === 1501-510 Compilation successful for file clstpfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/batreac.o ../../min3p/batreac.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/batreac.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** batreac === End of Compilation 1 === 1501-510 Compilation successful for file batreac.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtsvap.o ../../min3p/updtsvap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtsvap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtsvap === End of Compilation 1 === 1501-510 Compilation successful for file updtsvap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tranflow.o ../../min3p/tranflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tranflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tranflow === End of Compilation 1 === 1501-510 Compilation successful for file tranflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tortuosity_vap.o ../../min3p/tortuosity_vap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tortuosity_vap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tortuosity_vap === End of Compilation 1 === 1501-510 Compilation successful for file tortuosity_vap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readtemp.o ../../min3p/readtemp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readtemp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readtemp === End of Compilation 1 === 1501-510 Compilation successful for file readtemp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readbcvs.o ../../min3p/readbcvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readbcvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readbcvs === End of Compilation 1 === 1501-510 Compilation successful for file readbcvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/msysrt.o ../../min3p/msysrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/msysrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** msysrt === End of Compilation 1 === 1501-510 Compilation successful for file msysrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_njart.o ../../min3p/mem_njart.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_njart.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_njart === End of Compilation 1 === 1501-510 Compilation successful for file mem_njart.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacddvs.o ../../min3p/jacddvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacddvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacddvs === End of Compilation 1 === 1501-510 Compilation successful for file jacddvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/inittemp.o ../../min3p/inittemp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/inittemp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** inittemp === End of Compilation 1 === 1501-510 Compilation successful for file inittemp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcprt.o ../../min3p/initcprt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcprt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcprt === End of Compilation 1 === 1501-510 Compilation successful for file initcprt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/energy_bal.o ../../min3p/energy_bal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/energy_bal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** energy_bal === End of Compilation 1 === 1501-510 Compilation successful for file energy_bal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/draoult.o ../../min3p/draoult.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/draoult.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** draoult === End of Compilation 1 === 1501-510 Compilation successful for file draoult.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/datstr_n.o ../../min3p/datstr_n.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/datstr_n.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** datstr_n === End of Compilation 1 === 1501-510 Compilation successful for file datstr_n.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updatevs.o ../../min3p/updatevs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updatevs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updatevs === End of Compilation 1 === 1501-510 Compilation successful for file updatevs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tprfrtlc.o ../../min3p/tprfrtlc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tprfrtlc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tprfrtlc === End of Compilation 1 === "../../min3p/tprfrtlc.F90", 1500-030 (I) INFORMATION: tprfrtlc: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file tprfrtlc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/storvs.o ../../min3p/storvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/storvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** storvs === End of Compilation 1 === 1501-510 Compilation successful for file storvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readminx.o ../../min3p/readminx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readminx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readminx === End of Compilation 1 === 1501-510 Compilation successful for file readminx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rateint.o ../../min3p/rateint.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rateint.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rateint === End of Compilation 1 === 1501-510 Compilation successful for file rateint.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnplfls.o ../../min3p/opnplfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnplfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnplfls === End of Compilation 1 === 1501-510 Compilation successful for file opnplfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/modrate.o ../../min3p/modrate.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/modrate.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** modrate === End of Compilation 1 === 1501-510 Compilation successful for file modrate.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_heat.o ../../min3p/mem_heat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_heat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_heat === End of Compilation 1 === "../../min3p/mem_heat.F90", 1500-030 (I) INFORMATION: mem_heat: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_heat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacbevap.o ../../min3p/jacbevap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacbevap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacbevap === End of Compilation 1 === 1501-510 Compilation successful for file jacbevap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initppenergybal.o ../../min3p/initppenergybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initppenergybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initppeb === End of Compilation 1 === 1501-510 Compilation successful for file initppenergybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initbcvs.o ../../min3p/initbcvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initbcvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initbcvs === End of Compilation 1 === 1501-510 Compilation successful for file initbcvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/icrtlczn.o ../../min3p/icrtlczn.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/icrtlczn.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** icrtlczn === End of Compilation 1 === "../../min3p/icrtlczn.F90", 1500-030 (I) INFORMATION: icrtlczn: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file icrtlczn.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/gcreact.o ../../min3p/gcreact.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/gcreact.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gcreact === End of Compilation 1 === 1501-510 Compilation successful for file gcreact.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/driver_pc.o ../../min3p/driver_pc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/driver_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** driver_pc === End of Compilation 1 === 1501-510 Compilation successful for file driver_pc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/constnts.o ../../min3p/constnts.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/constnts.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** constnts === End of Compilation 1 === 1501-510 Compilation successful for file constnts.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/checkerr.o ../../min3p/checkerr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/checkerr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** checkerr === End of Compilation 1 === 1501-510 Compilation successful for file checkerr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/velocity.o ../../min3p/velocity.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/velocity.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** velocity === End of Compilation 1 === 1501-510 Compilation successful for file velocity.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tsteprt.o ../../min3p/tsteprt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tsteprt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tsteprt === End of Compilation 1 === 1501-510 Compilation successful for file tsteprt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totdyvisc.o ../../min3p/totdyvisc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totdyvisc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totdyvisc === End of Compilation 1 === 1501-510 Compilation successful for file totdyvisc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/stedflow.o ../../min3p/stedflow.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/stedflow.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** stedflow === End of Compilation 1 === 1501-510 Compilation successful for file stedflow.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/soilparm.o ../../min3p/soilparm.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/soilparm.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** soilparm === End of Compilation 1 === 1501-510 Compilation successful for file soilparm.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readcomp.o ../../min3p/readcomp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readcomp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readcomp === End of Compilation 1 === 1501-510 Compilation successful for file readcomp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/pitzer/pitzer.o ../../min3p/pitzer/pitzer.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/pitzer/pitzer.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** pitzer === End of Compilation 1 === 1501-510 Compilation successful for file pitzer.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnenergybal.o ../../min3p/opnenergybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnenergybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnenergybal === End of Compilation 1 === 1501-510 Compilation successful for file opnenergybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nsb.o ../../min3p/mem_nsb.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nsb.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nsb === End of Compilation 1 === "../../min3p/mem_nsb.F90", 1500-030 (I) INFORMATION: mem_nsb: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_nsb.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mbal_mcd.o ../../min3p/mbal_mcd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mbal_mcd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mbal_mcd === End of Compilation 1 === 1501-510 Compilation successful for file mbal_mcd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacvs.o ../../min3p/jacvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacvs === End of Compilation 1 === 1501-510 Compilation successful for file jacvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initicenergybal.o ../../min3p/initicenergybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initicenergybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initicenergybal === End of Compilation 1 === 1501-510 Compilation successful for file initicenergybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infevap.o ../../min3p/infevap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infevap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infevap === End of Compilation 1 === 1501-510 Compilation successful for file infevap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/iajart.o ../../min3p/iajart.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/iajart.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** iajart === End of Compilation 1 === 1501-510 Compilation successful for file iajart.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/gasd_m.o ../../gas_advection/gasd_m.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/gasd_m.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasd_m === End of Compilation 1 === 1501-510 Compilation successful for file gasd_m.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/dratemin.o ../../min3p/dratemin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/dratemin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** dratemin === End of Compilation 1 === 1501-510 Compilation successful for file dratemin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/clsgfls.o ../../min3p/clsgfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/clsgfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** clsgfls === End of Compilation 1 === 1501-510 Compilation successful for file clsgfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/atotconc.o ../../min3p/atotconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/atotconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** atotconc === End of Compilation 1 === 1501-510 Compilation successful for file atotconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/xyzcoord.o ../../min3p/xyzcoord.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/xyzcoord.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** xyzcoord === End of Compilation 1 === 1501-510 Compilation successful for file xyzcoord.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/weed.o ../../min3p/weed.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/weed.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** weed === End of Compilation 1 === 1501-510 Compilation successful for file weed.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtsurf.o ../../min3p/updtsurf.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtsurf.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtsurf === End of Compilation 1 === 1501-510 Compilation successful for file updtsurf.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tranbcrt.o ../../min3p/tranbcrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tranbcrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tranbcrt === End of Compilation 1 === 1501-510 Compilation successful for file tranbcrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/timeloop.o ../../min3p/timeloop.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/timeloop.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** timeloop === End of Compilation 1 === 1501-510 Compilation successful for file timeloop.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readsspc.o ../../min3p/readsspc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readsspc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readsspc === End of Compilation 1 === 1501-510 Compilation successful for file readsspc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/reactran.o ../../min3p/reactran.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/reactran.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** reactran === End of Compilation 1 === 1501-510 Compilation successful for file reactran.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/outputvs.o ../../min3p/outputvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/outputvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** outputvs === End of Compilation 1 === 1501-510 Compilation successful for file outputvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_ng.o ../../min3p/mem_ng.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_ng.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_ng === End of Compilation 1 === "../../min3p/mem_ng.F90", 1500-030 (I) INFORMATION: mem_ng: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_ng.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacddfs_energybal.o ../../min3p/jacddfs_energybal.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacddfs_energybal.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacddfs_energybal === End of Compilation 1 === 1501-510 Compilation successful for file jacddfs_energybal.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initsatw.o ../../min3p/initsatw.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initsatw.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initsatw === End of Compilation 1 === 1501-510 Compilation successful for file initsatw.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcplc.o ../../min3p/initcplc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcplc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcplc === End of Compilation 1 === 1501-510 Compilation successful for file initcplc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/guess.o ../../min3p/guess.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/guess.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** guess === End of Compilation 1 === 1501-510 Compilation successful for file guess.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/fluxv_vl.o ../../min3p/fluxv_vl.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/fluxv_vl.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** fluxv_vl === End of Compilation 1 === 1501-510 Compilation successful for file fluxv_vl.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/elecmigration.o ../../min3p/elecmigration.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/elecmigration.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** elecmigration === End of Compilation 1 === 1501-510 Compilation successful for file elecmigration.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/distmp.o ../../min3p/distmp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/distmp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** distmp === End of Compilation 1 === 1501-510 Compilation successful for file distmp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/datstr_1.o ../../min3p/datstr_1.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/datstr_1.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** datstr_1 === End of Compilation 1 === 1501-510 Compilation successful for file datstr_1.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updatert.o ../../min3p/updatert.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updatert.F90", line 181.11: 1516-036 (S) Entity isnan has undefined type. "../../min3p/updatert.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updatert === End of Compilation 1 === 1501-511 Compilation failed for file updatert.F90. make: [../../min3p/updatert.o] Error 1 (ignored) mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tprfdd.o ../../min3p/tprfdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tprfdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tprfdd === End of Compilation 1 === 1501-510 Compilation successful for file tprfdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rootwat.o ../../min3p/rootwat.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rootwat.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rootwat === End of Compilation 1 === 1501-510 Compilation successful for file rootwat.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readmin_new.o ../../min3p/readmin_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readmin_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readmin_new === End of Compilation 1 === 1501-510 Compilation successful for file readmin_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rategasd.o ../../min3p/rategasd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rategasd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rategasd === End of Compilation 1 === 1501-510 Compilation successful for file rategasd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opnpgfls.o ../../min3p/opnpgfls.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opnpgfls.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opnpgfls === End of Compilation 1 === 1501-510 Compilation successful for file opnpgfls.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/minmaxwd.o ../../min3p/minmaxwd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/minmaxwd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** minmaxwd === End of Compilation 1 === 1501-510 Compilation successful for file minmaxwd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_evap.o ../../min3p/mem_evap.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_evap.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_evap === End of Compilation 1 === 1501-510 Compilation successful for file mem_evap.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initppdd.o ../../min3p/initppdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initppdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initppdd === End of Compilation 1 === 1501-510 Compilation successful for file initppdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initbcrt.o ../../min3p/initbcrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initbcrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initbcrt === End of Compilation 1 === "../../min3p/initbcrt.F90", 1500-030 (I) INFORMATION: initbcrt: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file initbcrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/gcconst.o ../../min3p/gcconst.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/gcconst.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gcconst === End of Compilation 1 === 1501-510 Compilation successful for file gcconst.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/draterdx.o ../../min3p/draterdx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/draterdx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** draterdx === End of Compilation 1 === 1501-510 Compilation successful for file draterdx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/vel_lin.o ../../min3p/vel_lin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/vel_lin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** vel_lin1 === End of Compilation 1 === 1501-510 Compilation successful for file vel_lin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tsteplc.o ../../min3p/tsteplc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tsteplc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tsteplc === End of Compilation 1 === 1501-510 Compilation successful for file tsteplc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/totconfac.o ../../min3p/totconfac.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/totconfac.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** totconcfac === End of Compilation 1 === 1501-510 Compilation successful for file totconfac.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/stddmass.o ../../min3p/stddmass.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/stddmass.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** stddmass === End of Compilation 1 === 1501-510 Compilation successful for file stddmass.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/opndbfls_pc.o ../../min3p/opndbfls_pc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/opndbfls_pc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** opndbfls === End of Compilation 1 === 1501-510 Compilation successful for file opndbfls_pc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nr.o ../../min3p/mem_nr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nr === End of Compilation 1 === "../../min3p/mem_nr.F90", 1500-030 (I) INFORMATION: mem_nr: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_nr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacsurf.o ../../min3p/jacsurf.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacsurf.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacsurf === End of Compilation 1 === 1501-510 Compilation successful for file jacsurf.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initicdd.o ../../min3p/initicdd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initicdd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initicdd === End of Compilation 1 === 1501-510 Compilation successful for file initicdd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../gas_advection/infcvs_cp.o ../../gas_advection/infcvs_cp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../gas_advection/infcvs_cp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcvs_cp === End of Compilation 1 === 1501-510 Compilation successful for file infcvs_cp.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/iajabl.o ../../min3p/iajabl.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/iajabl.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** iajabl === End of Compilation 1 === 1501-510 Compilation successful for file iajabl.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/gasconc.o ../../min3p/gasconc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/gasconc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** gasconc === End of Compilation 1 === 1501-510 Compilation successful for file gasconc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/drateint_new.o ../../min3p/drateint_new.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/drateint_new.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** drateint_new === End of Compilation 1 === 1501-510 Compilation successful for file drateint_new.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/ddtds.o ../../min3p/ddtds.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/ddtds.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** ddtds === End of Compilation 1 === 1501-510 Compilation successful for file ddtds.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/pitzer/closepitzer.o ../../min3p/pitzer/closepitzer.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/pitzer/closepitzer.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** closepitzer === End of Compilation 1 === 1501-510 Compilation successful for file closepitzer.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/aratemin.o ../../min3p/aratemin.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/aratemin.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** aratemin === End of Compilation 1 === 1501-510 Compilation successful for file aratemin.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/updtsoil.o ../../min3p/updtsoil.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/updtsoil.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** updtsoil === End of Compilation 1 === 1501-510 Compilation successful for file updtsoil.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tprfvs.o ../../min3p/tprfvs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tprfvs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tprfvs === End of Compilation 1 === 1501-510 Compilation successful for file tprfvs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/tcorr.o ../../min3p/tcorr.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/tcorr.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** tcorr === End of Compilation 1 === 1501-510 Compilation successful for file tcorr.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/readsorb.o ../../min3p/readsorb.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/readsorb.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** readsorb === End of Compilation 1 === 1501-510 Compilation successful for file readsorb.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/rateredx.o ../../min3p/rateredx.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/rateredx.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** rateredx === End of Compilation 1 === 1501-510 Compilation successful for file rateredx.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/outputrt.o ../../min3p/outputrt.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/outputrt.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** outputrt === End of Compilation 1 === "../../min3p/outputrt.F90", 1500-030 (I) INFORMATION: outputrt: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file outputrt.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/mem_nc.o ../../min3p/mem_nc.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/mem_nc.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** mem_nc === End of Compilation 1 === "../../min3p/mem_nc.F90", 1500-030 (I) INFORMATION: mem_nc: Additional optimization may be attained by recompiling and specifying MAXMEM option with a value greater than 8192. 1501-510 Compilation successful for file mem_nc.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/jacddfs.o ../../min3p/jacddfs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/jacddfs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** jacddfs === End of Compilation 1 === 1501-510 Compilation successful for file jacddfs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initprob.o ../../min3p/initprob.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initprob.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initprob === End of Compilation 1 === 1501-510 Compilation successful for file initprob.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/initcpgs.o ../../min3p/initcpgs.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/initcpgs.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** initcpgs === End of Compilation 1 === 1501-510 Compilation successful for file initcpgs.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/infcrt_mcd.o ../../min3p/infcrt_mcd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/infcrt_mcd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** infcrt_mcd === End of Compilation 1 === 1501-510 Compilation successful for file infcrt_mcd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/diffcoff_mcd.o ../../min3p/diffcoff_mcd.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/diffcoff_mcd.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** diffcoff_mcd === End of Compilation 1 === 1501-510 Compilation successful for file diffcoff_mcd.F90. mpif90 -c -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/include -I/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/include -I/bgsys/drivers/V1R2M1/ppc64/comm/include -I/bgsys/drivers/V1R2M1/ppc64/comm/lib/gnu -I/bgsys/drivers/V1R2M1/ppc64 -I/bgsys/drivers/V1R2M1/ppc64/comm/sys/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include -I/bgsys/drivers/V1R2M1/ppc64/spi/include/kernel/cnk -DLINUX -DRELEASE -DRELEASE_X64 -DSTANDARD_FORTRAN -DPETSC -DMPI -DPETSC_V3_5_X -o ../../min3p/cliqdisp.o ../../min3p/cliqdisp.F90 /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-214 (W) command option M reserved for future use - ignored /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-257 (W) Option P is not recognized. Option will be ignored. "../../min3p/cliqdisp.F90", 1520-031 (W) Option DLINES is ignored within Fortran 90 free form and IBM free form. ** cliqdisp === End of Compilation 1 === 1501-510 Compilation successful for file cliqdisp.F90. mpif90 -Wall -Wno-unused-variable -ffree-line-length-0 -g -O2 -WF,-DLINUX -WF,-DRELEASE -WF,-DRELEASE_X64 -WF,-DSTANDARD_FORTRAN -WF,-DPETSC -WF,-DMPI -WF,-DPETSC_V3_5_X -o min3p_thcm ./../../min3p/totsorb.o ./../../min3p/storheat.o ./../../min3p/rhsvs.o ./../../min3p/fluxdd.o ./../../min3p/relperm_ovendry.o ./../../min3p/int3a_ovendry.o ./../../min3p/g_ovendry.o ./../../min3p/findstrg.o ./../../min3p/alkcalc.o ./../../gas_advection/giups_brt.o ./../../min3p/fluxheat.o ./../../min3p/diffcoff.o ./../../min3p/rhsrt.o ./../../min3p/int_h_ovendry.o ./../../min3p/fluxd.o ./../../min3p/bulkconc.o ./../../min3p/zero_r8.o ./../../min3p/acoff.o ./../../min3p/dtotcong.o ./../../min3p/diff_vapour.o ./../../min3p/storddfs.o ./../../min3p/int3b_ovendry.o ./../../min3p/readbloc.o ./../../min3p/fluxvs.o ./../../min3p/findname.o ./../../min3p/vhoff.o ./../../min3p/dhconst.o ./../../min3p/cos_function.o ./../../min3p/stordd.o ./../../min3p/soilprdd.o ./../../min3p/porosity_flow.o ./../../phase_class/tools/lubksb.o ./../../gas_advection/gasm.o ./../../min3p/zero_i4.o ./../../min3p/secspec.o ./../../min3p/h_ovendry.o ./../../gas_advection/fluxvg.o ./../../min3p/findkey.o ./../../gas_advection/wgpropd.o ./../../min3p/rsort.o ./../../gas_advection/relpfsat_g.o ./../../min3p/ddtds_1.o ./../../min3p/satindex.o ./../../gas_advection/wgprop.o ./../../min3p/storheatevap.o ./../../min3p/ionstr.o ./../../min3p/icnvrt.o ./../../min3p/fluxfs.o ./../../gas_advection/dfluxvg.o ./../../min3p/concsort.o ./../../min3p/zoutput.o ./../../min3p/simq.o ./../../min3p/relpfsat.o ./../../min3p/findzone.o ./../../min3p/xh_ovendry.o ./../../min3p/w_ovendry.o ./../../min3p/satfpres.o ./../../min3p/gs_ovendry.o ./../../min3p/fluxv.o ./../../min3p/darcy_energybal.o ./../../phase_class/tools/xmlreader/m_charset.o ./../../solver/petsc_mpi_common.o ./../../min3p/parm.o ./../../phase_class/tools/xmlreader/m_debug.o ./../../version/Version.o ./../../solver/solver_snes_common.o ./../../phase_class/constants/m_constants_cheproo.o ./../../min3p/dens.o ./../../icesheet/m_ice_sheet.o ./../../min3p/multidiff.o ./../../phase_class/tools/xmlreader/m_buffer.o ./../../energy_balance/m_heat_transport.o ./../../phase_class/tools/xmlreader/m_dictionary.o ./../../version/writeversion.o ./../../phase_class/tools/xmlreader/m_io.o ./../../min3p/gen.o ./../../solver/solver_snes_interface.o ./../../phase_class/tools/xmlreader/m_reader.o ./../../phase_class/tools/m_general_tools_cheproo.o ./../../solver/solver_snes_function.o ./../../phase_class/tools/xmlreader/m_converters.o ./../../min3p/file_utility.o ./../../min3p/phys.o ./../../solver/matrix_utility.o ./../../min3p/dual.o ./../../phase_class/tools/xmlreader/m_entities.o ./../../solver/solver_runtime.o ./../../phase_class/tools/xmlreader/m_elstack.o ./../../solver/solver_results.o ./../../solver/solver_pardiso.o ./../../solver/solver_ddmethod.o ./../../phase_class/tools/xmlreader/m_fsm.o ./../../phase_class/tools/xmlreader/m_xml_error.o ./../../phase_class/tools/xmlreader/m_xml_parser.o ./../../phase_class/tools/xmlreader/flib_sax.o ./../../phase_class/tools/xpath/m_path.o ./../../phase_class/tools/xmlreader/m_handlers.o ./../../phase_class/tools/xpath/flib_xpath.o ./../../phase_class/species/m_species.o ./../../phase_class/phase/m_parentphase.o ./../../phase_class/phase/m_parentaqueousphase.o ./../../phase_class/phase/m_aqueousphasepitzer.o ./../../phase_class/phase/m_aqueousphaseideal.o ./../../phase_class/phase/m_aqueousphasedavis.o ./../../phase_class/phase/m_aqueousphasebdot.o ./../../phase_class/phase/m_aqueousphase.o ./../../phase_class/phase/m_phase.o ./../../min3p/chem.o ./../../solver/solver.o ./../../min3p/welcome_pc.o ./../../min3p/velovapour.o ./../../min3p/updatelc.o ./../../min3p/readmin.o ./../../min3p/rategas.o ./../../min3p/opnmbfls_mcd.o ./../../min3p/mem_vs.o ./../../min3p/mem_dd.o ./../../min3p/intpolt.o ./../../min3p/pitzer/initpitzer_pc.o ./../../min3p/initbcenergybal.o ./../../min3p/icbcrt.o ./../../gas_advection/gasv.o ./../../min3p/dratemin_new.o ./../../min3p/compute_sensible.o ./../../min3p/cbalance.o ./../../min3p/zero_r8_parallel.o ./../../min3p/vapor_prop.o ./../../min3p/trddflow.o ./../../min3p/totconcg.o ./../../min3p/sptldisc.o ./../../min3p/setsize.o ./../../min3p/phpe.o ./../../min3p/nexttime.o ./../../min3p/mem_nmx.o ./../../min3p/jacrt.o ./../../min3p/initgeom.o ./../../min3p/infcvs.o ./../../min3p/i2upfind_heat.o ./../../min3p/drateint.o ./../../min3p/ddfsflow.o ./../../min3p/vsflow.o ./../../min3p/updtbcvs.o ./../../min3p/rtrvpprm.o ./../../min3p/readredx_new.o ./../../min3p/ratemin_new.o ./../../min3p/outputlc.o ./../../min3p/mem_naq.o ./../../min3p/jacbvs_energybal.o ./../../min3p/initppvs.o ./../../min3p/initcpevaporation.o ./../../min3p/infcrt_g.o ./../../min3p/dtotdyvisc.o ./../../min3p/cvolume.o ./../../min3p/chrgcorr.o ./../../min3p/velodd.o ./../../min3p/updatedd_energybalance.o ./../../min3p/totredx.o ./../../min3p/storfs.o ./../../min3p/readint_new.o ./../../min3p/raoult.o ./../../min3p/opnmbfls.o ./../../min3p/mem_rt.o ./../../min3p/mbalvs.o ./../../min3p/initopgs.o ./../../min3p/initbcdd.o ./../../min3p/iajavs_energybal.o ./../../gas_advection/gasp_m.o ./../../min3p/delcmigfunc.o ./../../min3p/comptotc.o ./../../min3p/updtsvmp.o ./../../min3p/tranunit.o ./../../min3p/totconc.o ./../../min3p/sortcomp.o ./../../min3p/seepfdd.o ./../../min3p/readzone.o ./../../min3p/phcorr.o ./../../min3p/mem_nm.o ./../../min3p/jaclc.o ./../../min3p/initweed.o ./../../min3p/initcsys.o ./../../min3p/infcrtdd.o ./../../min3p/i2upfind.o ./../../min3p/fsflow.o ./../../min3p/findpath.o ./../../min3p/evap.o ./../../min3p/drategdd.o ./../../min3p/ddbdflux_energybal.o ./../../solver/ws209.o ./../../min3p/visconew.o ./../../min3p/updtbcdd.o ./../../min3p/surfcomp.o ./../../min3p/rstatlc.o ./../../min3p/readredx.o ./../../min3p/ratemin.o ./../../min3p/outputdd.o ./../../min3p/msysdd.o ./../../min3p/mem_mat.o ./../../min3p/jacbvs.o ./../../min3p/initpprt.o ./../../min3p/initcpenergybal.o ./../../min3p/infcrt_a.o ./../../gas_advection/giups.o ./../../min3p/cputime_pc.o ./../../gas_advection/velocity_g.o ./../../min3p/updatedd.o ./../../min3p/totmin.o ./../../min3p/restart_w.o ./../../min3p/readint.o ./../../min3p/radiation.o ./../../min3p/opnmbfdd.o ./../../min3p/mem_nx.o ./../../min3p/mbalrt.o ./../../min3p/initicvs.o ./../../min3p/infheat_d.o ./../../min3p/iajavs_dp.o ./../../gas_advection/gasp.o ./../../min3p/flux_calc.o ./../../min3p/ddvsflow.o ./../../icesheet/comp_bc_ice_sheet.o ./../../min3p/bdryflux.o ./../../min3p/zero_i4_parallel.o ./../../min3p/updtsvgp.o ./../../min3p/trans_evap_info.o ./../../min3p/totcona.o ./../../min3p/sorbspc.o ./../../min3p/seepface.o ./../../min3p/readtime.o ./../../min3p/msysvs.o ./../../min3p/mem_njavs.o ./../../min3p/jacfs.o ./../../min3p/inittsgs.o ./../../min3p/initcpvs.o ./../../min3p/hydrostatic_pitzerdens.o ./../../min3p/energysys.o ./../../min3p/drategas.o ./../../min3p/ddbdflux.o ./../../min3p/updtbcatm.o ./../../min3p/surf_tens_prop.o ./../../min3p/rstatgs.o ./../../min3p/readminx_new.o ./../../min3p/rateint_new.o ./../../min3p/opntemp.o ./../../min3p/molconc.o ./../../min3p/mem_hmcd.o ./../../min3p/jacbrt.o ./../../min3p/initpppm.o ./../../min3p/initcpdd.o ./../../min3p/indextec.o ./../../min3p/dtotconc.o ./../../min3p/checksat.o ./../../min3p/velocity_a.o ./../../min3p/tstepvs.o ./../../min3p/totint.o ./../../min3p/restart_r.o ./../../min3p/readgses.o ./../../min3p/opngfls.o ./../../min3p/mem_ntmp.o ./../../min3p/mbaldd.o ./../../min3p/initicrt.o ./../../min3p/infheat_c.o ./../../min3p/iajavs.o ./../../min3p/ddtds_energybal.o ./../../min3p/clstpfls.o ./../../min3p/batreac.o ./../../min3p/updtsvap.o ./../../min3p/tranflow.o ./../../min3p/tortuosity_vap.o ./../../min3p/readtemp.o ./../../min3p/readbcvs.o ./../../min3p/msysrt.o ./../../min3p/mem_njart.o ./../../min3p/jacddvs.o ./../../min3p/inittemp.o ./../../min3p/initcprt.o ./../../min3p/energy_bal.o ./../../min3p/draoult.o ./../../min3p/datstr_n.o ./../../min3p/updatevs.o ./../../min3p/tprfrtlc.o ./../../min3p/storvs.o ./../../min3p/readminx.o ./../../min3p/rateint.o ./../../min3p/opnplfls.o ./../../min3p/modrate.o ./../../min3p/mem_heat.o ./../../min3p/jacbevap.o ./../../min3p/initppenergybal.o ./../../min3p/initbcvs.o ./../../min3p/icrtlczn.o ./../../min3p/gcreact.o ./../../min3p/driver_pc.o ./../../min3p/constnts.o ./../../min3p/checkerr.o ./../../min3p/velocity.o ./../../min3p/tsteprt.o ./../../min3p/totdyvisc.o ./../../min3p/stedflow.o ./../../min3p/soilparm.o ./../../min3p/readcomp.o ./../../min3p/pitzer/pitzer.o ./../../min3p/opnenergybal.o ./../../min3p/mem_nsb.o ./../../min3p/mbal_mcd.o ./../../min3p/jacvs.o ./../../min3p/initicenergybal.o ./../../min3p/infevap.o ./../../min3p/iajart.o ./../../gas_advection/gasd_m.o ./../../min3p/dratemin.o ./../../min3p/clsgfls.o ./../../min3p/atotconc.o ./../../min3p/xyzcoord.o ./../../min3p/weed.o ./../../min3p/updtsurf.o ./../../min3p/tranbcrt.o ./../../min3p/timeloop.o ./../../min3p/readsspc.o ./../../min3p/reactran.o ./../../min3p/outputvs.o ./../../min3p/mem_ng.o ./../../min3p/jacddfs_energybal.o ./../../min3p/initsatw.o ./../../min3p/initcplc.o ./../../min3p/guess.o ./../../min3p/fluxv_vl.o ./../../min3p/elecmigration.o ./../../min3p/distmp.o ./../../min3p/datstr_1.o ./../../min3p/updatert.o ./../../min3p/tprfdd.o ./../../min3p/rootwat.o ./../../min3p/readmin_new.o ./../../min3p/rategasd.o ./../../min3p/opnpgfls.o ./../../min3p/minmaxwd.o ./../../min3p/mem_evap.o ./../../min3p/initppdd.o ./../../min3p/initbcrt.o ./../../min3p/gcconst.o ./../../min3p/draterdx.o ./../../min3p/vel_lin.o ./../../min3p/tsteplc.o ./../../min3p/totconfac.o ./../../min3p/stddmass.o ./../../min3p/opndbfls_pc.o ./../../min3p/mem_nr.o ./../../min3p/jacsurf.o ./../../min3p/initicdd.o ./../../gas_advection/infcvs_cp.o ./../../min3p/iajabl.o ./../../min3p/gasconc.o ./../../min3p/drateint_new.o ./../../min3p/ddtds.o ./../../min3p/pitzer/closepitzer.o ./../../min3p/aratemin.o ./../../min3p/updtsoil.o ./../../min3p/tprfvs.o ./../../min3p/tcorr.o ./../../min3p/readsorb.o ./../../min3p/rateredx.o ./../../min3p/outputrt.o ./../../min3p/mem_nc.o ./../../min3p/jacddfs.o ./../../min3p/initprob.o ./../../min3p/initcpgs.o ./../../min3p/infcrt_mcd.o ./../../min3p/diffcoff_mcd.o ./../../min3p/cliqdisp.o -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lpetsc -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/superlu/dist-3.3/linux-rhel_6-ppc64-gcc-4.4.6/lib -lsuperlu -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/hypre/2.9.2a/linux-rhel_6-ppc64-gcc-4.4.6/lib -lHYPRE -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/lib64 -L/bgsys/drivers/V1R2M1/ppc64/spi/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/sys/lib -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/lib/gcc/powerpc64-bgq-linux/4.4.7 -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/lib/gcc -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/powerpc64-bgq-linux/lib -lmpichcxx-gcc -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/ml/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lml -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/lib -lparmetis -lmetis -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/lapack/3.5.0/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/lapack/3.5.0/linux-rhel_6-ppc64-gcc-4.4.6/lib -llapack -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/blas/19Apr11/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/blas/19Apr11/linux-rhel_6-ppc64-gcc-4.4.6/lib -lblas -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/zoltan/trilinos-11.8.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lzoltan -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/parmetis/4.0.3/linux-rhel_6-ppc64-gcc-4.4.6/lib -lparmetis -lmetis -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lchaco -lpthread -lexoIIv2for -lexodus -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/moab/4.7.0RC1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lMOAB -L/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/cgma/13.1.1/linux-rhel_6-ppc64-gcc-4.4.6/lib -lcgm -lzoltan -lparmetis -lmetis -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/install/netcdf/4.3.0/linux-rhel_6-ppc64-gcc-4.4.6/lib -lnetcdf -Wl,-rpath,/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/lib -L/gpfs/vesta-fs0/projects/FASTMath/install/hdf5/1.8.11/linux-rhel_6-ppc64-gcc-4.4.6/lib -lhdf5_hl -lhdf5 -lm -lmpichf90-gcc -lgfortran -lm -lmpichcxx-gcc -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/lib64 -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/V1R2M1/ppc64/spi/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/sys/lib -L/bgsys/drivers/V1R2M1/ppc64/spi/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/sys/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/lib64 -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/V1R2M1/ppc64/spi/lib -L/bgsys/drivers/V1R2M1/ppc64/comm/lib -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/lib/gcc/powerpc64-bgq-linux/4.4.7 -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/lib/gcc -L/bgsys/drivers/toolchain/V1R2M2_base/gnu-linux/powerpc64-bgq-linux/lib -ldl -lmpich-gcc -lopa-gcc -lmpl-gcc -lpami-gcc -lSPI -lSPI_cnk -lrt -lpthread -lstdc++ -lgcc_eh -lnss_files -lnss_dns -lresolv -ldl /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wall was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-289 (W) Option -Wno-unused-variable was incorrectly specified. The option will be ignored. /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-228 (W) input file ./../../min3p/welcome_pc.o not found /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-228 (W) input file ./../../min3p/updatedd_energybalance.o not found /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-228 (W) input file ./../../solver/ws209.o not found /soft/compilers/ibmcmp-may2014/xlf/bg/14.1/bin/.orig/bgxlf90_r: 1501-228 (W) input file ./../../min3p/updatert.o not found make: [min3p_ibmxl] Error 252 (ignored) /bin/rm -f ./../../*.o ./../../energy_balance/*.o ./../../icesheet/*.o ./../../min3p/*.o /bin/rm -f ./../../min3p/pitzer/*.o ./../../phase_class/constants/*.o /bin/rm -f ./../../phase_class/phase/*.o ./../../phase_class/species/*.o /bin/rm -f ./../../phase_class/tools/*.o ./../../phase_class/tools/xmlreader/*.o /bin/rm -f ./../../phase_class/tools/xpath/*.o ./../../version/*.o /bin/rm -f ./../../solver/*.o ./../../solver/cond_number/*.o ./../../gas_advection/*.o *.o /bin/rm -f ./../../*.mod ./../../energy_balance/*.mod ./../../icesheet/*.mod ./../../min3p/*.mod /bin/rm -f ./../../min3p/pitzer/*.mod ./../../phase_class/constants/*.mod /bin/rm -f ./../../phase_class/phase/*.mod ./../../phase_class/species/*.mod /bin/rm -f ./../../phase_class/tools/*.mod ./../../phase_class/tools/xmlreader/*.mod /bin/rm -f ./../../phase_class/tools/xpath/*.mod ./../../version/*.mod /bin/rm -f ./../../solver/*.mod ./../../solver/cond_number/*.mod ./../../gas_advection/*.mod *.mod From balay at mcs.anl.gov Tue Aug 12 23:41:59 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Tue, 12 Aug 2014 23:41:59 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: You appear to use: PETSC_DIR=/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/ This is built with gnu compilers - and can't be used from xl compilers. [i.e use it with +mpiwrapper-gcc] Satish On Tue, 12 Aug 2014, Danyang Su wrote: > Hi Satish, > > The log file is attached. > > There are errors like below: > > "../../min3p/welcome_pc.F90", line 151.16: 1516-036 (S) Entity iargc has > undefined type. > "../../min3p/welcome_pc.F90", 1520-031 (W) Option DLINES is ignored within > Fortran 90 free form and IBM free form. > ** welcome === End of Compilation 1 === > > I use preprocessor definition so as to exclude these non-standard fortran > calling like iargc. > > Thanks, > > Danyang > > > On Tue, Aug 12, 2014 at 11:11 PM, Satish Balay wrote: > > > On Tue, 12 Aug 2014, Danyang Su wrote: > > > > > On Tue, Aug 12, 2014 at 10:46 PM, Satish Balay > > wrote: > > > > > > I don't understand. Doesn't the following work? What compile commands > > does > > > > make invoke with it? > > > > > > > Yes, the following doesn't work. I just use "make example &> log.txt" to > > > compile it. From the log file, it shows that the FPP FLAGS are not > > > recongised. > > > The machine is Vesta and I have add +mpiwrapper-xl to .soft file and > > > resoft it. > > > > I wanted to see the contents of log.text. Anyway - here is how it > > works on vesta.. > > > > Satish > > > > ----------- > > > > [balay at vestalac1 test]$ ls > > ex1f.F makefile > > [balay at vestalac1 test]$ cat makefile > > CFLAGS = > > FFLAGS = > > CPPFLAGS = > > FPPFLAGS = -WF,-DDUMMY_FLAG > > CLEANFILES = > > > > include ${PETSC_DIR}/conf/variables > > include ${PETSC_DIR}/conf/rules > > > > ex1f: ex1f.o chkopts > > -${FLINKER} -o ex1f ex1f.o ${PETSC_KSP_LIB} > > ${RM} ex1f.o > > > > [balay at vestalac1 test]$ make ex1f > > mpixlf77_r -qnosave -c -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict > > -qstrict_induction -I/soft/libraries/petsc/3.4.4/xl-opt/include > > -I/soft/libraries/petsc/3.4.4/xl-opt/include -WF,-DDUMMY_FLAG -o ex1f.o > > ex1f.F > > ** main === End of Compilation 1 === > > 1501-510 Compilation successful for file ex1f.F. > > mpixlf77_r -qnosave -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict > > -qstrict_induction -o ex1f ex1f.o > > -L/soft/libraries/petsc/3.4.4/xl-opt/lib -lpetsc > > -Wl,-rpath,/soft/libraries/petsc/3.4.4/xl-opt/lib -lcmumps -ldmumps > > -lsmumps -lzmumps -lmumps_common -lpord > > -Wl,-rpath,/soft/libraries/alcf/current/xl/SCALAPACK/lib > > -L/soft/libraries/alcf/current/xl/SCALAPACK/lib -lscalapack -lsuperlu_4.3 > > -lsuperlu_dist_3.3 -lHYPRE -lspai -lumfpack -lamd > > -L/soft/libraries/alcf/current/xl/LAPACK/lib -llapack > > -L/soft/libraries/alcf/current/xl/BLAS/lib -lblas -ltriangle -lchaco > > -lparmetis -lmetis -lpthread -ldl -lmpichcxx-gcc -lmpichf77-gcc > > -L/soft/compilers/ibmcmp-nov2013/vacpp/bg/12.1/bglib64 -libmc++ > > -L/soft/compilers/ibmcmp-nov2013/xlf/bg/14.1/bglib64 -lxlf90_r -lxlomp_ser > > -lxlfmath > > /bin/rm -f ex1f.o > > [balay at vestalac1 test]$ > > > > > From danyang.su at gmail.com Wed Aug 13 00:10:34 2014 From: danyang.su at gmail.com (Danyang Su) Date: Wed, 13 Aug 2014 00:10:34 -0500 Subject: [petsc-users] Preprocessor definition in makefile for IBM XL Fortran Compiler In-Reply-To: References: Message-ID: On Tue, Aug 12, 2014 at 11:41 PM, Satish Balay wrote: > You appear to use: > PETSC_DIR=/gpfs/vesta-fs0/projects/FASTMath/ATPESC-2014/install/petsc/ > 3.5.1.1/linux-rhel_6-ppc64-gcc-4.4.6/ > > This is built with gnu compilers - and can't be used from xl compilers. > [i.e use it with +mpiwrapper-gcc] > Yes, with +mpiwrapper-gcc, the codes can be compiled successfully. Thanks. > > Satish > > On Tue, 12 Aug 2014, Danyang Su wrote: > > > Hi Satish, > > > > The log file is attached. > > > > There are errors like below: > > > > "../../min3p/welcome_pc.F90", line 151.16: 1516-036 (S) Entity iargc has > > undefined type. > > "../../min3p/welcome_pc.F90", 1520-031 (W) Option DLINES is ignored > within > > Fortran 90 free form and IBM free form. > > ** welcome === End of Compilation 1 === > > > > I use preprocessor definition so as to exclude these non-standard fortran > > calling like iargc. > > > > Thanks, > > > > Danyang > > > > > > On Tue, Aug 12, 2014 at 11:11 PM, Satish Balay > wrote: > > > > > On Tue, 12 Aug 2014, Danyang Su wrote: > > > > > > > On Tue, Aug 12, 2014 at 10:46 PM, Satish Balay > > > wrote: > > > > > > > > I don't understand. Doesn't the following work? What compile > commands > > > does > > > > > make invoke with it? > > > > > > > > > Yes, the following doesn't work. I just use "make example &> > log.txt" to > > > > compile it. From the log file, it shows that the FPP FLAGS are not > > > > recongised. > > > > The machine is Vesta and I have add +mpiwrapper-xl to .soft file and > > > > resoft it. > > > > > > I wanted to see the contents of log.text. Anyway - here is how it > > > works on vesta.. > > > > > > Satish > > > > > > ----------- > > > > > > [balay at vestalac1 test]$ ls > > > ex1f.F makefile > > > [balay at vestalac1 test]$ cat makefile > > > CFLAGS = > > > FFLAGS = > > > CPPFLAGS = > > > FPPFLAGS = -WF,-DDUMMY_FLAG > > > CLEANFILES = > > > > > > include ${PETSC_DIR}/conf/variables > > > include ${PETSC_DIR}/conf/rules > > > > > > ex1f: ex1f.o chkopts > > > -${FLINKER} -o ex1f ex1f.o ${PETSC_KSP_LIB} > > > ${RM} ex1f.o > > > > > > [balay at vestalac1 test]$ make ex1f > > > mpixlf77_r -qnosave -c -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 > -qstrict > > > -qstrict_induction -I/soft/libraries/petsc/3.4.4/xl-opt/include > > > -I/soft/libraries/petsc/3.4.4/xl-opt/include -WF,-DDUMMY_FLAG -o > ex1f.o > > > ex1f.F > > > ** main === End of Compilation 1 === > > > 1501-510 Compilation successful for file ex1f.F. > > > mpixlf77_r -qnosave -O3 -qhot=level=0 -qsimd=auto -qmaxmem=-1 -qstrict > > > -qstrict_induction -o ex1f ex1f.o > > > -L/soft/libraries/petsc/3.4.4/xl-opt/lib -lpetsc > > > -Wl,-rpath,/soft/libraries/petsc/3.4.4/xl-opt/lib -lcmumps -ldmumps > > > -lsmumps -lzmumps -lmumps_common -lpord > > > -Wl,-rpath,/soft/libraries/alcf/current/xl/SCALAPACK/lib > > > -L/soft/libraries/alcf/current/xl/SCALAPACK/lib -lscalapack > -lsuperlu_4.3 > > > -lsuperlu_dist_3.3 -lHYPRE -lspai -lumfpack -lamd > > > -L/soft/libraries/alcf/current/xl/LAPACK/lib -llapack > > > -L/soft/libraries/alcf/current/xl/BLAS/lib -lblas -ltriangle -lchaco > > > -lparmetis -lmetis -lpthread -ldl -lmpichcxx-gcc -lmpichf77-gcc > > > -L/soft/compilers/ibmcmp-nov2013/vacpp/bg/12.1/bglib64 -libmc++ > > > -L/soft/compilers/ibmcmp-nov2013/xlf/bg/14.1/bglib64 -lxlf90_r > -lxlomp_ser > > > -lxlfmath > > > /bin/rm -f ex1f.o > > > [balay at vestalac1 test]$ > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Wed Aug 13 00:11:16 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Wed, 13 Aug 2014 00:11:16 -0500 Subject: [petsc-users] slepc external matrix-vector product subroutine In-Reply-To: <53EAE959.1060302@pitt.edu> References: <53EAE959.1060302@pitt.edu> Message-ID: On Tue, 12 Aug 2014, Tijo Vazhappilly wrote: > Hi Balay, > > I am a new user to Slepc. Is there any option to give a external matrix-vector > subroutine to Slepc program or include with in the Slepc code. check MatShell in petsc http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MATSHELL.html > > Our matrix is symmetric and very sparse (DVR basis) for the eigenvalue > problem. It is a 3dimensional matrix and in the current implementation, > the full > matrix is not constructed for the diagonalization. We are using arpack in our > current code. > > My test slepc program takes a lot of time as expected by building the full > matrix. It wasn't clear from the manual or examples about other options. perhaps the matrix was not preallocated correctly. http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatSeqAIJSetPreallocation.html > Thank you for your time. > > Best, > Tijo > > ps: If you want I could post this to the slepc mailing list. cc:ing list. thats the better location to discuss issues. Satish From jroman at dsic.upv.es Wed Aug 13 02:04:50 2014 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 13 Aug 2014 09:04:50 +0200 Subject: [petsc-users] slepc external matrix-vector product subroutine In-Reply-To: References: <53EAE959.1060302@pitt.edu> Message-ID: There are several examples in the SLEPc distribution that use shell matrices. http://www.grycap.upv.es/slepc/documentation/current/src/eps/examples/tutorials/ex3.c.html http://www.grycap.upv.es/slepc/documentation/current/src/eps/examples/tutorials/ex9.c.html http://www.grycap.upv.es/slepc/documentation/current/src/eps/examples/tutorials/ex6f.F.html See also section 8.2 of the users guide. Jose El 13/08/2014, a las 07:11, Satish Balay escribi?: > On Tue, 12 Aug 2014, Tijo Vazhappilly wrote: > >> Hi Balay, >> >> I am a new user to Slepc. Is there any option to give a external matrix-vector >> subroutine to Slepc program or include with in the Slepc code. > > check MatShell in petsc > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MATSHELL.html > >> >> Our matrix is symmetric and very sparse (DVR basis) for the eigenvalue >> problem. It is a 3dimensional matrix and in the current implementation, >> the full >> matrix is not constructed for the diagonalization. We are using arpack in our >> current code. >> >> My test slepc program takes a lot of time as expected by building the full >> matrix. It wasn't clear from the manual or examples about other options. > > perhaps the matrix was not preallocated correctly. > > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatSeqAIJSetPreallocation.html > >> Thank you for your time. >> >> Best, >> Tijo >> >> ps: If you want I could post this to the slepc mailing list. > > cc:ing list. thats the better location to discuss issues. > > Satish > From sickofcowboys at hotmail.com Wed Aug 13 02:48:21 2014 From: sickofcowboys at hotmail.com (aymeric aymeric) Date: Wed, 13 Aug 2014 09:48:21 +0200 Subject: [petsc-users] Creating a Vec with DMCreateGlobalVector from a dmplex? Message-ID: - I create a dmplex with DMPlexCreateHexBoxMesh- Distribute it with DMPlexDistribute- Create a Vec based on the distributed dmplex with DMCreateGlobalVector- But when I check the size of this Vec with VecGetOwnershipRange or VecGetSize, it is empty. What am I missing? I know this is possible, because in SNES ex12.c a vector is created using this sequence of commands. Unfortunately, it some other commands are also used, but they are not all documented. Thanks. -------------- next part -------------- An HTML attachment was scrubbed... URL: From cedric.doucet at inria.fr Wed Aug 13 03:09:40 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Wed, 13 Aug 2014 10:09:40 +0200 (CEST) Subject: [petsc-users] Optional arguments of MatZeroRows In-Reply-To: <2054874936.10717169.1407916854877.JavaMail.zimbra@inria.fr> Message-ID: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> Hello, I want to use MatZeroRows function ( http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatZeroRows.html ). It is said in the documentation that the last two arguments are optional, i.e. x and b vectors: PetscErrorCode MatZeroRows(Mat mat,PetscInt numRows,const PetscInt rows[],PetscScalar diag, Vec x , Vec b ) However, a call to MatZeroRows(mat,numRows,rows,diag) does not seem to work because the last two input arguments are required. In examples, e.g. src/ksp/ksp/examples/tutorials/ex3.c.html , it seems that optional arguments are passed by putting some zero values instead of vectors: MatZeroRows(mat,numRows,rows,diag, 0 , 0 ) Is this the right way to use MatZeroRows function when one does not want to pass x and b vectors as input arguments? Best, C?dric -------------- next part -------------- An HTML attachment was scrubbed... URL: From cedric.doucet at inria.fr Wed Aug 13 03:20:48 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Wed, 13 Aug 2014 10:20:48 +0200 (CEST) Subject: [petsc-users] Optional arguments of MatZeroRows In-Reply-To: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> References: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> Message-ID: <22282262.10724214.1407918048376.JavaMail.zimbra@inria.fr> It seems that MatZeroRows(mat,numRows,rows,diag, NULL , NULL ) also works. Is it better to pass NULL instead of 0? C?dric ----- Mail original ----- > De: "Cedric Doucet" > ?: petsc-users at mcs.anl.gov > Envoy?: Mercredi 13 Ao?t 2014 10:09:40 > Objet: [petsc-users] Optional arguments of MatZeroRows > Hello, > I want to use MatZeroRows function ( > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatZeroRows.html > ). > It is said in the documentation that the last two arguments are optional, > i.e. x and b vectors: > PetscErrorCode MatZeroRows(Mat mat,PetscInt numRows,const PetscInt > rows[],PetscScalar diag, Vec x , Vec b ) > However, a call to > MatZeroRows(mat,numRows,rows,diag) > does not seem to work because the last two input arguments are required. > In examples, e.g. src/ksp/ksp/examples/tutorials/ex3.c.html , it seems that > optional arguments are passed by putting some zero values instead of > vectors: > MatZeroRows(mat,numRows,rows,diag, 0 , 0 ) > Is this the right way to use MatZeroRows function when one does not want to > pass x and b vectors as input arguments? > Best, > C?dric -------------- next part -------------- An HTML attachment was scrubbed... URL: From rupp at iue.tuwien.ac.at Wed Aug 13 03:20:55 2014 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Wed, 13 Aug 2014 10:20:55 +0200 Subject: [petsc-users] Optional arguments of MatZeroRows In-Reply-To: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> References: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> Message-ID: <53EB1FE7.9090000@iue.tuwien.ac.at> Hi Cedric, > I want to use MatZeroRows function > (http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatZeroRows.html). > > It is said in the documentation that the last two arguments are > optional, i.e. x and b vectors: > /PetscErrorCode MatZeroRows(Mat mat,PetscInt numRows,const PetscInt > rows[],PetscScalar diag,*Vec x*,*Vec*/*b*) > However, a call to > /MatZeroRows(mat,numRows,rows,diag)/ > does not seem to work because the last two input arguments are required. > > In examples, e.g. src/ksp/ksp/examples/tutorials/ex3.c.html > , > it seems that optional arguments are passed by putting some zero values > instead of vectors: > /MatZeroRows(mat,numRows,rows,diag,*0*,*0*)/ > > Is this the right way to use MatZeroRows function when one does not want > to pass x and b vectors as input arguments? Yes, in PETSc language an optional argument is an argument for which one can pass NULL (or equivalent). This is because C does not support function overloading, so you always have to pass the full number of arguments. Best regards, Karli From cedric.doucet at inria.fr Wed Aug 13 03:22:10 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Wed, 13 Aug 2014 10:22:10 +0200 (CEST) Subject: [petsc-users] Optional arguments of MatZeroRows In-Reply-To: <53EB1FE7.9090000@iue.tuwien.ac.at> References: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> <53EB1FE7.9090000@iue.tuwien.ac.at> Message-ID: <860516658.10724357.1407918129993.JavaMail.zimbra@inria.fr> Hi Karl, thank you very much for your answer! Ok, I understand! So, I will pass NULL instead of 0. :-) Best, C?dric ----- Mail original ----- > De: "Karl Rupp" > ?: "Cedric Doucet" , petsc-users at mcs.anl.gov > Envoy?: Mercredi 13 Ao?t 2014 10:20:55 > Objet: Re: [petsc-users] Optional arguments of MatZeroRows > > Hi Cedric, > > > I want to use MatZeroRows function > > (http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatZeroRows.html). > > > > It is said in the documentation that the last two arguments are > > optional, i.e. x and b vectors: > > /PetscErrorCode MatZeroRows(Mat mat,PetscInt numRows,const PetscInt > > rows[],PetscScalar diag,*Vec x*,*Vec*/*b*) > > However, a call to > > /MatZeroRows(mat,numRows,rows,diag)/ > > does not seem to work because the last two input arguments are required. > > > > In examples, e.g. src/ksp/ksp/examples/tutorials/ex3.c.html > > , > > it seems that optional arguments are passed by putting some zero values > > instead of vectors: > > /MatZeroRows(mat,numRows,rows,diag,*0*,*0*)/ > > > > Is this the right way to use MatZeroRows function when one does not want > > to pass x and b vectors as input arguments? > > Yes, in PETSc language an optional argument is an argument for which one > can pass NULL (or equivalent). This is because C does not support > function overloading, so you always have to pass the full number of > arguments. > > Best regards, > Karli > > From rupp at iue.tuwien.ac.at Wed Aug 13 03:22:29 2014 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Wed, 13 Aug 2014 10:22:29 +0200 Subject: [petsc-users] Optional arguments of MatZeroRows In-Reply-To: <22282262.10724214.1407918048376.JavaMail.zimbra@inria.fr> References: <831811373.10719238.1407917380604.JavaMail.zimbra@inria.fr> <22282262.10724214.1407918048376.JavaMail.zimbra@inria.fr> Message-ID: <53EB2045.5090902@iue.tuwien.ac.at> > It seems that > /MatZeroRows(mat,numRows,rows,diag,*NULL*,*NULL*)/ > also works. > > Is it better to pass NULL instead of 0? both should be fine, unless you use an ancient compiler which does not define NULL... Best regards, Karli > ------------------------------------------------------------------------ > > *De: *"Cedric Doucet" > *?: *petsc-users at mcs.anl.gov > *Envoy?: *Mercredi 13 Ao?t 2014 10:09:40 > *Objet: *[petsc-users] Optional arguments of MatZeroRows > > Hello, > > I want to use MatZeroRows function > (http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatZeroRows.html). > > It is said in the documentation that the last two arguments are > optional, i.e. x and b vectors: > /PetscErrorCode MatZeroRows(Mat mat,PetscInt numRows,const PetscInt > rows[],PetscScalar diag,*Vec x*,*Vec*/*b*) > However, a call to > /MatZeroRows(mat,numRows,rows,diag)/ > does not seem to work because the last two input arguments are required. > > In examples, e.g. src/ksp/ksp/examples/tutorials/ex3.c.html > , > it seems that optional arguments are passed by putting some zero > values instead of vectors: > /MatZeroRows(mat,numRows,rows,diag,*0*,*0*)/ > > Is this the right way to use MatZeroRows function when one does not > want to pass x and b vectors as input arguments? > > Best, > > C?dric > > > From knepley at gmail.com Wed Aug 13 07:09:03 2014 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 13 Aug 2014 07:09:03 -0500 Subject: [petsc-users] Creating a Vec with DMCreateGlobalVector from a dmplex? In-Reply-To: References: Message-ID: On Wed, Aug 13, 2014 at 2:48 AM, aymeric aymeric wrote: > - I create a dmplex with DMPlexCreateHexBoxMesh > - Distribute it with DMPlexDistribute > Here you are missing a crucial step. You have to define a data layout over the mesh. The most basic way to do this is to create a PetscSection object, and then use DMSetDefaulSection(). There is a helper function for this: http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/DM/DMPlexCreateSection.html The DMDA has a default layout in which every vertex gets dof degrees of freedom. Thanks, Matt > - Create a Vec based on the distributed dmplex with DMCreateGlobalVector > - But when I check the size of this Vec with VecGetOwnershipRange or > VecGetSize, it is empty. > > What am I missing? > > I know this is possible, because in SNES ex12.c a vector is created using > this sequence of commands. Unfortunately, it some other commands are also > used, but they are not all documented. > > Thanks. > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From alex at jubileedvds.com Wed Aug 13 08:48:38 2014 From: alex at jubileedvds.com (Jubilee DVDs) Date: Wed, 13 Aug 2014 06:48:38 -0700 Subject: [petsc-users] Jubilee DVDs Spotlight Collections Message-ID: <53eb6cb61b524_225ae55eac4802644@prd-nresque01.sf.verticalresponse.com.mail> View Online ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vZW1haWxzLzIxOTkwMjMyNjc0MTk_Y29udGFjdF9pZD0yMTk5MDI4OTAzOTEw/ukJrgEYGJ4ZOWxIFscNACA==&merge_field_type=%7BVR_HOSTED_LINK%7D ) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL3d3dy5qdWJpbGVlZHZkcy5jb20=/Qz5jSz70d1h-ErTOUHTH_w==&merge_field_type=(?x-mi:(?%3C=href=)[ ) Spotlight Collections Alfred Adam Hi from Jubilee DVDs! ?I am now offering regular spotlight collections. These collections are intended for cinephile completists and will feature rather obscure titles. ?I hope you enjoy them! ?When you receive an invoice it will always feature free shipping and I will even discount for larger orders.??Spotlight No. 1?-?Alfred Adam?Born in 1909 in Asmieres, France, he was a character player in French films, often in treacherous roles. ?He was highly respected for his work in the theater as an actor as well as a playwright. ?Adam could as well be the nasty type as the regular working-class Parisian, the cuckold as the local Casanova, a general as a chauffeur, a gangster as a policeman, a peasant or the richest man in the village, an ordinary butcher as an eccentric. He was always convincing with, in addition, this Gallic touch that made (and still makes) him a treat to look at and to listen to.??Besides becoming an actor, he studied civil engineering, wrote plays (his most famous being 'Sylvie et le fant?me'), penned film screenplays and dialogs and even the argument for a Roland Petit ballet. He also showed a life long interest in reading, sport (boxing, tennis, soccer), good food and friendship. He was a local figure in Montmartre where he lived, gaily strolling the streets in his long long coat and his wide wide hat.?He died in 1982 of a heart attack. Here is the Spotlight Collection for Alfred Adam. ?Just click on title and it will take you to the listing on the website. La Kermesse heroique (1935) - inquire by emailUn Carnet de Bal (1937) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9Vbi1jYXJuZXQtZGUtYmFsLTE5MzctRFZELUg1MzAyMDE0MTAyMy5odG0_Y2F0ZWdvcnlJZD0tMQ==/9W1f8JSI6_7feb7wjFygCA==&merge_field_type=(?x-mi:(?%3C=href=)[ )La Vie de Boheme (1942) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9MYS12aWUtZGUtYm9oZW1lLTE5NDUtRFZELVE2MTAyMDExMzA3Lmh0bT9jYXRlZ29yeUlkPS0x/3O9pqdlKzhSfR8Y7kV7hCw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Boule de Suif (1945) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9Cb3VsZS1kZS1zdWlmLTE5NDUtRFZELUg1MjkyMDE0MzM4Lmh0bT9jYXRlZ29yeUlkPS0x/q8kpFEoiheaRdpdSbopP7Q==&merge_field_type=(?x-mi:(?%3C=href=)[ )Sylvie et la Fantome (1946) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9TeWx2aWUtZXQtbGUtZmFudG9tZS0xOTQ2LURWRC1INjIyMjAxNDEyNTIuaHRtP2NhdGVnb3J5SWQ9LTE=/c2ZtnJdXD3sTSfJUAySoCA==&merge_field_type=(?x-mi:(?%3C=href=)[ )A Royal Affair (1950) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9BLVJveWFsLUFmZmFpci0xOTQ5LURWRC1INjI1MjAxNDQ1NS5odG0_Y2F0ZWdvcnlJZD0tMQ==/kczKmbHk0eBo_kt2y6Z4Gw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Caroline Cherie (1950) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9DYXJvbGluZS1jaGVyaWUtMTk1MS1EVkQtSDUzMTIwMTQxMDMxLmh0bT9jYXRlZ29yeUlkPS0x/G9d9uTHNvsBtDT-nFisI2Q==&merge_field_type=(?x-mi:(?%3C=href=)[ )L'Ennemi public No. 1 (1953) - inquire by emailCadet Rousselle (1954) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9DYWRldC1Sb3Vzc2VsbGUtMTk1NC1EVkQtSDY1MjAxNDg1Ny5odG0_Y2F0ZWdvcnlJZD0tMQ==/hyD5ci2UNQ6r6sOKaqaxMg==&merge_field_type=(?x-mi:(?%3C=href=)[ )The Crucible (1956) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9UaGUtQ3J1Y2libGUtMTk1Ny1EVkQtSDYyNzIwMTQxMTYuaHRtP2NhdGVnb3J5SWQ9LTE=/BaYOMd_w-DhZ4QiOCi26UQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Une manche et la belle (1957) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9VbmUtbWFuY2hlLWV0LWxhLWJlbGxlLTE5NTctRFZELUg2MjIwMTQ3MzEuaHRtP2NhdGVnb3J5SWQ9LTE=/nUOFqdW1sc182-NRw2dj4A==&merge_field_type=(?x-mi:(?%3C=href=)[ )La Belle Americaine (1961) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9MYS1iZWxsZS1BbWVyaWNhaW5lLTE5NjEtRFZELU01MjgyMDE0MjIwLmh0bT9jYXRlZ29yeUlkPS0x/ybewUQls3P7EvWztXxxsTQ==&merge_field_type=(?x-mi:(?%3C=href=)[ )Mon oncle Benjamin (1969) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9tb24tb25jbGUtQmVuamFtaW4tMTk2OS1EVkQtSDUyNDIwMTQ5NDUuaHRtP2NhdGVnb3J5SWQ9LTE=/mR0eidjk0c9TxPmBgV4vBw==&merge_field_type=(?x-mi:(?%3C=href=)[ )Let Joy Reign Supreme (1977) ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cDovL2p1YmlsZWVkdmRzLmNvbS9MZXQtSm95LVJlaWduLVN1cHJlbWUtMTk3NS1EVkQtSDYxNDIwMTQxMDQ2Lmh0bT9jYXRlZ29yeUlkPS0x/J9zUNaTGwUdT--d-mfDE2w==&merge_field_type=(?x-mi:(?%3C=href=)[ ) I hope some of these are titles you have been searching for to complete your collections.??Chow for now! Jubilee DVDs7027 W. Broward Blvd. # 309Plantation, FL 33317 Update your Email Preferences ( https://cts.vrmailer1.com/click?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vY29udGFjdHMvMjE5OTAyODkwMzkxMC9lZGl0P2VtYWlsX2lkPTIxOTkwMjMyNjc0MTk=/YCEztQhc3Sg9TvCeKMhDYQ==&merge_field_type=%7BEMAIL_PREFERENCES%7D ) or Unsubscribe ( https://cts.vrmailer1.com/unsub?sk=adKAB2JgCjBJbbqZQAP0F5JYcbRtl0LdZCj2DGtK2byg=/aHR0cHM6Ly92cjIudmVydGljYWxyZXNwb25zZS5jb20vY29udGFjdHMvMjE5OTAyODkwMzkxMC91bnN1YnNjcmliZT9lbWFpbF9pZD0yMTk5MDIzMjY3NDE5/0gLYVDpgo7LQXDwa7gzcRw==&merge_field_type=%7BUNSUBSCRIBE_LINK%7D ) ( http://www.verticalresponse.com/?utm_campaign=email-footer&utm_medium=referral&utm_source=footer&utm_content=CamID2199023267419&sn=CamID2199023267419 ) -------------- next part -------------- An HTML attachment was scrubbed... URL: From jychang48 at gmail.com Wed Aug 13 14:35:21 2014 From: jychang48 at gmail.com (Justin Chang) Date: Wed, 13 Aug 2014 14:35:21 -0500 Subject: [petsc-users] How to run SNES ex62 Message-ID: Hi all, This might seem like a silly question, but whenever I try running ./ex62 i seem to always get a zero solution. I didn't see any script for running ex62 in the makefile so I have tried all the runtime combination of options listed in the Paris tutorial 2012 slides (e.g., block jacobi, gauss seidel, uzawa, schur complement, etc). They either give me a zero pivot for LU or errors like Petsc has generated inconsistent data. Can someone show me how to get solutions for this problem? Thanks, Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 13 17:11:04 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 13 Aug 2014 17:11:04 -0500 Subject: [petsc-users] problem in using MatCreateMPIAIJWithArrays routine In-Reply-To: <4A629AF3-3445-47ED-938A-B5BD30052EFF@odu.edu> References: <4A629AF3-3445-47ED-938A-B5BD30052EFF@odu.edu> Message-ID: Usually the matrix is generated in parallel so each process has part of the matrix. If the matrix is generated sequentially then that will limit the parallel performance you can get. The MPI model is not particularly friendly to ?some parts of my code are purely sequential, but I want other parts to be parallel? Barry On Aug 13, 2014, at 3:52 PM, Priyank Patel wrote: > Thank you Barry, > > But what if I have a matrix that is 1000000 X 1000000 and with 32 processors? I would be a very time consuming task to indicate column and row indices for all of them I guess. Do you think there is another way to do it? I just want to do parallel matrix matrix multiplication. > > Priyank Patel > ppate024 at odu.edu > > > > > On 12-Aug-2014, at 9:20 pm, Barry Smith wrote: > >> >> On each process you should only pass the row and column indices for the rows you want on that process. In other words do not pass the entire matrix on each process. Take a look at the example matrix in the manual page http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatCreateMPIAIJWithArrays.html >> >> Barry >> >> On Aug 12, 2014, at 8:02 PM, Priyank Patel wrote: >> >>> Hello, >>> I am trying to do sparse - dense matrix multiplication and for that I am using a CSR Matrix(that are three array) in PETSC using the function MatCreateMPIAIJWithArrays() to create a petsc matrix. >>> My call to routine is as below >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> //Initialize PETSC >>> MPI_Init(&argc, &argv); >>> PetscInitialize(&argc, &argv, (char*) 0, help); >>> >>> MPI_Comm_rank(PETSC_COMM_WORLD, &taskid); >>> MPI_Comm_size(PETSC_COMM_WORLD, &numtasks); >>> >>> //Create A Sparse Matrix fro the files >>> ierr = MatCreateMPIAIJWithArrays(PETSC_COMM_WORLD, m, m, PETSC_DETERMINE, PETSC_DETERMINE, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); >>> >>> //ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_WORLD, m, m, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); >>> >>> MatView(A,PETSC_VIEWER_STDOUT_WORLD); >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> >>> My make file is as below >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> PETSC_DIR=/export/software/petsc-3.3 >>> >>> INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ >>> MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ >>> INTEL_LIB_PATH_64=/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ >>> MKL_INC_PATH=/export/software/intel/mkl/include/ >>> SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ >>> SCALAPACK_INC_PATH=/export/software/scalapack-2.0.2/ >>> GENERAL_LIB_PATH=/export/software/lib/ >>> >>> CLINKER=mpicc >>> >>> PKG_INC = -I${MKL_INC_PATH} >>> PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -Wl,-rpath,${INTEL_LIB_PATH_64} -L${INTEL_LIB_PATH_64} -liomp5 -Wl,-rpath,${SCALAPACK_LIB_PATH} -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -lblas >>> >>> CFLAGS = >>> FFLAGS = >>> CPPFLAGS = ${PKG_INC} >>> FPPFLAGS = >>> CLEANFILES = >>> >>> include ${PETSC_DIR}/conf/variables >>> include ${PETSC_DIR}/conf/rules >>> >>> blockCG_1: blockCG_1.o chkopts >>> -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} >>> >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> >>> And I tried to run the program with following command >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> /opt/openmpi/bin/mpirun -np 3 ./blockCG_1 /home/ppatel/MPI/LF10_2 >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> >>> but the routine is not distributing the matrix and give me the result as below. >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> loading matrix from : /home/ppatel/MPI/LF10_2 >>> nRows: 18, nCoefs: 82. >>> Matrix Object: 1 MPI processes >>> type: mpiaij >>> row 0: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 1: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 2: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 3: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 4: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 5: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 6: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 7: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 8: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 9: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 10: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 11: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 12: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 13: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 14: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 15: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 16: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 17: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> row 18: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 19: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 20: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 21: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 22: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 23: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 24: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 25: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 26: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 27: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 28: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 29: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 30: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 31: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 32: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 33: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 34: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 35: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> row 36: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 37: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 38: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 39: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 40: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 41: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 42: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 43: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 44: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 45: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 46: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 47: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 48: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 49: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 50: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 51: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 52: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 53: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> row 54: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 55: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 56: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 57: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 58: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 59: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 60: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 61: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 62: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 63: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 64: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 65: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 66: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 67: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 68: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 69: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 70: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 71: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> row 72: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 73: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 74: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 75: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 76: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 77: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 78: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 79: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 80: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 81: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 82: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 83: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 84: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 85: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 86: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 87: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 88: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 89: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> row 90: (0, 3.53448) (1, -477.155) (2, 1.76724) >>> row 91: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>> row 92: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>> row 93: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>> row 94: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>> row 95: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>> row 96: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>> row 97: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>> row 98: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>> row 99: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>> row 100: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>> row 101: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>> row 102: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>> row 103: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>> row 104: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>> row 105: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>> row 106: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>> row 107: (15, 477.155) (16, 1.76724) (17, 3.53448) >>> >>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>> that is creating a matrix with rows repeated 6 times instead of distributed over 6 process. >>> >>> Can you please tell me where I am doing wrong?? >>> >>> Thanks for your time >>> >>> Priyank Patel >>> ppate024 at odu.edu >>> >>> >>> >>> >>> >> >> >> >> -- >> BEGIN-ANTISPAM-VOTING-LINKS >> ------------------------------------------------------ >> >> Teach CanIt if this mail (ID 02MC1lmkI) is spam: >> Spam: https://www.spamtrap.odu.edu/canit/b.php?i=02MC1lmkI&m=5fb5857f0823&t=20140812&c=s >> Not spam: https://www.spamtrap.odu.edu/canit/b.php?i=02MC1lmkI&m=5fb5857f0823&t=20140812&c=n >> Forget vote: https://www.spamtrap.odu.edu/canit/b.php?i=02MC1lmkI&m=5fb5857f0823&t=20140812&c=f >> ------------------------------------------------------ >> END-ANTISPAM-VOTING-LINKS >> > From ppate024 at odu.edu Thu Aug 14 06:52:02 2014 From: ppate024 at odu.edu (Priyank Patel) Date: Thu, 14 Aug 2014 07:52:02 -0400 Subject: [petsc-users] problem in using MatCreateMPIAIJWithArrays routine In-Reply-To: References: <4A629AF3-3445-47ED-938A-B5BD30052EFF@odu.edu> Message-ID: <3EB680CD-5600-4BA7-8316-183C383093AE@odu.edu> Hello, As per your advice I am trying to pass the row and column indices to MatCreateMPIAIJWithArrays(), but there is a confusion, if we follow the matrix given in the manual. --------------------------------------------------------------------------------------------------------------------------------------------- The i and j indices are 0 based, and i indices are indices corresponding to the local j array. 3990: The format which is used for the sparse matrix input, is equivalent to a 3991: row-major ordering.. i.e for the following matrix, the input data expected is 3992: as shown: 3994: 1 0 0 3995: 2 0 3 P0 3996: ------- 3997: 4 5 6 P1 3999: Process0 [P0]: rows_owned=[0,1] 4000: i = {0,1,3} [size = nrow+1 = 2+1] 4001: j = {0,0,2} [size = nz = 6] 4002: v = {1,2,3} [size = nz = 6] 4004: Process1 [P1]: rows_owned=[2] 4005: i = {0,3} [size = nrow+1 = 1+1] 4006: j = {0,1,2} [size = nz = 6] 4007: v = {4,5,6} [size = nz = 6] --------------------------------------------------------------------------------------------------------------------------------------------- --> the i and j array should be 0 based. if I want to add one row in P2 as below then what would be the i and j array for that? 1 0 0 2 0 3 P0 ------- 4 5 6 P1 ------- 0 0 7 P2 Because the start position for the non-zero value is 2. Thanks Priyank On 13-Aug-2014, at 6:11 pm, Barry Smith wrote: > > Usually the matrix is generated in parallel so each process has part of the matrix. If the matrix is generated sequentially then that will limit the parallel performance you can get. > > The MPI model is not particularly friendly to ?some parts of my code are purely sequential, but I want other parts to be parallel? > > Barry > > On Aug 13, 2014, at 3:52 PM, Priyank Patel wrote: > >> Thank you Barry, >> >> But what if I have a matrix that is 1000000 X 1000000 and with 32 processors? I would be a very time consuming task to indicate column and row indices for all of them I guess. Do you think there is another way to do it? I just want to do parallel matrix matrix multiplication. >> >> Priyank Patel >> ppate024 at odu.edu >> >> >> >> >> On 12-Aug-2014, at 9:20 pm, Barry Smith wrote: >> >>> >>> On each process you should only pass the row and column indices for the rows you want on that process. In other words do not pass the entire matrix on each process. Take a look at the example matrix in the manual page http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatCreateMPIAIJWithArrays.html >>> >>> Barry >>> >>> On Aug 12, 2014, at 8:02 PM, Priyank Patel wrote: >>> >>>> Hello, >>>> I am trying to do sparse - dense matrix multiplication and for that I am using a CSR Matrix(that are three array) in PETSC using the function MatCreateMPIAIJWithArrays() to create a petsc matrix. >>>> My call to routine is as below >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> //Initialize PETSC >>>> MPI_Init(&argc, &argv); >>>> PetscInitialize(&argc, &argv, (char*) 0, help); >>>> >>>> MPI_Comm_rank(PETSC_COMM_WORLD, &taskid); >>>> MPI_Comm_size(PETSC_COMM_WORLD, &numtasks); >>>> >>>> //Create A Sparse Matrix fro the files >>>> ierr = MatCreateMPIAIJWithArrays(PETSC_COMM_WORLD, m, m, PETSC_DETERMINE, PETSC_DETERMINE, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); >>>> >>>> //ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_WORLD, m, m, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); >>>> >>>> MatView(A,PETSC_VIEWER_STDOUT_WORLD); >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> >>>> My make file is as below >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> PETSC_DIR=/export/software/petsc-3.3 >>>> >>>> INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ >>>> MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ >>>> INTEL_LIB_PATH_64=/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ >>>> MKL_INC_PATH=/export/software/intel/mkl/include/ >>>> SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ >>>> SCALAPACK_INC_PATH=/export/software/scalapack-2.0.2/ >>>> GENERAL_LIB_PATH=/export/software/lib/ >>>> >>>> CLINKER=mpicc >>>> >>>> PKG_INC = -I${MKL_INC_PATH} >>>> PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -Wl,-rpath,${INTEL_LIB_PATH_64} -L${INTEL_LIB_PATH_64} -liomp5 -Wl,-rpath,${SCALAPACK_LIB_PATH} -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -lblas >>>> >>>> CFLAGS = >>>> FFLAGS = >>>> CPPFLAGS = ${PKG_INC} >>>> FPPFLAGS = >>>> CLEANFILES = >>>> >>>> include ${PETSC_DIR}/conf/variables >>>> include ${PETSC_DIR}/conf/rules >>>> >>>> blockCG_1: blockCG_1.o chkopts >>>> -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} >>>> >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> >>>> And I tried to run the program with following command >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> /opt/openmpi/bin/mpirun -np 3 ./blockCG_1 /home/ppatel/MPI/LF10_2 >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> >>>> but the routine is not distributing the matrix and give me the result as below. >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> loading matrix from : /home/ppatel/MPI/LF10_2 >>>> nRows: 18, nCoefs: 82. >>>> Matrix Object: 1 MPI processes >>>> type: mpiaij >>>> row 0: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 1: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 2: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 3: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 4: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 5: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 6: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 7: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 8: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 9: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 10: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 11: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 12: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 13: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 14: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 15: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 16: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 17: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> row 18: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 19: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 20: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 21: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 22: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 23: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 24: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 25: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 26: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 27: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 28: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 29: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 30: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 31: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 32: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 33: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 34: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 35: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> row 36: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 37: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 38: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 39: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 40: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 41: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 42: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 43: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 44: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 45: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 46: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 47: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 48: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 49: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 50: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 51: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 52: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 53: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> row 54: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 55: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 56: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 57: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 58: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 59: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 60: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 61: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 62: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 63: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 64: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 65: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 66: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 67: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 68: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 69: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 70: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 71: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> row 72: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 73: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 74: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 75: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 76: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 77: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 78: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 79: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 80: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 81: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 82: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 83: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 84: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 85: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 86: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 87: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 88: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 89: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> row 90: (0, 3.53448) (1, -477.155) (2, 1.76724) >>>> row 91: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) >>>> row 92: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) >>>> row 93: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, 477.155) >>>> row 94: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) >>>> row 95: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, 477.155) >>>> row 96: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) >>>> row 97: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, 477.155) >>>> row 98: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, 1.76724) >>>> row 99: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, 477.155) >>>> row 100: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, 1.76724) >>>> row 101: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, 477.155) >>>> row 102: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, 1.76724) >>>> row 103: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, 477.155) >>>> row 104: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, 1.76724) >>>> row 105: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) >>>> row 106: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) >>>> row 107: (15, 477.155) (16, 1.76724) (17, 3.53448) >>>> >>>> ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ >>>> that is creating a matrix with rows repeated 6 times instead of distributed over 6 process. >>>> >>>> Can you please tell me where I am doing wrong?? >>>> >>>> Thanks for your time >>>> >>>> Priyank Patel >>>> ppate024 at odu.edu >>>> >>>> >>>> >>>> >>>> >>> >>> >>> >>> -- >>> >> > > > > -- > BEGIN-ANTISPAM-VOTING-LINKS > ------------------------------------------------------ > > Teach CanIt if this mail (ID 03MCmbAxj) is spam: > Spam: https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=s > Not spam: https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=n > Forget vote: https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=f > ------------------------------------------------------ > END-ANTISPAM-VOTING-LINKS -------------- next part -------------- An HTML attachment was scrubbed... URL: From hong at aspiritech.org Thu Aug 14 09:55:41 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Thu, 14 Aug 2014 09:55:41 -0500 Subject: [petsc-users] problem in using MatCreateMPIAIJWithArrays routine In-Reply-To: <3EB680CD-5600-4BA7-8316-183C383093AE@odu.edu> References: <4A629AF3-3445-47ED-938A-B5BD30052EFF@odu.edu> <3EB680CD-5600-4BA7-8316-183C383093AE@odu.edu> Message-ID: Priyank : > > --------------------------------------------------------------------------------------------------------------------------------------------- > --> the i and j array should be 0 based. > if I want to add one row in P2 as below then what would be the i and j array > for that? > 1 0 0 > 2 0 3 P0 > ------- > 4 5 6 P1 > ------- > 0 0 7 P2 > Because the start position for the non-zero value is 2. For P2: i = { 0,1} j = { 2} v = {7} Hong > > On 13-Aug-2014, at 6:11 pm, Barry Smith wrote: > > > Usually the matrix is generated in parallel so each process has part of the > matrix. If the matrix is generated sequentially then that will limit the > parallel performance you can get. > > The MPI model is not particularly friendly to ?some parts of my code are > purely sequential, but I want other parts to be parallel? > > Barry > > On Aug 13, 2014, at 3:52 PM, Priyank Patel wrote: > > Thank you Barry, > > But what if I have a matrix that is 1000000 X 1000000 and with 32 > processors? I would be a very time consuming task to indicate column and row > indices for all of them I guess. Do you think there is another way to do it? > I just want to do parallel matrix matrix multiplication. > > Priyank Patel > ppate024 at odu.edu > > > > > On 12-Aug-2014, at 9:20 pm, Barry Smith wrote: > > > On each process you should only pass the row and column indices for the rows > you want on that process. In other words do not pass the entire matrix on > each process. Take a look at the example matrix in the manual page > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatCreateMPIAIJWithArrays.html > > Barry > > On Aug 12, 2014, at 8:02 PM, Priyank Patel wrote: > > Hello, > I am trying to do sparse - dense matrix multiplication and for that I am > using a CSR Matrix(that are three array) in PETSC using the function > MatCreateMPIAIJWithArrays() to create a petsc matrix. > My call to routine is as below > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > //Initialize PETSC > MPI_Init(&argc, &argv); > PetscInitialize(&argc, &argv, (char*) 0, help); > > MPI_Comm_rank(PETSC_COMM_WORLD, &taskid); > MPI_Comm_size(PETSC_COMM_WORLD, &numtasks); > > //Create A Sparse Matrix fro the files > ierr = MatCreateMPIAIJWithArrays(PETSC_COMM_WORLD, m, m, PETSC_DETERMINE, > PETSC_DETERMINE, h_iA, h_jA, h_valA, &A);CHKERRQ(ierr); > > //ierr = MatCreateSeqAIJWithArrays(PETSC_COMM_WORLD, m, m, h_iA, h_jA, > h_valA, &A);CHKERRQ(ierr); > > MatView(A,PETSC_VIEWER_STDOUT_WORLD); > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > My make file is as below > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > PETSC_DIR=/export/software/petsc-3.3 > > INTEL_ROOT=/export/software/intel/composerxe-2011.4.191/ > MKL_LIB_PATH_64=/export/software/intel/mkl/lib/intel64/ > INTEL_LIB_PATH_64=/export/software/intel/composerxe-2011.4.191/compiler/lib/intel64/ > MKL_INC_PATH=/export/software/intel/mkl/include/ > SCALAPACK_LIB_PATH=/export/software/scalapack-2.0.2/lib/ > SCALAPACK_INC_PATH=/export/software/scalapack-2.0.2/ > GENERAL_LIB_PATH=/export/software/lib/ > > CLINKER=mpicc > > PKG_INC = -I${MKL_INC_PATH} > PKG_LIB = -Wl,-rpath,${MKL_LIB_PATH_64} -L${MKL_LIB_PATH_64} > -lmkl_intel_lp64 -lmkl_gnu_thread -lmkl_core -Wl,-rpath,${INTEL_LIB_PATH_64} > -L${INTEL_LIB_PATH_64} -liomp5 -Wl,-rpath,${SCALAPACK_LIB_PATH} > -L${SCALAPACK_LIB_PATH} -lscalapack -llapack -lblas > > CFLAGS = > FFLAGS = > CPPFLAGS = ${PKG_INC} > FPPFLAGS = > CLEANFILES = > > include ${PETSC_DIR}/conf/variables > include ${PETSC_DIR}/conf/rules > > blockCG_1: blockCG_1.o chkopts > -${CLINKER} -o blockCG_1 blockCG_1.o ${PKG_LIB} ${PETSC_LIB} > > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > And I tried to run the program with following command > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > /opt/openmpi/bin/mpirun -np 3 ./blockCG_1 /home/ppatel/MPI/LF10_2 > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > > but the routine is not distributing the matrix and give me the result as > below. > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > loading matrix from : /home/ppatel/MPI/LF10_2 > nRows: 18, nCoefs: 82. > Matrix Object: 1 MPI processes > type: mpiaij > row 0: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 1: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 2: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 3: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 4: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, 1.76724) > row 5: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 6: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, 1.76724) > row 7: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 8: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 9: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 10: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 11: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 12: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 13: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 14: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 15: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 16: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 17: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 18: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 19: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 20: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 21: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 22: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, > 1.76724) > row 23: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 24: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, > 1.76724) > row 25: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 26: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 27: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 28: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 29: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 30: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 31: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 32: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 33: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 34: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 35: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 36: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 37: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 38: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 39: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 40: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, > 1.76724) > row 41: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 42: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, > 1.76724) > row 43: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 44: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 45: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 46: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 47: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 48: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 49: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 50: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 51: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 52: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 53: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 54: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 55: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 56: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 57: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 58: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, > 1.76724) > row 59: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 60: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, > 1.76724) > row 61: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 62: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 63: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 64: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 65: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 66: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 67: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 68: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 69: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 70: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 71: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 72: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 73: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 74: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 75: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 76: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, > 1.76724) > row 77: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 78: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, > 1.76724) > row 79: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 80: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 81: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 82: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 83: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 84: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 85: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 86: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 87: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 88: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 89: (15, 477.155) (16, 1.76724) (17, 3.53448) > row 90: (0, 3.53448) (1, -477.155) (2, 1.76724) > row 91: (0, -477.155) (1, 171776) (3, -85887.9) (4, 477.155) > row 92: (0, 1.76724) (2, 7.06896) (3, -477.155) (4, 1.76724) > row 93: (1, -85887.9) (2, -477.155) (3, 171776) (5, -85887.9) (6, > 477.155) > row 94: (1, 477.155) (2, 1.76724) (4, 7.06896) (5, -477.155) (6, > 1.76724) > row 95: (3, -85887.9) (4, -477.155) (5, 171776) (7, -85887.9) (8, > 477.155) > row 96: (3, 477.155) (4, 1.76724) (6, 7.06896) (7, -477.155) (8, > 1.76724) > row 97: (5, -85887.9) (6, -477.155) (7, 171776) (9, -85887.9) (10, > 477.155) > row 98: (5, 477.155) (6, 1.76724) (8, 7.06896) (9, -477.155) (10, > 1.76724) > row 99: (7, -85887.9) (8, -477.155) (9, 171776) (11, -85887.9) (12, > 477.155) > row 100: (7, 477.155) (8, 1.76724) (10, 7.06896) (11, -477.155) (12, > 1.76724) > row 101: (9, -85887.9) (10, -477.155) (11, 171776) (13, -85887.9) (14, > 477.155) > row 102: (9, 477.155) (10, 1.76724) (12, 7.06896) (13, -477.155) (14, > 1.76724) > row 103: (11, -85887.9) (12, -477.155) (13, 171776) (15, -85887.9) (16, > 477.155) > row 104: (11, 477.155) (12, 1.76724) (14, 7.06896) (15, -477.155) (16, > 1.76724) > row 105: (13, -85887.9) (14, -477.155) (15, 171776) (17, 477.155) > row 106: (13, 477.155) (14, 1.76724) (16, 7.06896) (17, 1.76724) > row 107: (15, 477.155) (16, 1.76724) (17, 3.53448) > > ------------------------------------------------------------------------------------------------------------------------------------------------------------------------ > that is creating a matrix with rows repeated 6 times instead of distributed > over 6 process. > > Can you please tell me where I am doing wrong?? > > Thanks for your time > > Priyank Patel > ppate024 at odu.edu > > > > > > > > > -- > > > > > > -- > BEGIN-ANTISPAM-VOTING-LINKS > ------------------------------------------------------ > > Teach CanIt if this mail (ID 03MCmbAxj) is spam: > Spam: > https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=s > Not spam: > https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=n > Forget vote: > https://www.spamtrap.odu.edu/canit/b.php?i=03MCmbAxj&m=52032b34dad0&t=20140813&c=f > ------------------------------------------------------ > END-ANTISPAM-VOTING-LINKS > > From jsor at comcast.net Thu Aug 14 12:46:01 2014 From: jsor at comcast.net (Blackboard ) Date: Thu, 14 Aug 2014 10:46:01 -0700 Subject: [petsc-users] Your Email Account Message-ID: <201408141746.s7EHjor4031035@posti8.jyu.fi> You have 1 new message Sign In Blackboard | Technology Services -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 15 01:16:03 2014 From: jed at jedbrown.org (Jed Brown) Date: Thu, 14 Aug 2014 23:16:03 -0700 Subject: [petsc-users] How to run SNES ex62 In-Reply-To: References: Message-ID: <8738cy1dng.fsf@jedbrown.org> Justin Chang writes: > Hi all, > > This might seem like a silly question, but whenever I try running ./ex62 i > seem to always get a zero solution. Matt doesn't like the normal run targets in makefiles, so he keeps all the options in config/builder.py. You should be able to find meaningful options for ex62 in that file. > I didn't see any script for running ex62 in the makefile so I have > tried all the runtime combination of options listed in the Paris > tutorial 2012 slides (e.g., block jacobi, gauss seidel, uzawa, schur > complement, etc). They either give me a zero pivot for LU or errors > like Petsc has generated inconsistent data. Can someone show me how to > get solutions for this problem? > > Thanks, > Justin -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From tijovaz at pitt.edu Sat Aug 16 11:08:27 2014 From: tijovaz at pitt.edu (tijovaz) Date: Sat, 16 Aug 2014 12:08:27 -0400 Subject: [petsc-users] slepc external matrix-vector product subroutine Message-ID: <53EF81FB.1000000@pitt.edu> Hi, Preallocation of the matrix greatly improved the speed up of the eigensolver. Is it possible to use the lapack routine 'DSPMV' in the external matrix-vector multiplication for the shellmatrix ? I couldn't find this routine in the petscblaslapack.h or slepcblaslapack.h. Am I missing something? If there is a slepc/petsc matrix-vector multiplication routine that would also work. Thanks, Tijo From bsmith at mcs.anl.gov Sat Aug 16 12:36:20 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 16 Aug 2014 12:36:20 -0500 Subject: [petsc-users] slepc external matrix-vector product subroutine In-Reply-To: <53EF81FB.1000000@pitt.edu> References: <53EF81FB.1000000@pitt.edu> Message-ID: <1B80F1AD-3349-4801-B235-D374B1CC0606@mcs.anl.gov> On Aug 16, 2014, at 11:08 AM, tijovaz wrote: > Hi, > > Preallocation of the matrix greatly improved the speed up of the eigensolver. > > > Is it possible to use the lapack routine 'DSPMV' in the external matrix-vector multiplication for the shellmatrix ? > I couldn't find this routine in the petscblaslapack.h or slepcblaslapack.h. Am I missing something? You can use it since it is part of BLAS and is linked into the executable. The petscblaslapack.h and slepcblaslapack.h only have prototypes for the functions we use directly in PETSc/SLEPc. You just have to write your own prototype for it. Barry > > If there is a slepc/petsc matrix-vector multiplication routine that would also work. > > Thanks, > Tijo > > From mfadams at lbl.gov Sat Aug 16 13:50:33 2014 From: mfadams at lbl.gov (Mark Adams) Date: Sat, 16 Aug 2014 14:50:33 -0400 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre Message-ID: I am creating an Schur complement matrix explicitly (solver%schur) and setting it with code like: call SNESGetKSP(solver%snes,innerksp,ierr) call KSPGetPC(innerksp,spc,ierr) call PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) I would think that the "inner" solver would not be used but it is getting used. It looks to me like I am not getting this hooked up correctly and my Schur complement is not being used. I've attached an output with view data and converged_reason data. I use the "inner" parameters for my Schur construction (code appended), so you see it at the beginning of this output. But it is also in each solve, which seems wrong to me. Any thoughts? Thanks, Mark call MatGetSize(solver%Bmat,M,N,ierr) call VecDuplicate(Xsub(1),v1,ierr) call VecDuplicate(Xsub(1),v2,ierr) call KSPCreate(solver%comm,innerksp,ierr) call KSPSetOptionsPrefix(innerksp,'fsa_fieldsplit_lambda_inner_',ierr) call KSPSetFromOptions(innerksp,ierr) call KSPSetOperators(innerksp, solver%Amat, solver%Amat, ierr ) call KSPSetUp(innerksp,ierr) call MatDuplicate(solver%Dmat,MAT_COPY_VALUES,solver%schur,ierr) call MatGetOwnershipRange(solver%Cmat,low,high,ierr) do k=0,N-1 call MatGetColumnVector(solver%Bmat,v1,k,ierr) call KSPSolve(innerksp,v1,v2,ierr) do j=0,N-1 call VecZeroEntries(v1,ierr) if (j.ge.low .and.j.lt.high) then call MatGetRow(solver%Cmat,j,ncols,cols,vals,ierr) call VecSetValues(v1,ncols,cols,vals,INSERT_VALUES,ierr) !write(*,*) (vals(i), i=1,ncols) call MatRestoreRow(solver%Cmat,j,ncols,cols,vals,ierr) end if call VecAssemblyBegin(v1,ierr) call VecAssemblyEnd(v1,ierr) call VecTDot(v1,v2,dot,ierr) dot = -dot call MatSetValues(solver%schur,ione,j,ione,k,dot,INSERT_VALUES,ierr) ! D - C (A-1) B end do end do call MatAssemblyBegin(solver%schur,MAT_FINAL_ASSEMBLY,ierr) call MatAssemblyEnd(solver%schur,MAT_FINAL_ASSEMBLY,ierr) call VecDestroy(v1,ierr) call VecDestroy(v2,ierr) call KSPDestroy(innerksp,ierr) call SNESGetKSP(solver%snes,innerksp,ierr) call KSPGetPC(innerksp,spc,ierr) call PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: out Type: application/octet-stream Size: 85715 bytes Desc: not available URL: From jifengzhao2015 at u.northwestern.edu Sun Aug 17 21:56:04 2014 From: jifengzhao2015 at u.northwestern.edu (jifeng zhao) Date: Sun, 17 Aug 2014 21:56:04 -0500 Subject: [petsc-users] Out-of-memory, reading ASCII files using single processor Message-ID: Hello all, I am trying to read large matrices from ASCII files and save it into petsc binary format using uni-processor. But I am encountered a out-of-memory error, when reading too-large ASCII file. Is there any way around to read in large matrices? I can't use multiple cores to share memories because reading ASCII files has to be done by single processor. Thanks, Jifeng Zhao -- Jifeng Zhao PhD candidate at Northwestern University, US Theoretical and Applied Mechanics Program -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sun Aug 17 23:40:27 2014 From: jed at jedbrown.org (Jed Brown) Date: Sun, 17 Aug 2014 22:40:27 -0600 Subject: [petsc-users] Out-of-memory, reading ASCII files using single processor In-Reply-To: References: Message-ID: <878ummxves.fsf@jedbrown.org> jifeng zhao writes: > Hello all, > > I am trying to read large matrices from ASCII files and save it into petsc > binary format using uni-processor. > > But I am encountered a out-of-memory error, when reading too-large ASCII > file. Don't use ASCII. It is a monumentally bad format for parallel computing. Convert your ASCII files to PETSc binary files (or HDF5, but PETSc binary is sufficient and simpler), then read in parallel. You can do this easily in MATLAB or Python, or with a serial PETSc program. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From tweyens at fis.uc3m.es Mon Aug 18 05:46:31 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Mon, 18 Aug 2014 12:46:31 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC Message-ID: Dear all, I am using PETSC and SLEPC to simulate a problem in MHD, described in http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. I have a bit of experience with MPI but not too much with PETSC and SLEPC. So after reading both user manuals and also the relevant chapters of the PETSC developers manual, I still can't get it to work. The problem that I have to solve is a large generalized eigenvalue system where the matrices are both Hermitian* by blocks* and *tridiagonal*, e.g.: ( A11 A12 0 0 0 ) ( B11 B12 0 0 0 ) ( A12* A22 A23 0 0 ) ( B12* B22 B23 0 0 ) ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 0 ) ( 0 0 A34* A44 A45) ( 0 0 B34* B44 B45) ( 0 0 A45* A55 0 ) ( 0 0 B45* B55 0 ) where Aii = Aii*, with * the Hermitian conjugate. I apologize for the ugly representation. The dimensions of both A and B are around 50 to 100 blocks (as there is a block per discretized point) and the blocks themselves can vary from 1 to more than 100x100 as well (as they correspond to a spectral decomposition). Now, my question is: how to solve this economically? What I have been trying to do is to make use of the fact that the matrices are Hermitian and by using *matcreatesbaij* and through the recommended *matcreate*, *matsettype(matsbaij)*, etc. Could someone help me out? All help would be greatly appreciated! Thank you in advance, Toon UC3M -------------- next part -------------- An HTML attachment was scrubbed... URL: From ztdepyahoo at 163.com Mon Aug 18 07:28:55 2014 From: ztdepyahoo at 163.com (=?GBK?B?tqHAz8qm?=) Date: Mon, 18 Aug 2014 20:28:55 +0800 (CST) Subject: [petsc-users] how to install two different version petsc in the same pc Message-ID: <36e40e52.148c7.147e9177a27.Coremail.ztdepyahoo@163.com> I need to install a library that could only be run with petsc 3.2. but i have installed the 3.3-p6. how to install the petesc 3.2 in the same pc -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 18 07:36:28 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 06:36:28 -0600 Subject: [petsc-users] how to install two different version petsc in the same pc In-Reply-To: <36e40e52.148c7.147e9177a27.Coremail.ztdepyahoo@163.com> References: <36e40e52.148c7.147e9177a27.Coremail.ztdepyahoo@163.com> Message-ID: <8738cux9df.fsf@jedbrown.org> ??? writes: > I need to install a library that could only be run with petsc 3.2. but i have installed the 3.3-p6. > how to install the petesc 3.2 in the same pc Each version is a different PETSC_DIR. Also, please upgrade to petsc-3.5 at your earliest convenience. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From ztdepyahoo at 163.com Mon Aug 18 07:39:19 2014 From: ztdepyahoo at 163.com (=?GBK?B?tqHAz8qm?=) Date: Mon, 18 Aug 2014 20:39:19 +0800 (CST) Subject: [petsc-users] how to install two different version petsc in the same pc In-Reply-To: <8738cux9df.fsf@jedbrown.org> References: <36e40e52.148c7.147e9177a27.Coremail.ztdepyahoo@163.com> <8738cux9df.fsf@jedbrown.org> Message-ID: <7fd5364.14c16.147e920ffa0.Coremail.ztdepyahoo@163.com> how to set the PETSC_DIR with two different value. At 2014-08-18 08:36:28, "Jed Brown" wrote: >??? writes: > >> I need to install a library that could only be run with petsc 3.2. but i have installed the 3.3-p6. >> how to install the petesc 3.2 in the same pc > >Each version is a different PETSC_DIR. > >Also, please upgrade to petsc-3.5 at your earliest convenience. -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 18 07:47:37 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 06:47:37 -0600 Subject: [petsc-users] how to install two different version petsc in the same pc In-Reply-To: <7fd5364.14c16.147e920ffa0.Coremail.ztdepyahoo@163.com> References: <36e40e52.148c7.147e9177a27.Coremail.ztdepyahoo@163.com> <8738cux9df.fsf@jedbrown.org> <7fd5364.14c16.147e920ffa0.Coremail.ztdepyahoo@163.com> Message-ID: <87zjf2vuae.fsf@jedbrown.org> ??? writes: > how to set the PETSC_DIR with two different value. It is an environment variable used with PETSc makefiles (see the users manual for more on PETSC_DIR and PETSC_ARCH). If you use a different configuration system (autotools, cmake, etc.) then it will probably respect the environment variable at configure time, plus offer some flags to set as an alternative. We recommend using PETSc makefiles when possible. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From hong at aspiritech.org Mon Aug 18 09:34:56 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Mon, 18 Aug 2014 09:34:56 -0500 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: Message-ID: Toon, 1) install petsc and slepc, run few examples, e.g. slepc/src/eps/examples/tutorials/ex13.c for generalized symmetric eigenproblem. Run it with option '-eps_view' to understand what method is being used. Use option '-help' to see available methods. 2) replace its matrices with yours, experiment default method, then other methods using runtime options provided by slepc. Hong On Mon, Aug 18, 2014 at 5:46 AM, Toon Weyens wrote: > Dear all, > > I am using PETSC and SLEPC to simulate a problem in MHD, described in > http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. > > I have a bit of experience with MPI but not too much with PETSC and SLEPC. > So after reading both user manuals and also the relevant chapters of the > PETSC developers manual, I still can't get it to work. > > The problem that I have to solve is a large generalized eigenvalue system > where the matrices are both Hermitian by blocks and tridiagonal, e.g.: > > ( A11 A12 0 0 0 ) ( B11 B12 0 0 > 0 ) > ( A12* A22 A23 0 0 ) ( B12* B22 B23 0 > 0 ) > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 0 > ) > ( 0 0 A34* A44 A45) ( 0 0 B34* > B44 B45) > ( 0 0 A45* A55 0 ) ( 0 0 B45* > B55 0 ) > > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the ugly > representation. > > The dimensions of both A and B are around 50 to 100 blocks (as there is a > block per discretized point) and the blocks themselves can vary from 1 to > more than 100x100 as well (as they correspond to a spectral decomposition). > > Now, my question is: how to solve this economically? > > What I have been trying to do is to make use of the fact that the matrices > are Hermitian and by using matcreatesbaij and through the recommended > matcreate, matsettype(matsbaij), etc. > > Could someone help me out? All help would be greatly appreciated! > > Thank you in advance, > Toon > UC3M From jifengzhao2015 at u.northwestern.edu Mon Aug 18 09:46:18 2014 From: jifengzhao2015 at u.northwestern.edu (jifeng zhao) Date: Mon, 18 Aug 2014 09:46:18 -0500 Subject: [petsc-users] Out-of-memory, reading ASCII files using single processor In-Reply-To: <878ummxves.fsf@jedbrown.org> References: <878ummxves.fsf@jedbrown.org> Message-ID: Hi Jed, Actually the out-of-memory happened when converting ASCII files to petsc format using a serial PETSc program. It seems a single processor doesn't have enough memory to preallocate enough space to store the matrices. Is there any way around it...? Best regards, Jifeng Zhao On Sun, Aug 17, 2014 at 11:40 PM, Jed Brown wrote: > jifeng zhao writes: > > > Hello all, > > > > I am trying to read large matrices from ASCII files and save it into > petsc > > binary format using uni-processor. > > > > But I am encountered a out-of-memory error, when reading too-large ASCII > > file. > > Don't use ASCII. It is a monumentally bad format for parallel > computing. Convert your ASCII files to PETSc binary files (or HDF5, but > PETSc binary is sufficient and simpler), then read in parallel. You can > do this easily in MATLAB or Python, or with a serial PETSc program. > -- Jifeng Zhao PhD candidate at Northwestern University, US Theoretical and Applied Mechanics Program -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 18 10:12:57 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 09:12:57 -0600 Subject: [petsc-users] Out-of-memory, reading ASCII files using single processor In-Reply-To: References: <878ummxves.fsf@jedbrown.org> Message-ID: <87k365x24m.fsf@jedbrown.org> jifeng zhao writes: > Hi Jed, > > Actually the out-of-memory happened when converting ASCII files to petsc > format using a serial PETSc program. > > It seems a single processor doesn't have enough memory to preallocate > enough space to store the matrices. Is there any way around it...? How did you create the matrices in the first place? What ASCII format are you using? -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From bsmith at mcs.anl.gov Mon Aug 18 13:52:36 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 18 Aug 2014 13:52:36 -0500 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: Message-ID: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> I would recommend just using AIJ matrices and not worry about SBAIJ at this stage. SBAIJ can save you memory but not operations and unless memory is really tight is not likely a useful optimization. What eigensolvers have you tried and which eigenvalues do you want? Barry On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: > Dear all, > > I am using PETSC and SLEPC to simulate a problem in MHD, described in http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. > > I have a bit of experience with MPI but not too much with PETSC and SLEPC. So after reading both user manuals and also the relevant chapters of the PETSC developers manual, I still can't get it to work. > > The problem that I have to solve is a large generalized eigenvalue system where the matrices are both Hermitian by blocks and tridiagonal, e.g.: > > ( A11 A12 0 0 0 ) ( B11 B12 0 0 0 ) > ( A12* A22 A23 0 0 ) ( B12* B22 B23 0 0 ) > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 0 ) > ( 0 0 A34* A44 A45) ( 0 0 B34* B44 B45) > ( 0 0 A45* A55 0 ) ( 0 0 B45* B55 0 ) > > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the ugly representation. > > The dimensions of both A and B are around 50 to 100 blocks (as there is a block per discretized point) and the blocks themselves can vary from 1 to more than 100x100 as well (as they correspond to a spectral decomposition). > > Now, my question is: how to solve this economically? > > What I have been trying to do is to make use of the fact that the matrices are Hermitian and by using matcreatesbaij and through the recommended matcreate, matsettype(matsbaij), etc. > > Could someone help me out? All help would be greatly appreciated! > > Thank you in advance, > Toon > UC3M From bsmith at mcs.anl.gov Mon Aug 18 13:56:40 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 18 Aug 2014 13:56:40 -0500 Subject: [petsc-users] Out-of-memory, reading ASCII files using single processor In-Reply-To: References: <878ummxves.fsf@jedbrown.org> Message-ID: What code are you using to do the conversion? Is it reading the ASCII file twice and doing the preallocation of the PETSc matrix correctly? So long as a bit more than one copy of the matrix in compressed sparse row format can fit in your physical memory you should be able to do the conversion. How much physical memory do you have and how many non zeros in your matrix? Barry On Aug 18, 2014, at 9:46 AM, jifeng zhao wrote: > Hi Jed, > > Actually the out-of-memory happened when converting ASCII files to petsc format using a serial PETSc program. > > It seems a single processor doesn't have enough memory to preallocate enough space to store the matrices. Is there any way around it...? > > Best regards, > Jifeng Zhao > > > On Sun, Aug 17, 2014 at 11:40 PM, Jed Brown wrote: > jifeng zhao writes: > > > Hello all, > > > > I am trying to read large matrices from ASCII files and save it into petsc > > binary format using uni-processor. > > > > But I am encountered a out-of-memory error, when reading too-large ASCII > > file. > > Don't use ASCII. It is a monumentally bad format for parallel > computing. Convert your ASCII files to PETSc binary files (or HDF5, but > PETSc binary is sufficient and simpler), then read in parallel. You can > do this easily in MATLAB or Python, or with a serial PETSc program. > > > > -- > Jifeng Zhao > PhD candidate at Northwestern University, US > Theoretical and Applied Mechanics Program From lb2653 at columbia.edu Mon Aug 18 14:28:55 2014 From: lb2653 at columbia.edu (Luc Berger-Vergiat) Date: Mon, 18 Aug 2014 15:28:55 -0400 Subject: [petsc-users] Computing Vector Norm Field wise Message-ID: <53F253F7.2080001@columbi.edu> Hi all, I am using the fieldsplit/DM facility to work on a multiphysics problem. I would like to get some field dependent convergence information. Is there something similar to the VecStrideNorm function that can compute a residual for each field defined in the DM? Or should I use the DM to extract subvectors and compute their norms? -- Best, Luc From knepley at gmail.com Mon Aug 18 14:42:08 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 18 Aug 2014 14:42:08 -0500 Subject: [petsc-users] Computing Vector Norm Field wise In-Reply-To: <53F253F7.2080001@columbi.edu> References: <53F253F7.2080001@columbi.edu> Message-ID: On Aug 18, 2014 2:28 PM, "Luc Berger-Vergiat" wrote: > > Hi all, > I am using the fieldsplit/DM facility to work on a multiphysics problem. > I would like to get some field dependent convergence information. > Is there something similar to the VecStrideNorm function that can compute a residual for each field defined in the DM? > Or should I use the DM to extract subvectors and compute their norms? I wroteca monitor that does this. I am currently out of internet range, but I will mail it Wed when I get back. Thanks Matt > -- > Best, > Luc > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From tweyens at fis.uc3m.es Mon Aug 18 14:54:25 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Mon, 18 Aug 2014 21:54:25 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Hi, thanks for the answers! I think I expressed myself wrong: I can indeed get it to work with just using AIJ matrices, as in example 13. This is the way that I am currently solving my problem. There are only two issues: 1. memory is indeed important so I would certainly like to decrease it by one third if possible :-) The goal is to make the simulations as fast and light as possible to be able to perform parameter studies (on the stability of MHD configurations). 2. I have played around a little bit with the different solvers but it appears that the standard method and the Arnoldi with explicit restart method are the best. Some of the others don't converge and some are slower. The thing is that in the end the matrices that I use are large but they have a very easy structure: hermitian tri-diagonal. That's why, I think, slepc usually converges in a few iterations (correct me if I'm wrong). The problem is that sometimes, when I consider more grid points, the solver doesn't work any more because apparently it uses the LU decomposition (not sure for the matrix A or B in A x = lambda B x) and there is a zero pivot element (see below for error message). In other words: the matrices become almost singular. This is a characteristic of the numerical method I think. Is there any way to fix this by setting a more precise threshold or something? Also, there is one more thing: is it possible and useful to use the non-zero structure of A when defining matrix B? Does this affect perfomance? Thanks in advance! Toon Error messages: identical for KRYLOV-SCHUR and ARNOLDI [0]PETSC ERROR: --------------------- Error Message ------------------------------------ [0]PETSC ERROR: Detected zero pivot in LU factorization: see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance 2.22045e-14! [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 [0]PETSC ERROR: See docs/changes/index.html for recent updates. [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [0]PETSC ERROR: See docs/index.html for manual pages. [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon Mon Aug 18 21:47:41 2014 [0]PETSC ERROR: Libraries linked from /opt/petsc/petsc-3.4.5/debug-complex/lib [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex --with-scalar-type=complex --with-debugging [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: MatPivotCheck_none() line 589 in /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h [0]PETSC ERROR: MatPivotCheck() line 608 in /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c [0]PETSC ERROR: PCSetUp_LU() line 152 in /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c [0]PETSC ERROR: PCSetUp() line 890 in /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c [0]PETSC ERROR: KSPSetUp() line 278 in /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: PCSetUp_Redundant() line 170 in /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c [0]PETSC ERROR: PCSetUp() line 890 in /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c [0]PETSC ERROR: KSPSetUp() line 278 in /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: STSetUp_Shift() line 126 in /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c [0]PETSC ERROR: STSetUp() line 294 in /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c [0]PETSC ERROR: EPSSetUp() line 215 in /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c [0]PETSC ERROR: EPSSolve() line 90 in /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c On 18 August 2014 20:52, Barry Smith wrote: > > I would recommend just using AIJ matrices and not worry about SBAIJ at > this stage. SBAIJ can save you memory but not operations and unless memory > is really tight is not likely a useful optimization. > > What eigensolvers have you tried and which eigenvalues do you want? > > Barry > > On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: > > > Dear all, > > > > I am using PETSC and SLEPC to simulate a problem in MHD, described in > http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. > > > > I have a bit of experience with MPI but not too much with PETSC and > SLEPC. So after reading both user manuals and also the relevant chapters of > the PETSC developers manual, I still can't get it to work. > > > > The problem that I have to solve is a large generalized eigenvalue > system where the matrices are both Hermitian by blocks and tridiagonal, > e.g.: > > > > ( A11 A12 0 0 0 ) ( B11 B12 0 > 0 0 ) > > ( A12* A22 A23 0 0 ) ( B12* B22 B23 > 0 0 ) > > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 > 0 ) > > ( 0 0 A34* A44 A45) ( 0 0 > B34* B44 B45) > > ( 0 0 A45* A55 0 ) ( 0 0 > B45* B55 0 ) > > > > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the > ugly representation. > > > > The dimensions of both A and B are around 50 to 100 blocks (as there is > a block per discretized point) and the blocks themselves can vary from 1 to > more than 100x100 as well (as they correspond to a spectral decomposition). > > > > Now, my question is: how to solve this economically? > > > > What I have been trying to do is to make use of the fact that the > matrices are Hermitian and by using matcreatesbaij and through the > recommended matcreate, matsettype(matsbaij), etc. > > > > Could someone help me out? All help would be greatly appreciated! > > > > Thank you in advance, > > Toon > > UC3M > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From tweyens at fis.uc3m.es Mon Aug 18 15:00:47 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Mon, 18 Aug 2014 22:00:47 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Sorry, I forgot to mention: I am looking for the Eigenvalues that are the largest, *not* in absolute value, but along the real axis. On 18 August 2014 21:54, Toon Weyens wrote: > Hi, thanks for the answers! > > I think I expressed myself wrong: I can indeed get it to work with just > using AIJ matrices, as in example 13. This is the way that I am currently > solving my problem. There are only two issues: > 1. memory is indeed important so I would certainly like to decrease it by > one third if possible :-) The goal is to make the simulations as fast and > light as possible to be able to perform parameter studies (on the stability > of MHD configurations). > > 2. I have played around a little bit with the different solvers but it > appears that the standard method and the Arnoldi with explicit restart > method are the best. Some of the others don't converge and some are slower. > > The thing is that in the end the matrices that I use are large but they > have a very easy structure: hermitian tri-diagonal. That's why, I think, > slepc usually converges in a few iterations (correct me if I'm wrong). > > The problem is that sometimes, when I consider more grid points, the > solver doesn't work any more because apparently it uses the LU > decomposition (not sure for the matrix A or B in A x = lambda B x) and > there is a zero pivot element (see below for error message). In other > words: the matrices become almost singular. This is a characteristic of the > numerical method I think. Is there any way to fix this by setting a more > precise threshold or something? > > Also, there is one more thing: is it possible and useful to use the > non-zero structure of A when defining matrix B? Does this affect perfomance? > > Thanks in advance! > Toon > > > Error messages: identical for KRYLOV-SCHUR and ARNOLDI > > [0]PETSC ERROR: --------------------- Error Message > ------------------------------------ > [0]PETSC ERROR: Detected zero pivot in LU factorization: > see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! > [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance 2.22045e-14! > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 > [0]PETSC ERROR: See docs/changes/index.html for recent updates. > [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. > [0]PETSC ERROR: See docs/index.html for manual pages. > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon Mon > Aug 18 21:47:41 2014 > [0]PETSC ERROR: Libraries linked from > /opt/petsc/petsc-3.4.5/debug-complex/lib > [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 > [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex > --with-scalar-type=complex --with-debugging > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: MatPivotCheck_none() line 589 in > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > [0]PETSC ERROR: MatPivotCheck() line 608 in > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in > /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c > [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in > /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c > [0]PETSC ERROR: PCSetUp_LU() line 152 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c > [0]PETSC ERROR: PCSetUp() line 890 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: KSPSetUp() line 278 in > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: PCSetUp_Redundant() line 170 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c > [0]PETSC ERROR: PCSetUp() line 890 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: KSPSetUp() line 278 in > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: STSetUp_Shift() line 126 in > /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c > [0]PETSC ERROR: STSetUp() line 294 in > /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c > [0]PETSC ERROR: EPSSetUp() line 215 in > /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c > [0]PETSC ERROR: EPSSolve() line 90 in > /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c > > > > On 18 August 2014 20:52, Barry Smith wrote: > >> >> I would recommend just using AIJ matrices and not worry about SBAIJ at >> this stage. SBAIJ can save you memory but not operations and unless memory >> is really tight is not likely a useful optimization. >> >> What eigensolvers have you tried and which eigenvalues do you want? >> >> Barry >> >> On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: >> >> > Dear all, >> > >> > I am using PETSC and SLEPC to simulate a problem in MHD, described in >> http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. >> > >> > I have a bit of experience with MPI but not too much with PETSC and >> SLEPC. So after reading both user manuals and also the relevant chapters of >> the PETSC developers manual, I still can't get it to work. >> > >> > The problem that I have to solve is a large generalized eigenvalue >> system where the matrices are both Hermitian by blocks and tridiagonal, >> e.g.: >> > >> > ( A11 A12 0 0 0 ) ( B11 B12 0 >> 0 0 ) >> > ( A12* A22 A23 0 0 ) ( B12* B22 B23 >> 0 0 ) >> > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 >> 0 ) >> > ( 0 0 A34* A44 A45) ( 0 0 >> B34* B44 B45) >> > ( 0 0 A45* A55 0 ) ( 0 0 >> B45* B55 0 ) >> > >> > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the >> ugly representation. >> > >> > The dimensions of both A and B are around 50 to 100 blocks (as there is >> a block per discretized point) and the blocks themselves can vary from 1 to >> more than 100x100 as well (as they correspond to a spectral decomposition). >> > >> > Now, my question is: how to solve this economically? >> > >> > What I have been trying to do is to make use of the fact that the >> matrices are Hermitian and by using matcreatesbaij and through the >> recommended matcreate, matsettype(matsbaij), etc. >> > >> > Could someone help me out? All help would be greatly appreciated! >> > >> > Thank you in advance, >> > Toon >> > UC3M >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 18 15:12:42 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 14:12:42 -0600 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: <87iolpv9ol.fsf@jedbrown.org> Toon Weyens writes: > Hi, thanks for the answers! > > I think I expressed myself wrong: I can indeed get it to work with just > using AIJ matrices, as in example 13. This is the way that I am currently > solving my problem. There are only two issues: > 1. memory is indeed important so I would certainly like to decrease it by > one third if possible :-) The goal is to make the simulations as fast and > light as possible to be able to perform parameter studies (on the stability > of MHD configurations). What do your matrices represent? If A and B are really tridiagonal, then memory needed for matrix storage is irrelevant because the Krylov vectors will dominate. > 2. I have played around a little bit with the different solvers but it > appears that the standard method and the Arnoldi with explicit restart > method are the best. Some of the others don't converge and some are slower. > > The thing is that in the end the matrices that I use are large but they > have a very easy structure: hermitian tri-diagonal. That's why, I think, > slepc usually converges in a few iterations (correct me if I'm wrong). > > The problem is that sometimes, when I consider more grid points, the solver > doesn't work any more because apparently it uses the LU decomposition (not > sure for the matrix A or B in A x = lambda B x) The factorization is for B because you are not using inversion (usually to target interior eigenvalues or those near 0). What is B? -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From hzhang at mcs.anl.gov Mon Aug 18 15:20:55 2014 From: hzhang at mcs.anl.gov (Hong) Date: Mon, 18 Aug 2014 15:20:55 -0500 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Toon: > > I think I expressed myself wrong: I can indeed get it to work with just > using AIJ matrices, as in example 13. This is the way that I am currently > solving my problem. There are only two issues: > 1. memory is indeed important so I would certainly like to decrease it by > one third if possible :-) The goal is to make the simulations as fast and > light as possible to be able to perform parameter studies (on the stability > of MHD configurations). We need find out where the memory is taken. It seems you are using slepc default krylovschur/sinvert/preonly/lu, lu factorization might consume the most of memory. Run your code with '-eps_view' and find out what solver you are using. > > 2. I have played around a little bit with the different solvers but it > appears that the standard method and the Arnoldi with explicit restart > method are the best. Some of the others don't converge and some are slower. Your problem is symmetric, so you should use: problem type: generalized symmetric eigenvalue problem It seems you are using non-symmetric type. Check it with '-eps_view'. > > The thing is that in the end the matrices that I use are large but they have > a very easy structure: hermitian tri-diagonal. That's why, I think, slepc > usually converges in a few iterations (correct me if I'm wrong). The number of iterations does not depend on the data structure of the matrices, but the location of eigenvalues. > > The problem is that sometimes, when I consider more grid points, the solver > doesn't work any more because apparently it uses the LU decomposition (not > sure for the matrix A or B in A x = lambda B x) and there is a zero pivot > element (see below for error message). In other words: the matrices become > almost singular. This is a characteristic of the numerical method I think. > Is there any way to fix this by setting a more precise threshold or > something? You need carefully select the target of the shift. > > Also, there is one more thing: is it possible and useful to use the non-zero > structure of A when defining matrix B? Does this affect performance? Yes, use same data structure for A and B would make MatAXPY faster, but may not affect much of performance if you only use a single shift, e.g., ex13.c. Hong > > Error messages: identical for KRYLOV-SCHUR and ARNOLDI > > [0]PETSC ERROR: --------------------- Error Message > ------------------------------------ > [0]PETSC ERROR: Detected zero pivot in LU factorization: > see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! > [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance 2.22045e-14! > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 > [0]PETSC ERROR: See docs/changes/index.html for recent updates. > [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. > [0]PETSC ERROR: See docs/index.html for manual pages. > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon Mon > Aug 18 21:47:41 2014 > [0]PETSC ERROR: Libraries linked from > /opt/petsc/petsc-3.4.5/debug-complex/lib > [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 > [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex > --with-scalar-type=complex --with-debugging > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: MatPivotCheck_none() line 589 in > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > [0]PETSC ERROR: MatPivotCheck() line 608 in > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in > /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c > [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in > /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c > [0]PETSC ERROR: PCSetUp_LU() line 152 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c > [0]PETSC ERROR: PCSetUp() line 890 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: KSPSetUp() line 278 in > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: PCSetUp_Redundant() line 170 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c > [0]PETSC ERROR: PCSetUp() line 890 in > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: KSPSetUp() line 278 in > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: STSetUp_Shift() line 126 in > /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c > [0]PETSC ERROR: STSetUp() line 294 in > /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c > [0]PETSC ERROR: EPSSetUp() line 215 in > /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c > [0]PETSC ERROR: EPSSolve() line 90 in > /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c > > > > On 18 August 2014 20:52, Barry Smith wrote: >> >> >> I would recommend just using AIJ matrices and not worry about SBAIJ at >> this stage. SBAIJ can save you memory but not operations and unless memory >> is really tight is not likely a useful optimization. >> >> What eigensolvers have you tried and which eigenvalues do you want? >> >> Barry >> >> On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: >> >> > Dear all, >> > >> > I am using PETSC and SLEPC to simulate a problem in MHD, described in >> > http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. >> > >> > I have a bit of experience with MPI but not too much with PETSC and >> > SLEPC. So after reading both user manuals and also the relevant chapters of >> > the PETSC developers manual, I still can't get it to work. >> > >> > The problem that I have to solve is a large generalized eigenvalue >> > system where the matrices are both Hermitian by blocks and tridiagonal, >> > e.g.: >> > >> > ( A11 A12 0 0 0 ) ( B11 B12 0 >> > 0 0 ) >> > ( A12* A22 A23 0 0 ) ( B12* B22 B23 0 >> > 0 ) >> > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 >> > 0 ) >> > ( 0 0 A34* A44 A45) ( 0 0 >> > B34* B44 B45) >> > ( 0 0 A45* A55 0 ) ( 0 0 >> > B45* B55 0 ) >> > >> > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the >> > ugly representation. >> > >> > The dimensions of both A and B are around 50 to 100 blocks (as there is >> > a block per discretized point) and the blocks themselves can vary from 1 to >> > more than 100x100 as well (as they correspond to a spectral decomposition). >> > >> > Now, my question is: how to solve this economically? >> > >> > What I have been trying to do is to make use of the fact that the >> > matrices are Hermitian and by using matcreatesbaij and through the >> > recommended matcreate, matsettype(matsbaij), etc. >> > >> > Could someone help me out? All help would be greatly appreciated! >> > >> > Thank you in advance, >> > Toon >> > UC3M >> > From hzhang at mcs.anl.gov Mon Aug 18 15:24:51 2014 From: hzhang at mcs.anl.gov (Hong) Date: Mon, 18 Aug 2014 15:24:51 -0500 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Toon : > Sorry, I forgot to mention: I am looking for the Eigenvalues that are the > largest, not in absolute value, but along the real axis. Then, you do not need shift-invert, therefore, should not use LU matrix factorization. Hong > > > On 18 August 2014 21:54, Toon Weyens wrote: >> >> Hi, thanks for the answers! >> >> I think I expressed myself wrong: I can indeed get it to work with just >> using AIJ matrices, as in example 13. This is the way that I am currently >> solving my problem. There are only two issues: >> 1. memory is indeed important so I would certainly like to decrease it by >> one third if possible :-) The goal is to make the simulations as fast and >> light as possible to be able to perform parameter studies (on the stability >> of MHD configurations). >> >> 2. I have played around a little bit with the different solvers but it >> appears that the standard method and the Arnoldi with explicit restart >> method are the best. Some of the others don't converge and some are slower. >> >> The thing is that in the end the matrices that I use are large but they >> have a very easy structure: hermitian tri-diagonal. That's why, I think, >> slepc usually converges in a few iterations (correct me if I'm wrong). >> >> The problem is that sometimes, when I consider more grid points, the >> solver doesn't work any more because apparently it uses the LU decomposition >> (not sure for the matrix A or B in A x = lambda B x) and there is a zero >> pivot element (see below for error message). In other words: the matrices >> become almost singular. This is a characteristic of the numerical method I >> think. Is there any way to fix this by setting a more precise threshold or >> something? >> >> Also, there is one more thing: is it possible and useful to use the >> non-zero structure of A when defining matrix B? Does this affect perfomance? >> >> Thanks in advance! >> Toon >> >> >> Error messages: identical for KRYLOV-SCHUR and ARNOLDI >> >> [0]PETSC ERROR: --------------------- Error Message >> ------------------------------------ >> [0]PETSC ERROR: Detected zero pivot in LU factorization: >> see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! >> [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance 2.22045e-14! >> [0]PETSC ERROR: >> ------------------------------------------------------------------------ >> [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 >> [0]PETSC ERROR: See docs/changes/index.html for recent updates. >> [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. >> [0]PETSC ERROR: See docs/index.html for manual pages. >> [0]PETSC ERROR: >> ------------------------------------------------------------------------ >> [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon Mon >> Aug 18 21:47:41 2014 >> [0]PETSC ERROR: Libraries linked from >> /opt/petsc/petsc-3.4.5/debug-complex/lib >> [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 >> [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex >> --with-scalar-type=complex --with-debugging >> [0]PETSC ERROR: >> ------------------------------------------------------------------------ >> [0]PETSC ERROR: MatPivotCheck_none() line 589 in >> /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h >> [0]PETSC ERROR: MatPivotCheck() line 608 in >> /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h >> [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in >> /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c >> [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in >> /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c >> [0]PETSC ERROR: PCSetUp_LU() line 152 in >> /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c >> [0]PETSC ERROR: PCSetUp() line 890 in >> /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c >> [0]PETSC ERROR: KSPSetUp() line 278 in >> /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c >> [0]PETSC ERROR: PCSetUp_Redundant() line 170 in >> /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c >> [0]PETSC ERROR: PCSetUp() line 890 in >> /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c >> [0]PETSC ERROR: KSPSetUp() line 278 in >> /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c >> [0]PETSC ERROR: STSetUp_Shift() line 126 in >> /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c >> [0]PETSC ERROR: STSetUp() line 294 in >> /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c >> [0]PETSC ERROR: EPSSetUp() line 215 in >> /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c >> [0]PETSC ERROR: EPSSolve() line 90 in >> /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c >> >> >> >> On 18 August 2014 20:52, Barry Smith wrote: >>> >>> >>> I would recommend just using AIJ matrices and not worry about SBAIJ at >>> this stage. SBAIJ can save you memory but not operations and unless memory >>> is really tight is not likely a useful optimization. >>> >>> What eigensolvers have you tried and which eigenvalues do you want? >>> >>> Barry >>> >>> On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: >>> >>> > Dear all, >>> > >>> > I am using PETSC and SLEPC to simulate a problem in MHD, described in >>> > http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. >>> > >>> > I have a bit of experience with MPI but not too much with PETSC and >>> > SLEPC. So after reading both user manuals and also the relevant chapters of >>> > the PETSC developers manual, I still can't get it to work. >>> > >>> > The problem that I have to solve is a large generalized eigenvalue >>> > system where the matrices are both Hermitian by blocks and tridiagonal, >>> > e.g.: >>> > >>> > ( A11 A12 0 0 0 ) ( B11 B12 0 >>> > 0 0 ) >>> > ( A12* A22 A23 0 0 ) ( B12* B22 B23 >>> > 0 0 ) >>> > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 >>> > 0 ) >>> > ( 0 0 A34* A44 A45) ( 0 0 >>> > B34* B44 B45) >>> > ( 0 0 A45* A55 0 ) ( 0 0 >>> > B45* B55 0 ) >>> > >>> > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the >>> > ugly representation. >>> > >>> > The dimensions of both A and B are around 50 to 100 blocks (as there is >>> > a block per discretized point) and the blocks themselves can vary from 1 to >>> > more than 100x100 as well (as they correspond to a spectral decomposition). >>> > >>> > Now, my question is: how to solve this economically? >>> > >>> > What I have been trying to do is to make use of the fact that the >>> > matrices are Hermitian and by using matcreatesbaij and through the >>> > recommended matcreate, matsettype(matsbaij), etc. >>> > >>> > Could someone help me out? All help would be greatly appreciated! >>> > >>> > Thank you in advance, >>> > Toon >>> > UC3M >>> >> > From jed at jedbrown.org Mon Aug 18 15:32:18 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 14:32:18 -0600 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: <87bnrhv8rx.fsf@jedbrown.org> Hong writes: > Toon : >> Sorry, I forgot to mention: I am looking for the Eigenvalues that are the >> largest, not in absolute value, but along the real axis. > > Then, you do not need shift-invert, therefore, should not use LU > matrix factorization. The error is in STSetUp_Shift, not STSetUp_Sinvert. This is a generalized eigenvalue problem. Of course you can change the PC, but I think we should understand the problem first. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From ppate024 at odu.edu Mon Aug 18 17:23:52 2014 From: ppate024 at odu.edu (Priyank Patel) Date: Mon, 18 Aug 2014 18:23:52 -0400 Subject: [petsc-users] problem in divide the matrix between processes for MatCreateMPIAIJWithArrays() Message-ID: <1DC0271D-1AFB-4B80-8C23-15E12D9A83D1@odu.edu> Hello, I am trying to divide the rows between the processes for MatCreateMPIAIJWithArrays() but I am unable to create a fully functional code for that. Is there any easy way to do it or is there anybody who have any ready code that I can use to divide the rows to use in MatCreateMPIAIJWithArrays(). Thanks, Priyank Patel ppate024 at odu.edu Priyank Patel ppate024 at odu.edu -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 18 17:30:41 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 18 Aug 2014 16:30:41 -0600 Subject: [petsc-users] problem in divide the matrix between processes for MatCreateMPIAIJWithArrays() In-Reply-To: <1DC0271D-1AFB-4B80-8C23-15E12D9A83D1@odu.edu> References: <1DC0271D-1AFB-4B80-8C23-15E12D9A83D1@odu.edu> Message-ID: <87sikttoq6.fsf@jedbrown.org> Priyank Patel writes: > Hello, > I am trying to divide the rows between the processes for MatCreateMPIAIJWithArrays() but I am unable to create a fully functional code for that. > Is there any easy way to do it or is there anybody who have any ready code that I can use to divide the rows to use in MatCreateMPIAIJWithArrays(). You should really use MatSetValues. It is unconditionally better for memory usage and flexibility. MatCreateMPIAIJWithArrays exists for people that already made a mistake in their software by manually building these useless arrays (you can't compute with them directly), refuse to update their code, but insist on passing them to PETSc. If you don't already have exactly the right arrays, you definitely shouldn't use the function. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From tweyens at fis.uc3m.es Tue Aug 19 06:05:01 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Tue, 19 Aug 2014 13:05:01 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Thanks for the answers! First of all, I indeed didn't specify GHEP because if I do, it gives me the message "IPNorm: The inner product is not well defined!" (see below). If I do the same calculation with LAPACK, it does work. And if I compare the Eigenvalues of the GHEP LAPACK simulation and the NHEP (standard) Krylov-Schur simulation, there is a relative difference between both of about 1E-10 (while the solution states that the rel. error is about 1E-14, anyway) So, if I try to do the same thing as in ex. 13, and set the Spectral Type to STSINVERT, it takes the error away for Krylov-Schur, but the solver does not find a solution. For Lanczos and Arnoldi with explicit restart, the error remains. The problem is that I don't really have any idea about what I'm doing! Anyway, here is what I need to do: My matrices A and B correspond to the potential energy and the kinetic energy of a plasma, respectively. It is very similar to the calculation of energy levels of quantum systems: you perturb the energy of the system while holding the kinetic energy of the perturbation constant. Minimizing this leads to the discrete (and continuous) energy levels. In this case, of the plasma system. If the eigenvalues are positive, this means that there is an exploding solution (the EV are the squares of the actual time evolution appearing in an exponential: e^(i sqrt(lambda) t)) So, when abstracting boundary conditions, using spectral transforms in 2 dimensions and finite differences in the third, I get two matrices A and B, both hermitian. I do as follows (FORTRAN): matrices: - call MatCreateAIJ explicitely giving the sizes of each processor - call MatGetOwnershipRange to find the ownership and determine which blocks to put - call call MatSetValues with INSERT_VALUES to put these blocks in the matrices - call MatAssemblyBegin and End to assemble them EPS: - call EPSCreate - call EPSSetOperators - call EPSSetProblemType with GHEP -> gives the error about the IPnorm, so I leave it out - call EPSSetWhichEigenpairs with EPS_LARGEST_REAL - call EPSSetFromOptions (why do I need to do this?) - call EPSSolve That's it... Thank you again in advance! Toon On 18 August 2014 22:20, Hong wrote: > Toon: > > > > I think I expressed myself wrong: I can indeed get it to work with just > > using AIJ matrices, as in example 13. This is the way that I am currently > > solving my problem. There are only two issues: > > 1. memory is indeed important so I would certainly like to decrease it by > > one third if possible :-) The goal is to make the simulations as fast and > > light as possible to be able to perform parameter studies (on the > stability > > of MHD configurations). > > We need find out where the memory is taken. It seems you are using > slepc default krylovschur/sinvert/preonly/lu, lu factorization might > consume the most of memory. Run your code with '-eps_view' and find > out what solver you are using. > > > > 2. I have played around a little bit with the different solvers but it > > appears that the standard method and the Arnoldi with explicit restart > > method are the best. Some of the others don't converge and some are > slower. > > Your problem is symmetric, so you should use: > problem type: generalized symmetric eigenvalue problem > It seems you are using non-symmetric type. Check it with '-eps_view'. > > > > The thing is that in the end the matrices that I use are large but they > have > > a very easy structure: hermitian tri-diagonal. That's why, I think, slepc > > usually converges in a few iterations (correct me if I'm wrong). > > The number of iterations does not depend on the data structure of the > matrices, but the location of eigenvalues. > > > > The problem is that sometimes, when I consider more grid points, the > solver > > doesn't work any more because apparently it uses the LU decomposition > (not > > sure for the matrix A or B in A x = lambda B x) and there is a zero pivot > > element (see below for error message). In other words: the matrices > become > > almost singular. This is a characteristic of the numerical method I > think. > > Is there any way to fix this by setting a more precise threshold or > > something? > > You need carefully select the target of the shift. > > > > Also, there is one more thing: is it possible and useful to use the > non-zero > > structure of A when defining matrix B? Does this affect performance? > > Yes, use same data structure for A and B would make MatAXPY faster, > but may not affect much of performance if you only use a single shift, > e.g., ex13.c. > > Hong > > > > > Error messages: identical for KRYLOV-SCHUR and ARNOLDI > > > > [0]PETSC ERROR: --------------------- Error Message > > ------------------------------------ > > [0]PETSC ERROR: Detected zero pivot in LU factorization: > > see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! > > [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance > 2.22045e-14! > > [0]PETSC ERROR: > > ------------------------------------------------------------------------ > > [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 > > [0]PETSC ERROR: See docs/changes/index.html for recent updates. > > [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. > > [0]PETSC ERROR: See docs/index.html for manual pages. > > [0]PETSC ERROR: > > ------------------------------------------------------------------------ > > [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon > Mon > > Aug 18 21:47:41 2014 > > [0]PETSC ERROR: Libraries linked from > > /opt/petsc/petsc-3.4.5/debug-complex/lib > > [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 > > [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex > > --with-scalar-type=complex --with-debugging > > [0]PETSC ERROR: > > ------------------------------------------------------------------------ > > [0]PETSC ERROR: MatPivotCheck_none() line 589 in > > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > > [0]PETSC ERROR: MatPivotCheck() line 608 in > > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h > > [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in > > /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c > > [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in > > /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c > > [0]PETSC ERROR: PCSetUp_LU() line 152 in > > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c > > [0]PETSC ERROR: PCSetUp() line 890 in > > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: KSPSetUp() line 278 in > > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > > [0]PETSC ERROR: PCSetUp_Redundant() line 170 in > > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c > > [0]PETSC ERROR: PCSetUp() line 890 in > > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: KSPSetUp() line 278 in > > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c > > [0]PETSC ERROR: STSetUp_Shift() line 126 in > > /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c > > [0]PETSC ERROR: STSetUp() line 294 in > > /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c > > [0]PETSC ERROR: EPSSetUp() line 215 in > > /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c > > [0]PETSC ERROR: EPSSolve() line 90 in > > /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c > > > > > > > > On 18 August 2014 20:52, Barry Smith wrote: > >> > >> > >> I would recommend just using AIJ matrices and not worry about SBAIJ > at > >> this stage. SBAIJ can save you memory but not operations and unless > memory > >> is really tight is not likely a useful optimization. > >> > >> What eigensolvers have you tried and which eigenvalues do you want? > >> > >> Barry > >> > >> On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: > >> > >> > Dear all, > >> > > >> > I am using PETSC and SLEPC to simulate a problem in MHD, described in > >> > > http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. > >> > > >> > I have a bit of experience with MPI but not too much with PETSC and > >> > SLEPC. So after reading both user manuals and also the relevant > chapters of > >> > the PETSC developers manual, I still can't get it to work. > >> > > >> > The problem that I have to solve is a large generalized eigenvalue > >> > system where the matrices are both Hermitian by blocks and > tridiagonal, > >> > e.g.: > >> > > >> > ( A11 A12 0 0 0 ) ( B11 B12 0 > >> > 0 0 ) > >> > ( A12* A22 A23 0 0 ) ( B12* B22 B23 > 0 > >> > 0 ) > >> > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 > >> > 0 ) > >> > ( 0 0 A34* A44 A45) ( 0 0 > >> > B34* B44 B45) > >> > ( 0 0 A45* A55 0 ) ( 0 0 > >> > B45* B55 0 ) > >> > > >> > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the > >> > ugly representation. > >> > > >> > The dimensions of both A and B are around 50 to 100 blocks (as there > is > >> > a block per discretized point) and the blocks themselves can vary > from 1 to > >> > more than 100x100 as well (as they correspond to a spectral > decomposition). > >> > > >> > Now, my question is: how to solve this economically? > >> > > >> > What I have been trying to do is to make use of the fact that the > >> > matrices are Hermitian and by using matcreatesbaij and through the > >> > recommended matcreate, matsettype(matsbaij), etc. > >> > > >> > Could someone help me out? All help would be greatly appreciated! > >> > > >> > Thank you in advance, > >> > Toon > >> > UC3M > >> > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From tweyens at fis.uc3m.es Tue Aug 19 06:07:38 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Tue, 19 Aug 2014 13:07:38 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: Okay I reread again your answers and it seems that I missed the fact that I do not need shift invert to find the EV with the largest real part? Then the "trick" of ex. 13 does not apply (they look for something close to 0). So what could I do to avoid the LU? On 19 August 2014 13:05, Toon Weyens wrote: > Thanks for the answers! > > First of all, I indeed didn't specify GHEP because if I do, it gives me > the message "IPNorm: The inner product is not well defined!" (see below). > If I do the same calculation with LAPACK, it does work. And if I compare > the Eigenvalues of the GHEP LAPACK simulation and the NHEP (standard) > Krylov-Schur simulation, there is a relative difference between both of > about 1E-10 (while the solution states that the rel. error is about 1E-14, > anyway) > > So, if I try to do the same thing as in ex. 13, and set the Spectral Type > to STSINVERT, it takes the error away for Krylov-Schur, but the solver does > not find a solution. For Lanczos and Arnoldi with explicit restart, the > error remains. The problem is that I don't really have any idea about what > I'm doing! > > Anyway, here is what I need to do: My matrices A and B correspond to the > potential energy and the kinetic energy of a plasma, respectively. It is > very similar to the calculation of energy levels of quantum systems: you > perturb the energy of the system while holding the kinetic energy of the > perturbation constant. Minimizing this leads to the discrete (and > continuous) energy levels. In this case, of the plasma system. If the > eigenvalues are positive, this means that there is an exploding solution > (the EV are the squares of the actual time evolution appearing in an > exponential: e^(i sqrt(lambda) t)) > > So, when abstracting boundary conditions, using spectral transforms in 2 > dimensions and finite differences in the third, I get two matrices A and B, > both hermitian. > > I do as follows (FORTRAN): > > matrices: > - call MatCreateAIJ explicitely giving the sizes of each processor > - call MatGetOwnershipRange to find the ownership and determine which > blocks to put > - call call MatSetValues with INSERT_VALUES to put these blocks in the > matrices > - call MatAssemblyBegin and End to assemble them > > EPS: > - call EPSCreate > - call EPSSetOperators > - call EPSSetProblemType with GHEP -> gives the error about the IPnorm, so > I leave it out > - call EPSSetWhichEigenpairs with EPS_LARGEST_REAL > - call EPSSetFromOptions (why do I need to do this?) > - call EPSSolve > > That's it... > > Thank you again in advance! > Toon > > > > On 18 August 2014 22:20, Hong wrote: > >> Toon: >> > >> > I think I expressed myself wrong: I can indeed get it to work with just >> > using AIJ matrices, as in example 13. This is the way that I am >> currently >> > solving my problem. There are only two issues: >> > 1. memory is indeed important so I would certainly like to decrease it >> by >> > one third if possible :-) The goal is to make the simulations as fast >> and >> > light as possible to be able to perform parameter studies (on the >> stability >> > of MHD configurations). >> >> We need find out where the memory is taken. It seems you are using >> slepc default krylovschur/sinvert/preonly/lu, lu factorization might >> consume the most of memory. Run your code with '-eps_view' and find >> out what solver you are using. >> > >> > 2. I have played around a little bit with the different solvers but it >> > appears that the standard method and the Arnoldi with explicit restart >> > method are the best. Some of the others don't converge and some are >> slower. >> >> Your problem is symmetric, so you should use: >> problem type: generalized symmetric eigenvalue problem >> It seems you are using non-symmetric type. Check it with '-eps_view'. >> > >> > The thing is that in the end the matrices that I use are large but they >> have >> > a very easy structure: hermitian tri-diagonal. That's why, I think, >> slepc >> > usually converges in a few iterations (correct me if I'm wrong). >> >> The number of iterations does not depend on the data structure of the >> matrices, but the location of eigenvalues. >> > >> > The problem is that sometimes, when I consider more grid points, the >> solver >> > doesn't work any more because apparently it uses the LU decomposition >> (not >> > sure for the matrix A or B in A x = lambda B x) and there is a zero >> pivot >> > element (see below for error message). In other words: the matrices >> become >> > almost singular. This is a characteristic of the numerical method I >> think. >> > Is there any way to fix this by setting a more precise threshold or >> > something? >> >> You need carefully select the target of the shift. >> > >> > Also, there is one more thing: is it possible and useful to use the >> non-zero >> > structure of A when defining matrix B? Does this affect performance? >> >> Yes, use same data structure for A and B would make MatAXPY faster, >> but may not affect much of performance if you only use a single shift, >> e.g., ex13.c. >> >> Hong >> >> > >> > Error messages: identical for KRYLOV-SCHUR and ARNOLDI >> > >> > [0]PETSC ERROR: --------------------- Error Message >> > ------------------------------------ >> > [0]PETSC ERROR: Detected zero pivot in LU factorization: >> > see http://www.mcs.anl.gov/petsc/documentation/faq.html#ZeroPivot! >> > [0]PETSC ERROR: Zero pivot row 19 value 6.57877e-16 tolerance >> 2.22045e-14! >> > [0]PETSC ERROR: >> > ------------------------------------------------------------------------ >> > [0]PETSC ERROR: Petsc Release Version 3.4.5, Jun, 29, 2014 >> > [0]PETSC ERROR: See docs/changes/index.html for recent updates. >> > [0]PETSC ERROR: See docs/faq.html for hints about trouble shooting. >> > [0]PETSC ERROR: See docs/index.html for manual pages. >> > [0]PETSC ERROR: >> > ------------------------------------------------------------------------ >> > [0]PETSC ERROR: ./PB3D on a debug-complex named toon-XPS-L501X by toon >> Mon >> > Aug 18 21:47:41 2014 >> > [0]PETSC ERROR: Libraries linked from >> > /opt/petsc/petsc-3.4.5/debug-complex/lib >> > [0]PETSC ERROR: Configure run at Mon Aug 11 10:08:29 2014 >> > [0]PETSC ERROR: Configure options PETSC_ARCH=debug-complex >> > --with-scalar-type=complex --with-debugging >> > [0]PETSC ERROR: >> > ------------------------------------------------------------------------ >> > [0]PETSC ERROR: MatPivotCheck_none() line 589 in >> > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h >> > [0]PETSC ERROR: MatPivotCheck() line 608 in >> > /opt/petsc/petsc-3.4.5/include/petsc-private/matimpl.h >> > [0]PETSC ERROR: MatLUFactorNumeric_SeqAIJ_Inode() line 1837 in >> > /opt/petsc/petsc-3.4.5/src/mat/impls/aij/seq/inode.c >> > [0]PETSC ERROR: MatLUFactorNumeric() line 2889 in >> > /opt/petsc/petsc-3.4.5/src/mat/interface/matrix.c >> > [0]PETSC ERROR: PCSetUp_LU() line 152 in >> > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/factor/lu/lu.c >> > [0]PETSC ERROR: PCSetUp() line 890 in >> > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: KSPSetUp() line 278 in >> > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c >> > [0]PETSC ERROR: PCSetUp_Redundant() line 170 in >> > /opt/petsc/petsc-3.4.5/src/ksp/pc/impls/redundant/redundant.c >> > [0]PETSC ERROR: PCSetUp() line 890 in >> > /opt/petsc/petsc-3.4.5/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: KSPSetUp() line 278 in >> > /opt/petsc/petsc-3.4.5/src/ksp/ksp/interface/itfunc.c >> > [0]PETSC ERROR: STSetUp_Shift() line 126 in >> > /opt/slepc/slepc-3.4.4/src/st/impls/shift/shift.c >> > [0]PETSC ERROR: STSetUp() line 294 in >> > /opt/slepc/slepc-3.4.4/src/st/interface/stsolve.c >> > [0]PETSC ERROR: EPSSetUp() line 215 in >> > /opt/slepc/slepc-3.4.4/src/eps/interface/setup.c >> > [0]PETSC ERROR: EPSSolve() line 90 in >> > /opt/slepc/slepc-3.4.4/src/eps/interface/solve.c >> > >> > >> > >> > On 18 August 2014 20:52, Barry Smith wrote: >> >> >> >> >> >> I would recommend just using AIJ matrices and not worry about SBAIJ >> at >> >> this stage. SBAIJ can save you memory but not operations and unless >> memory >> >> is really tight is not likely a useful optimization. >> >> >> >> What eigensolvers have you tried and which eigenvalues do you want? >> >> >> >> Barry >> >> >> >> On Aug 18, 2014, at 5:46 AM, Toon Weyens wrote: >> >> >> >> > Dear all, >> >> > >> >> > I am using PETSC and SLEPC to simulate a problem in MHD, described in >> >> > >> http://scitation.aip.org/content/aip/journal/pop/21/4/10.1063/1.4871859. >> >> > >> >> > I have a bit of experience with MPI but not too much with PETSC and >> >> > SLEPC. So after reading both user manuals and also the relevant >> chapters of >> >> > the PETSC developers manual, I still can't get it to work. >> >> > >> >> > The problem that I have to solve is a large generalized eigenvalue >> >> > system where the matrices are both Hermitian by blocks and >> tridiagonal, >> >> > e.g.: >> >> > >> >> > ( A11 A12 0 0 0 ) ( B11 B12 >> 0 >> >> > 0 0 ) >> >> > ( A12* A22 A23 0 0 ) ( B12* B22 >> B23 0 >> >> > 0 ) >> >> > ( 0 A23* A33 A34 0 ) = lambda ( 0 B23* B33 B34 >> >> > 0 ) >> >> > ( 0 0 A34* A44 A45) ( 0 0 >> >> > B34* B44 B45) >> >> > ( 0 0 A45* A55 0 ) ( 0 0 >> >> > B45* B55 0 ) >> >> > >> >> > where Aii = Aii*, with * the Hermitian conjugate. I apologize for the >> >> > ugly representation. >> >> > >> >> > The dimensions of both A and B are around 50 to 100 blocks (as there >> is >> >> > a block per discretized point) and the blocks themselves can vary >> from 1 to >> >> > more than 100x100 as well (as they correspond to a spectral >> decomposition). >> >> > >> >> > Now, my question is: how to solve this economically? >> >> > >> >> > What I have been trying to do is to make use of the fact that the >> >> > matrices are Hermitian and by using matcreatesbaij and through the >> >> > recommended matcreate, matsettype(matsbaij), etc. >> >> > >> >> > Could someone help me out? All help would be greatly appreciated! >> >> > >> >> > Thank you in advance, >> >> > Toon >> >> > UC3M >> >> >> > >> > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Tue Aug 19 07:53:29 2014 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Tue, 19 Aug 2014 12:53:29 +0000 Subject: [petsc-users] MatNestGetISs in fortran In-Reply-To: References: <64c4658aeb7441abbe20e4aa252554a2@MAR190N1.marin.local>, , <67a2f55136204b4987ae899b3d0a9064@MAR190n2.marin.local>, Message-ID: <7c024f8edceb42c399bd3a0b56aa1ebc@MAR190n2.marin.local> MatNestGetISs works as expected in fortran with petsc-3.5.1. Thanks! Chris ________________________________________ From: Satish Balay Sent: Monday, July 07, 2014 6:37 PM To: Klaij, Christiaan Cc: petsc-users Subject: Re: [petsc-users] MatNestGetISs in fortran My change is in petsc-3.5. You can upgrade and see if it works for you.. Satish On Mon, 7 Jul 2014, Klaij, Christiaan wrote: > Satish, > > Thanks for your reply! I've been on holiday for some time, do you still want me to test this or has it been fixed with the 3.5 release? > > Chris > > ________________________________________ > From: Satish Balay > Sent: Monday, June 16, 2014 5:41 PM > To: Klaij, Christiaan > Cc: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] MatNestGetISs in fortran > > perhaps this routine does not need custom fortran interface. > > Does the attached src/mat/impls/nest/ftn-auto/matnestf.c work [with petsc-3.4]? > > If so - I'll add this to petsc dev [master] > > thanks, > Satish > > On Fri, 13 Jun 2014, Klaij, Christiaan wrote: > > > Perhaps this message from May 27 "slipped through the email cracks" as Matt puts it? > > > > Chris > > > > > > dr. ir. Christiaan Klaij > > CFD Researcher > > Research & Development > > E mailto:C.Klaij at marin.nl > > T +31 317 49 33 44 > > > > > > MARIN > > 2, Haagsteeg, P.O. Box 28, 6700 AA Wageningen, The Netherlands > > T +31 317 49 39 11, F +31 317 49 32 45, I www.marin.nl > > > > ________________________________________ > > From: Klaij, Christiaan > > Sent: Monday, June 02, 2014 9:54 AM > > To: petsc-users at mcs.anl.gov > > Subject: RE: MatNestGetISs in fortran > > > > Just a reminder. Could you please add fortran support for MatNestGetISs? > > ________________________________________ > > From: Klaij, Christiaan > > Sent: Tuesday, May 27, 2014 3:47 PM > > To: petsc-users at mcs.anl.gov > > Subject: MatNestGetISs in fortran > > > > I'm trying to use MatNestGetISs in a fortran program but it seems to be missing from the fortran include file (PETSc 3.4). > > > > > From jed at jedbrown.org Tue Aug 19 08:40:35 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 19 Aug 2014 07:40:35 -0600 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> Message-ID: <87mwb0silo.fsf@jedbrown.org> Toon Weyens writes: > Okay I reread again your answers and it seems that I missed the fact that I > do not need shift invert to find the EV with the largest real part? Correct, inversion is way more expensive and used to find internal eigenvalues. > Then the "trick" of ex. 13 does not apply (they look for something > close to 0). So what could I do to avoid the LU? Is your matrix B singular? What are its boundary conditions? You have to solve with B for the generalized eigenvalue problem. That could be done iteratively, but a direct solve makes sense for a tridiagonal system and the zero pivot likely indicates a deeper issue with the formulation that won't vanish simply by avoiding LU. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jed at jedbrown.org Tue Aug 19 10:17:21 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 19 Aug 2014 09:17:21 -0600 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: References: Message-ID: <878umkse4e.fsf@jedbrown.org> Mark Adams writes: > I am creating an Schur complement matrix explicitly (solver%schur) and > setting it with code like: > > call SNESGetKSP(solver%snes,innerksp,ierr) > call KSPGetPC(innerksp,spc,ierr) > call > PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) > > I would think that the "inner" solver would not be used but it is getting > used. [...] > PC Object:(fsa_) 4 MPI processes > type: fieldsplit > FieldSplit with Schur preconditioner, factorization FULL > Preconditioner for the Schur complement formed from A11 I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then watch -l jac->schurpre since it appears that your information is being lost somewhere. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From tweyens at fis.uc3m.es Tue Aug 19 10:22:06 2014 From: tweyens at fis.uc3m.es (Toon Weyens) Date: Tue, 19 Aug 2014 17:22:06 +0200 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: <87mwb0silo.fsf@jedbrown.org> References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> <87mwb0silo.fsf@jedbrown.org> Message-ID: Yes, you are probably right: My code is not yet bug free (by all means!). However, I have been working very hard on it and I will see if I find something. B should not ever be really singular! I do, however, still have some questions: - Does slepc detect whether my matrix is tridiagonal and does it apply a direct method to solve it? Or do you talk about it in general: that it would be better for me to use a direct method that is not part of slepc? - How do I make use of the information that both A and B have the same non-zero structure? Is there an easy way? - What is the call "MatSetOption(mat,MAT_HERMITIAN,PETSC_TRUE,ierr)" do? Is it important? It does not seem to influence anything... Thank you for your time and pacience! Toon On 19 August 2014 15:40, Jed Brown wrote: > Toon Weyens writes: > > > Okay I reread again your answers and it seems that I missed the fact > that I > > do not need shift invert to find the EV with the largest real part? > > Correct, inversion is way more expensive and used to find internal > eigenvalues. > > > Then the "trick" of ex. 13 does not apply (they look for something > > close to 0). So what could I do to avoid the LU? > > Is your matrix B singular? What are its boundary conditions? You have > to solve with B for the generalized eigenvalue problem. That could be > done iteratively, but a direct solve makes sense for a tridiagonal > system and the zero pivot likely indicates a deeper issue with the > formulation that won't vanish simply by avoiding LU. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Tue Aug 19 10:38:16 2014 From: jed at jedbrown.org (Jed Brown) Date: Tue, 19 Aug 2014 09:38:16 -0600 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> <87mwb0silo.fsf@jedbrown.org> Message-ID: <8738cssd5j.fsf@jedbrown.org> Toon Weyens writes: > Yes, you are probably right: My code is not yet bug free (by all means!). > However, I have been working very hard on it and I will see if I find > something. B should not ever be really singular! > > I do, however, still have some questions: > > - Does slepc detect whether my matrix is tridiagonal and does it apply a > direct method to solve it? Or do you talk about it in general: that it > would be better for me to use a direct method that is not part of slepc? The direct method is just a default. For a tridiagonal matrix, there is no fill, so direct methods have great complexity. For other problems (multi-dimensional, etc.) the direct solver has fill and becomes asymptotically suboptimal. > - How do I make use of the information that both A and B have the same > non-zero structure? Is there an easy way? I don't think it could make any difference for your scenario. > - What is the call "MatSetOption(mat,MAT_HERMITIAN,PETSC_TRUE,ierr)" do? Is > it important? It does not seem to influence anything... In some circumstances, it would cause a method to default to Lanczos instead of Arnoldi, or Cholesky instead of LU. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From priyankpatel22 at live.com Tue Aug 19 11:39:29 2014 From: priyankpatel22 at live.com (priyank patel) Date: Tue, 19 Aug 2014 12:39:29 -0400 Subject: [petsc-users] Convert matrix to 1-D array Message-ID: Hello, I have a matrix generated from matrix matrix multiplication. I want that matrix to convert to 1 dimensional array. my code is as below ##################################################### //Multiplication A * B (A is MPIAIJ & B is MPIDENSE) MatMatMult(A, B, MAT_INITIAL_MATRIX, PETSC_DEFAULT, &C); MatView(C,PETSC_VIEWER_STDOUT_WORLD); //Convert Matrix C to 1D vector h_C for(i = 0; i < m; i++) { for(j = 0; j < k; j++) { ierr = MatGetValues(C, 1, &i, 1, &j, &h_C[IDX2C(i,j,end1)]);CHKERRQ(ierr); } } //printArray(h_B, m, k, "h_B"); printArray(h_C, m, k, "A * X0"); ##################################################### when I tried the routine MatGetValues() it shows some error as below ##################################################### --------------------- Error Message ------------------------------------ [1]PETSC ERROR: No support for this operation for this object type! [1]PETSC ERROR: Only local values currently supported! [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Petsc Release Version 3.3.0, Patch 0, Tue Jun 5 14:20:42 CDT 2012 [1]PETSC ERROR: See docs/changes/index.html for recent updates. [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. [1]PETSC ERROR: See docs/index.html for manual pages. [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: ./blockCG_1 on a arch-linu named hpcd.cs.odu.edu by ppatel Tue Aug 19 12:29:41 2014 [1]PETSC ERROR: Libraries linked from /export/software/petsc-3.3/lib [1]PETSC ERROR: Configure run at Wed Jun 6 16:29:21 2012 [1]PETSC ERROR: Configure options --prefix=/export/software/petsc-3.3 --download-f-blas-lapack=1 [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: MatGetValues_MPIDense() line 180 in src/mat/impls/dense/mpi/mpidense.c [1]PETSC ERROR: MatGetValues() line 1602 in src/mat/interface/matrix.c [1]PETSC ERROR: main() line 343 in blockCG_1.c -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD with errorcode 56. NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. You may or may not see output from other processes, depending on exactly when Open MPI kills them. -------------------------------------------------------------------------- ##################################################### what is the efficient way to create a 1-D array from the PETSC matrix? -------------- next part -------------- An HTML attachment was scrubbed... URL: From hzhang at mcs.anl.gov Tue Aug 19 12:59:18 2014 From: hzhang at mcs.anl.gov (Hong) Date: Tue, 19 Aug 2014 12:59:18 -0500 Subject: [petsc-users] Solving tridiagonal hermitian generalized eigenvalue problem with SLEPC In-Reply-To: <8738cssd5j.fsf@jedbrown.org> References: <5FB012E4-A74C-4D08-962F-F767F04DBA07@mcs.anl.gov> <87mwb0silo.fsf@jedbrown.org> <8738cssd5j.fsf@jedbrown.org> Message-ID: Toon, Please read SLEPc user manual and learn 1. what type of eigenvalue problems do you have. We know you have Hermitian generalized eigen problems, you want largest eigenvalues, but how many do you want, a few, or many? Do you want eigenvectors as well? 2. what algorithms should be used for your problem? Iterative Lanczos method and some direct methods provided by Lapack (sequential) or Elemental (parallel). Here, you can start experimenting these methods provided by slepc. 3. base on your matrix structure, i.e., tridiagonal blocked or banded, you can use packages for dense matrices. Now start searching for efficient solvers among those working ones obtained in step 2. Hong On Tue, Aug 19, 2014 at 10:38 AM, Jed Brown wrote: > Toon Weyens writes: > >> Yes, you are probably right: My code is not yet bug free (by all means!). >> However, I have been working very hard on it and I will see if I find >> something. B should not ever be really singular! >> >> I do, however, still have some questions: >> >> - Does slepc detect whether my matrix is tridiagonal and does it apply a >> direct method to solve it? Or do you talk about it in general: that it >> would be better for me to use a direct method that is not part of slepc? > > The direct method is just a default. For a tridiagonal matrix, there is > no fill, so direct methods have great complexity. For other problems > (multi-dimensional, etc.) the direct solver has fill and becomes > asymptotically suboptimal. > >> - How do I make use of the information that both A and B have the same >> non-zero structure? Is there an easy way? > > I don't think it could make any difference for your scenario. > >> - What is the call "MatSetOption(mat,MAT_HERMITIAN,PETSC_TRUE,ierr)" do? Is >> it important? It does not seem to influence anything... > > In some circumstances, it would cause a method to default to Lanczos > instead of Arnoldi, or Cholesky instead of LU. From hzhang at mcs.anl.gov Tue Aug 19 13:09:37 2014 From: hzhang at mcs.anl.gov (Hong) Date: Tue, 19 Aug 2014 13:09:37 -0500 Subject: [petsc-users] Convert matrix to 1-D array In-Reply-To: References: Message-ID: Priyank: The product C = A * B is a dense matrix in petsc mpidense format. You should use MatDenseGetArray() http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatDenseGetArray.html which gives 1D array of local entries of C. I notice you are using petsc-3.3. Please update to the latest version of petsc. Hong > Hello, > > I have a matrix generated from matrix matrix multiplication. I want that > matrix to convert to 1 dimensional array. my code is as below > > ##################################################### > //Multiplication A * B (A is MPIAIJ & B is MPIDENSE) > MatMatMult(A, B, MAT_INITIAL_MATRIX, PETSC_DEFAULT, &C); > MatView(C,PETSC_VIEWER_STDOUT_WORLD); > //Convert Matrix C to 1D vector h_C > for(i = 0; i < m; i++) > { > for(j = 0; j < k; j++) > { > ierr = MatGetValues(C, 1, &i, 1, &j, &h_C[IDX2C(i,j,end1)]);CHKERRQ(ierr); > } > } > //printArray(h_B, m, k, "h_B"); > printArray(h_C, m, k, "A * X0"); > ##################################################### > when I tried the routine MatGetValues() it shows some error as below > > ##################################################### > --------------------- Error Message ------------------------------------ > [1]PETSC ERROR: No support for this operation for this object type! > [1]PETSC ERROR: Only local values currently supported! > [1]PETSC ERROR: > ------------------------------------------------------------------------ > [1]PETSC ERROR: Petsc Release Version 3.3.0, Patch 0, Tue Jun 5 14:20:42 > CDT 2012 > [1]PETSC ERROR: See docs/changes/index.html for recent updates. > [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. > [1]PETSC ERROR: See docs/index.html for manual pages. > [1]PETSC ERROR: > ------------------------------------------------------------------------ > [1]PETSC ERROR: ./blockCG_1 on a arch-linu named hpcd.cs.odu.edu by ppatel > Tue Aug 19 12:29:41 2014 > [1]PETSC ERROR: Libraries linked from /export/software/petsc-3.3/lib > [1]PETSC ERROR: Configure run at Wed Jun 6 16:29:21 2012 > [1]PETSC ERROR: Configure options --prefix=/export/software/petsc-3.3 > --download-f-blas-lapack=1 > [1]PETSC ERROR: > ------------------------------------------------------------------------ > [1]PETSC ERROR: MatGetValues_MPIDense() line 180 in > src/mat/impls/dense/mpi/mpidense.c > [1]PETSC ERROR: MatGetValues() line 1602 in src/mat/interface/matrix.c > [1]PETSC ERROR: main() line 343 in blockCG_1.c > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD > with errorcode 56. > > NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. > You may or may not see output from other processes, depending on > exactly when Open MPI kills them. > -------------------------------------------------------------------------- > > ##################################################### > > what is the efficient way to create a 1-D array from the PETSC matrix? From koki.imada at york.ac.uk Wed Aug 20 06:01:43 2014 From: koki.imada at york.ac.uk (Koki Imada) Date: Wed, 20 Aug 2014 12:01:43 +0100 Subject: [petsc-users] Inverting a Large Matrix with Fortran Code Message-ID: <53F48017.4010708@york.ac.uk> Hello, I have a problem of the kind: G(i) = (invM.P).G(i+1) +invM.(d -R.b), where M, P and R are square tri-diagonal matrices, invM is the inverse of M, G(i) and G(i+1) are the linearised solution vectors (given G(i+1), G(i) is determined using above), and "d" and "b" are vectors. The problem is, M at grid point (i) depends on M(i-1), so I #cannot# reduce the problem to: G(i) = invM(i).H(i+1), where H(i+1)=P.G + (d-R.b), because I first need to calculate alpha(i)=invM(i).P(i) for all i, before calculating G(i) from G(i+1). So I would like to directly invert M, using MatLUFactor and MatMatSolve. The problem here is, my code is written in Fortran 90, and there is a note on MatLUFactor manual page saying: "fortran interface is not autogenerated as the f90 interface defintion cannot be generated correctly [due to MatFactorInfo] " Does this mean the MatLUFactor routine cannot be used in Fortran? Or is there a workaround? Many Thanks, Koki From sylvainmercier85 at gmail.com Wed Aug 20 07:53:05 2014 From: sylvainmercier85 at gmail.com (Sylvain Mercier) Date: Wed, 20 Aug 2014 14:53:05 +0200 Subject: [petsc-users] Petsc with mumps single precision Message-ID: Hi everyone, I'm using PETSc to solve saddle point systems. I have found a block preconditionner which requires to solve a smaller symmetric positive definite system. I do it with MUMPS which is fast an robust. However, I would like to use this solver in single precision in order to compare the performances. So is it possible to use MUMPS in single precision inside a double precision solving with PETSc? Thanks, Sylvain -------------- next part -------------- An HTML attachment was scrubbed... URL: From hong at aspiritech.org Wed Aug 20 09:45:42 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Wed, 20 Aug 2014 09:45:42 -0500 Subject: [petsc-users] Petsc with mumps single precision In-Reply-To: References: Message-ID: Sylvain : You should be able to do so. Build petsc and mumps with single precision '--with-precision=single --download-mumps --download-scalapack ...' Hong > Hi everyone, > > I'm using PETSc to solve saddle point systems. I have found a block > preconditionner which requires to solve a smaller symmetric positive > definite system. I do it with MUMPS which is fast an robust. > However, I would like to use this solver in single precision in order to > compare the performances. > > So is it possible to use MUMPS in single precision inside a double precision > solving with PETSc? > > Thanks, > Sylvain From knepley at gmail.com Wed Aug 20 10:57:28 2014 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 20 Aug 2014 10:57:28 -0500 Subject: [petsc-users] Petsc with mumps single precision In-Reply-To: References: Message-ID: On Wed, Aug 20, 2014 at 7:53 AM, Sylvain Mercier wrote: > Hi everyone, > > I'm using PETSc to solve saddle point systems. I have found a block > preconditionner which requires to solve a smaller symmetric positive > definite system. I do it with MUMPS which is fast an robust. > However, I would like to use this solver in single precision in order to > compare the performances. > > So is it possible to use MUMPS in single precision inside a double > precision solving with PETSc? > No, right now PETSc must have all the same precision. We have investigated several methods for using multi-precision, but none has satisfied all our needs. Thanks, Matt > Thanks, > Sylvain > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Wed Aug 20 16:24:15 2014 From: jed at jedbrown.org (Jed Brown) Date: Wed, 20 Aug 2014 15:24:15 -0600 Subject: [petsc-users] Inverting a Large Matrix with Fortran Code In-Reply-To: <53F48017.4010708@york.ac.uk> References: <53F48017.4010708@york.ac.uk> Message-ID: <87d2buq2gw.fsf@jedbrown.org> Koki Imada writes: > Hello, > > I have a problem of the kind: > > G(i) = (invM.P).G(i+1) +invM.(d -R.b), > > where M, P and R are square tri-diagonal matrices, invM is the inverse of M, G(i) > and G(i+1) are the linearised solution vectors (given G(i+1), G(i) is determined > using above), and "d" and "b" are vectors. > > The problem is, M at grid point (i) depends on M(i-1), so I #cannot# reduce the > problem to: > > G(i) = invM(i).H(i+1), where H(i+1)=P.G + (d-R.b), > > because I first need to calculate alpha(i)=invM(i).P(i) for all i, before > calculating G(i) from G(i+1). I can't tell exactly what you're getting at here, but inv(M)*P is a dense matrix, so creating it explicitly would turn an O(n) algorithm into at least O(n^2). > So I would like to directly invert M, using MatLUFactor and MatMatSolve. The problem > here is, my code is written in Fortran 90, and there is a note on MatLUFactor manual > page saying: > "fortran interface is not autogenerated as the f90 interface defintion cannot be > generated correctly [due to MatFactorInfo] " > > Does this mean the MatLUFactor routine cannot be used in Fortran? Or is there a > workaround? It's called a "Developer Note" for a reason. The Fortran interface exists, but it is custom instead auto-generated. That does not concern users. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From knepley at gmail.com Thu Aug 21 10:00:31 2014 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 21 Aug 2014 10:00:31 -0500 Subject: [petsc-users] Computing Vector Norm Field wise In-Reply-To: References: <53F253F7.2080001@columbi.edu> Message-ID: On Mon, Aug 18, 2014 at 2:42 PM, Matthew Knepley wrote: > > On Aug 18, 2014 2:28 PM, "Luc Berger-Vergiat" wrote: > > > > Hi all, > > I am using the fieldsplit/DM facility to work on a multiphysics problem. > > I would like to get some field dependent convergence information. > > Is there something similar to the VecStrideNorm function that can > compute a residual for each field defined in the DM? > > Or should I use the DM to extract subvectors and compute their norms? > > I wroteca monitor that does this. I am currently out of internet range, > but I will mail it Wed when I get back. > Okay, what I have is not exactly what you want. I wrote something to look at the errors by field: ierr = DMPlexComputeL2FieldDiff(dm, user->exactFuncs, (void *) ctxs, u, ferror);CHKERRQ(ierr); but you want the residual. If we do not care too much about performance, we can easily do this using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/VecGetSubVector.html and then VecNorm, where we get the IS from http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/PC/PCFieldSplitGetIS.html You can write a simple monitor that calls these two. Thanks, Matt > Thanks > > Matt > > > -- > > Best, > > Luc > > > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 21 16:05:41 2014 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 21 Aug 2014 14:05:41 -0700 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: <878umkse4e.fsf@jedbrown.org> References: <878umkse4e.fsf@jedbrown.org> Message-ID: I have fixed this by setting the KSP op: call PCFieldSplitGetSubKSP(spc,i,subksp,ierr) call KSPSetOperators(subksp(2),solver%schur,solver%schur,ierr) Thanks, On Tue, Aug 19, 2014 at 8:17 AM, Jed Brown wrote: > Mark Adams writes: > > > I am creating an Schur complement matrix explicitly (solver%schur) and > > setting it with code like: > > > > call SNESGetKSP(solver%snes,innerksp,ierr) > > call KSPGetPC(innerksp,spc,ierr) > > call > > > PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) > > > > I would think that the "inner" solver would not be used but it is getting > > used. > > [...] > > > PC Object:(fsa_) 4 MPI processes > > type: fieldsplit > > FieldSplit with Schur preconditioner, factorization FULL > > Preconditioner for the Schur complement formed from A11 > > I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then > watch -l jac->schurpre since it appears that your information is being > lost somewhere. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 21 16:11:52 2014 From: jed at jedbrown.org (Jed Brown) Date: Thu, 21 Aug 2014 15:11:52 -0600 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: References: <878umkse4e.fsf@jedbrown.org> Message-ID: <87sikppmxz.fsf@jedbrown.org> Mark Adams writes: > I have fixed this by setting the KSP op: > > call PCFieldSplitGetSubKSP(spc,i,subksp,ierr) > call KSPSetOperators(subksp(2),solver%schur,solver%schur,ierr) Mark, where is the information getting lost? If the interface does not work correctly, we (PETSc) need to fix the interface, not just find a workaround. That's why I suggested running in a debugger. > Thanks, > > > > On Tue, Aug 19, 2014 at 8:17 AM, Jed Brown wrote: > >> Mark Adams writes: >> >> > I am creating an Schur complement matrix explicitly (solver%schur) and >> > setting it with code like: >> > >> > call SNESGetKSP(solver%snes,innerksp,ierr) >> > call KSPGetPC(innerksp,spc,ierr) >> > call >> > >> PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) >> > >> > I would think that the "inner" solver would not be used but it is getting >> > used. >> >> [...] >> >> > PC Object:(fsa_) 4 MPI processes >> > type: fieldsplit >> > FieldSplit with Schur preconditioner, factorization FULL >> > Preconditioner for the Schur complement formed from A11 >> >> I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then >> watch -l jac->schurpre since it appears that your information is being >> lost somewhere. >> -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From mfadams at lbl.gov Thu Aug 21 16:56:14 2014 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 21 Aug 2014 14:56:14 -0700 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: <87sikppmxz.fsf@jedbrown.org> References: <878umkse4e.fsf@jedbrown.org> <87sikppmxz.fsf@jedbrown.org> Message-ID: On Thu, Aug 21, 2014 at 2:11 PM, Jed Brown wrote: > Mark Adams writes: > > > I have fixed this by setting the KSP op: > > > > call PCFieldSplitGetSubKSP(spc,i,subksp,ierr) > > call KSPSetOperators(subksp(2),solver%schur,solver%schur,ierr) > > Mark, where is the information getting lost? If the interface does not > work correctly, we (PETSc) need to fix the interface, not just find a > workaround. That's why I suggested running in a debugger. > OK, I'll look at it but I need to get the debug build error (other thread) fixed to be able to step through the code. That error happens before this PC Schur stuff is set. > > > Thanks, > > > > > > > > On Tue, Aug 19, 2014 at 8:17 AM, Jed Brown wrote: > > > >> Mark Adams writes: > >> > >> > I am creating an Schur complement matrix explicitly (solver%schur) and > >> > setting it with code like: > >> > > >> > call SNESGetKSP(solver%snes,innerksp,ierr) > >> > call KSPGetPC(innerksp,spc,ierr) > >> > call > >> > > >> > PCFieldSplitSetSchurPre(spc,PC_FIELDSPLIT_SCHUR_PRE_USER,solver%schur,ierr) > >> > > >> > I would think that the "inner" solver would not be used but it is > getting > >> > used. > >> > >> [...] > >> > >> > PC Object:(fsa_) 4 MPI processes > >> > type: fieldsplit > >> > FieldSplit with Schur preconditioner, factorization FULL > >> > Preconditioner for the Schur complement formed from A11 > >> > >> I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then > >> watch -l jac->schurpre since it appears that your information is being > >> lost somewhere. > >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 21 17:49:32 2014 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 21 Aug 2014 15:49:32 -0700 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: <878umkse4e.fsf@jedbrown.org> References: <878umkse4e.fsf@jedbrown.org> Message-ID: > > > I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then > watch -l jac->schurpre since it appears that your information is being > lost somewhere. > The 'ptype" that comes in to PCFieldSplitSetSchurPre_FieldSplit is ..._SCHUR_PRE_ALL (not .._USER). Could the enums be messed up in F90? -------------- next part -------------- An HTML attachment was scrubbed... URL: From evanum at gmail.com Thu Aug 21 18:05:40 2014 From: evanum at gmail.com (Evan Um) Date: Thu, 21 Aug 2014 16:05:40 -0700 Subject: [petsc-users] Differences in PETSC between 3.4.4 and 3.5.0 Message-ID: Dear PETSC users, I recently downgraded my PETSC library from version 3.5.0 to version 3.4.4. For my application, most differences between the twos were changes in PETSC function interfaces. For examples, I got errors such as too few arguments in function call, but some errors were about the new functionality in the latest version. Does anyone know about 3.4.4 functions corresponding to KSPSetReusePreconditioner() and MatMumpsSetIcntl()? In advance, thanks for your comments. Regards, Evan fetdem3d_driver_csem.cpp(330): error: identifier "KSPSetReusePreconditioner" is undefined KSPSetReusePreconditioner(ksp_fetd_dt,PETSC_TRUE); fetdem3d_driver_csem.cpp(493): error: identifier "MatMumpsSetIcntl" is undefined MatMumpsSetIcntl(F_dt, icntl, ival); -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 21 18:06:44 2014 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 21 Aug 2014 16:06:44 -0700 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: References: <878umkse4e.fsf@jedbrown.org> Message-ID: Yep, it looks like SELFP was not added to FORTRAN: 6:04 1 edison03 master ~/petsc_private/include$ grep PC_FIELDSPLIT_SCHUR_PRE * petscpc.h:typedef enum {PC_FIELDSPLIT_SCHUR_PRE_SELF,PC_FIELDSPLIT_SCHUR_PRE_SELFP,PC_FIELDSPLIT_SCHUR_PRE_A11,PC_FIELDSPLIT_SCHUR_PRE_USER,PC_FIELDSPLIT_SCHUR_PRE_FULL} PCFieldSplitSchurPreType; 16:04 edison03 master ~/petsc_private/include$ grep PC_FIELDSPLIT_SCHUR_PRE finclude/* finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_SELF finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_A11 finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_USER finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_SELF=0) finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_A11=1) finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_USER=2) On Thu, Aug 21, 2014 at 3:49 PM, Mark Adams wrote: > >> I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then >> watch -l jac->schurpre since it appears that your information is being >> lost somewhere. >> > > The 'ptype" that comes in to PCFieldSplitSetSchurPre_FieldSplit is > ..._SCHUR_PRE_ALL (not .._USER). Could the enums be messed up in F90? > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From priyankpatel22 at live.com Thu Aug 21 18:25:07 2014 From: priyankpatel22 at live.com (priyank patel) Date: Thu, 21 Aug 2014 19:25:07 -0400 Subject: [petsc-users] Convert matrix to 1-D array In-Reply-To: References: Message-ID: hi, Ya this will give me only local entries. But what if I want the complete matrix in one array. So that I can use it with the lapack routines?? Thanks Priyank On 19-Aug-2014, at 2:09 pm, Hong wrote: > Priyank: > The product C = A * B is a dense matrix in petsc mpidense format. > You should use MatDenseGetArray() > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatDenseGetArray.html > > which gives 1D array of local entries of C. > > I notice you are using petsc-3.3. Please update to the latest version of petsc. > > Hong > >> Hello, >> >> I have a matrix generated from matrix matrix multiplication. I want that >> matrix to convert to 1 dimensional array. my code is as below >> >> ##################################################### >> //Multiplication A * B (A is MPIAIJ & B is MPIDENSE) >> MatMatMult(A, B, MAT_INITIAL_MATRIX, PETSC_DEFAULT, &C); >> MatView(C,PETSC_VIEWER_STDOUT_WORLD); >> //Convert Matrix C to 1D vector h_C >> for(i = 0; i < m; i++) >> { >> for(j = 0; j < k; j++) >> { >> ierr = MatGetValues(C, 1, &i, 1, &j, &h_C[IDX2C(i,j,end1)]);CHKERRQ(ierr); >> } >> } >> //printArray(h_B, m, k, "h_B"); >> printArray(h_C, m, k, "A * X0"); >> ##################################################### >> when I tried the routine MatGetValues() it shows some error as below >> >> ##################################################### >> --------------------- Error Message ------------------------------------ >> [1]PETSC ERROR: No support for this operation for this object type! >> [1]PETSC ERROR: Only local values currently supported! >> [1]PETSC ERROR: >> ------------------------------------------------------------------------ >> [1]PETSC ERROR: Petsc Release Version 3.3.0, Patch 0, Tue Jun 5 14:20:42 >> CDT 2012 >> [1]PETSC ERROR: See docs/changes/index.html for recent updates. >> [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. >> [1]PETSC ERROR: See docs/index.html for manual pages. >> [1]PETSC ERROR: >> ------------------------------------------------------------------------ >> [1]PETSC ERROR: ./blockCG_1 on a arch-linu named hpcd.cs.odu.edu by ppatel >> Tue Aug 19 12:29:41 2014 >> [1]PETSC ERROR: Libraries linked from /export/software/petsc-3.3/lib >> [1]PETSC ERROR: Configure run at Wed Jun 6 16:29:21 2012 >> [1]PETSC ERROR: Configure options --prefix=/export/software/petsc-3.3 >> --download-f-blas-lapack=1 >> [1]PETSC ERROR: >> ------------------------------------------------------------------------ >> [1]PETSC ERROR: MatGetValues_MPIDense() line 180 in >> src/mat/impls/dense/mpi/mpidense.c >> [1]PETSC ERROR: MatGetValues() line 1602 in src/mat/interface/matrix.c >> [1]PETSC ERROR: main() line 343 in blockCG_1.c >> -------------------------------------------------------------------------- >> MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD >> with errorcode 56. >> >> NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. >> You may or may not see output from other processes, depending on >> exactly when Open MPI kills them. >> -------------------------------------------------------------------------- >> >> ##################################################### >> >> what is the efficient way to create a 1-D array from the PETSC matrix? From bsmith at mcs.anl.gov Thu Aug 21 19:54:09 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 21 Aug 2014 19:54:09 -0500 Subject: [petsc-users] Differences in PETSC between 3.4.4 and 3.5.0 In-Reply-To: References: Message-ID: <9EB895AC-E758-4E9E-B683-3D8C7F0AD187@mcs.anl.gov> On Aug 21, 2014, at 6:05 PM, Evan Um wrote: > Dear PETSC users, > > I recently downgraded my PETSC library from version 3.5.0 to version 3.4.4. For my application, most differences between the twos were changes in PETSC function interfaces. For examples, I got errors such as too few arguments in function call, but some errors were about the new functionality in the latest version. Does anyone know about 3.4.4 functions corresponding to KSPSetReusePreconditioner() and MatMumpsSetIcntl()? In advance, thanks for your comments. Those simply did not exist at that time. You can get the effect of KSPSetReusePreconditioner() by passing the flag SAME_PRECONDITIONER as the final argument to KSPSetOperators(). Barry > > Regards, > Evan > > fetdem3d_driver_csem.cpp(330): error: identifier "KSPSetReusePreconditioner" is undefined > KSPSetReusePreconditioner(ksp_fetd_dt,PETSC_TRUE); > > fetdem3d_driver_csem.cpp(493): error: identifier "MatMumpsSetIcntl" is undefined > MatMumpsSetIcntl(F_dt, icntl, ival); From balay at mcs.anl.gov Thu Aug 21 20:03:26 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 21 Aug 2014 20:03:26 -0500 Subject: [petsc-users] Differences in PETSC between 3.4.4 and 3.5.0 In-Reply-To: <9EB895AC-E758-4E9E-B683-3D8C7F0AD187@mcs.anl.gov> References: <9EB895AC-E758-4E9E-B683-3D8C7F0AD187@mcs.anl.gov> Message-ID: Why downgrade? Satish On Thu, 21 Aug 2014, Barry Smith wrote: > > On Aug 21, 2014, at 6:05 PM, Evan Um wrote: > > > Dear PETSC users, > > > > I recently downgraded my PETSC library from version 3.5.0 to version 3.4.4. For my application, most differences between the twos were changes in PETSC function interfaces. For examples, I got errors such as too few arguments in function call, but some errors were about the new functionality in the latest version. Does anyone know about 3.4.4 functions corresponding to KSPSetReusePreconditioner() and MatMumpsSetIcntl()? In advance, thanks for your comments. > > Those simply did not exist at that time. You can get the effect of KSPSetReusePreconditioner() by passing the flag SAME_PRECONDITIONER as the final argument to KSPSetOperators(). > > > Barry > > > > > Regards, > > Evan > > > > fetdem3d_driver_csem.cpp(330): error: identifier "KSPSetReusePreconditioner" is undefined > > KSPSetReusePreconditioner(ksp_fetd_dt,PETSC_TRUE); > > > > fetdem3d_driver_csem.cpp(493): error: identifier "MatMumpsSetIcntl" is undefined > > MatMumpsSetIcntl(F_dt, icntl, ival); > > From hzhang at mcs.anl.gov Thu Aug 21 21:04:31 2014 From: hzhang at mcs.anl.gov (Hong) Date: Thu, 21 Aug 2014 21:04:31 -0500 Subject: [petsc-users] Convert matrix to 1-D array In-Reply-To: References: Message-ID: You can call MatGetSubMatrices() http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatGetSubMatrices.html Hong On Thu, Aug 21, 2014 at 6:25 PM, priyank patel wrote: > hi, > > Ya this will give me only local entries. But what if I want the complete matrix in one array. So that I can use it with the lapack routines?? > > Thanks > Priyank > > On 19-Aug-2014, at 2:09 pm, Hong wrote: > >> Priyank: >> The product C = A * B is a dense matrix in petsc mpidense format. >> You should use MatDenseGetArray() >> http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatDenseGetArray.html >> >> which gives 1D array of local entries of C. >> >> I notice you are using petsc-3.3. Please update to the latest version of petsc. >> >> Hong >> >>> Hello, >>> >>> I have a matrix generated from matrix matrix multiplication. I want that >>> matrix to convert to 1 dimensional array. my code is as below >>> >>> ##################################################### >>> //Multiplication A * B (A is MPIAIJ & B is MPIDENSE) >>> MatMatMult(A, B, MAT_INITIAL_MATRIX, PETSC_DEFAULT, &C); >>> MatView(C,PETSC_VIEWER_STDOUT_WORLD); >>> //Convert Matrix C to 1D vector h_C >>> for(i = 0; i < m; i++) >>> { >>> for(j = 0; j < k; j++) >>> { >>> ierr = MatGetValues(C, 1, &i, 1, &j, &h_C[IDX2C(i,j,end1)]);CHKERRQ(ierr); >>> } >>> } >>> //printArray(h_B, m, k, "h_B"); >>> printArray(h_C, m, k, "A * X0"); >>> ##################################################### >>> when I tried the routine MatGetValues() it shows some error as below >>> >>> ##################################################### >>> --------------------- Error Message ------------------------------------ >>> [1]PETSC ERROR: No support for this operation for this object type! >>> [1]PETSC ERROR: Only local values currently supported! >>> [1]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> [1]PETSC ERROR: Petsc Release Version 3.3.0, Patch 0, Tue Jun 5 14:20:42 >>> CDT 2012 >>> [1]PETSC ERROR: See docs/changes/index.html for recent updates. >>> [1]PETSC ERROR: See docs/faq.html for hints about trouble shooting. >>> [1]PETSC ERROR: See docs/index.html for manual pages. >>> [1]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> [1]PETSC ERROR: ./blockCG_1 on a arch-linu named hpcd.cs.odu.edu by ppatel >>> Tue Aug 19 12:29:41 2014 >>> [1]PETSC ERROR: Libraries linked from /export/software/petsc-3.3/lib >>> [1]PETSC ERROR: Configure run at Wed Jun 6 16:29:21 2012 >>> [1]PETSC ERROR: Configure options --prefix=/export/software/petsc-3.3 >>> --download-f-blas-lapack=1 >>> [1]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> [1]PETSC ERROR: MatGetValues_MPIDense() line 180 in >>> src/mat/impls/dense/mpi/mpidense.c >>> [1]PETSC ERROR: MatGetValues() line 1602 in src/mat/interface/matrix.c >>> [1]PETSC ERROR: main() line 343 in blockCG_1.c >>> -------------------------------------------------------------------------- >>> MPI_ABORT was invoked on rank 1 in communicator MPI_COMM_WORLD >>> with errorcode 56. >>> >>> NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. >>> You may or may not see output from other processes, depending on >>> exactly when Open MPI kills them. >>> -------------------------------------------------------------------------- >>> >>> ##################################################### >>> >>> what is the efficient way to create a 1-D array from the PETSC matrix? > From mfadams at lbl.gov Thu Aug 21 23:05:41 2014 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 21 Aug 2014 21:05:41 -0700 Subject: [petsc-users] Use of PCFieldSplitSetSchurPre In-Reply-To: References: <878umkse4e.fsf@jedbrown.org> Message-ID: I fixed the messed up fortran enums with: ! ! PCFieldSplitSchurPreType ! PetscEnum PC_FIELDSPLIT_SCHUR_PRE_SELF PetscEnum PC_FIELDSPLIT_SCHUR_PRE_SELFP PetscEnum PC_FIELDSPLIT_SCHUR_PRE_A11 PetscEnum PC_FIELDSPLIT_SCHUR_PRE_USER PetscEnum PC_FIELDSPLIT_SCHUR_PRE_FULL parameter (PC_FIELDSPLIT_SCHUR_PRE_SELF=0) parameter (PC_FIELDSPLIT_SCHUR_PRE_SELFP=1) parameter (PC_FIELDSPLIT_SCHUR_PRE_A11=2) parameter (PC_FIELDSPLIT_SCHUR_PRE_USER=3) parameter (PC_FIELDSPLIT_SCHUR_PRE_FULL=4) But I still don't get the right thing without setting the KSP operator explicitly. I traced through PCFieldSplitSetSchurPre_FieldSplit and it sets the jac->schurpre flag and the jac->schur_user matrix pointer correctly. This method does not do much but it now seems to be doing it correctly. On Thu, Aug 21, 2014 at 4:06 PM, Mark Adams wrote: > Yep, it looks like SELFP was not added to FORTRAN: > > 6:04 1 edison03 master ~/petsc_private/include$ grep > PC_FIELDSPLIT_SCHUR_PRE * > petscpc.h:typedef enum > {PC_FIELDSPLIT_SCHUR_PRE_SELF,PC_FIELDSPLIT_SCHUR_PRE_SELFP,PC_FIELDSPLIT_SCHUR_PRE_A11,PC_FIELDSPLIT_SCHUR_PRE_USER,PC_FIELDSPLIT_SCHUR_PRE_FULL} > PCFieldSplitSchurPreType; > 16:04 edison03 master ~/petsc_private/include$ grep > PC_FIELDSPLIT_SCHUR_PRE finclude/* > finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_SELF > finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_A11 > finclude/petscpc.h: PetscEnum PC_FIELDSPLIT_SCHUR_PRE_USER > finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_SELF=0) > finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_A11=1) > finclude/petscpc.h: parameter (PC_FIELDSPLIT_SCHUR_PRE_USER=2) > > > > On Thu, Aug 21, 2014 at 3:49 PM, Mark Adams wrote: > >> >>> I would set a breakpoint at PCFieldSplitSetSchurPre_FieldSplit and then >>> watch -l jac->schurpre since it appears that your information is being >>> lost somewhere. >>> >> >> The 'ptype" that comes in to PCFieldSplitSetSchurPre_FieldSplit is >> ..._SCHUR_PRE_ALL (not .._USER). Could the enums be messed up in F90? >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From earl at queensburydvds.com Fri Aug 22 02:25:51 2014 From: earl at queensburydvds.com (Earl of Queensbury) Date: Fri, 22 Aug 2014 03:25:51 -0400 Subject: [petsc-users] DVD Collections Fit For A King Message-ID: <26af01cfbddc$ddc195a0$9944c0e0$@queensburydvds.com> petsc-users at mcs.anl.govFilm collections fit for a King. https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/7b650762-f55c -4af0-88c6-45561a6f710e.jpg Collections Fit For A King Spotlight Collection No. 1 Here at Queensbury DVDs, I will be offering Spotlight Collections which will highlight a major contributor to the motion picture industry and will include as many works as I can amass. They will be economically priced and all orders include free shipping. I will ship these collections anywhere in the world, completely free of charge. https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/a74a5d38-79e8 -483c-9cda-f3d23979d9d3.jpg In The Spotlight... Ken Adam Born in 1921 in Berlin, Ken studied architecture at London University and was an RAF pilot in Word War II. He entered the film industry in 1947 as a draftsman; became an art director in the mid-50's and a production designer in the early 60s. His work has been known for its stylish inventiveness and sense of humor. He won an Oscar for the art direction of Kubrick's Barry Lyndon in 1975. Helen of Troy (1956) Around The World In 80 Days (1956) The Trials of Oscar Wilde (1960) Dr. No (1962) Dr. Strangelove (1964) Goldfinger (1964) Thunderball (1965) The Ipcress File (1965) Funeral In Berlin (1966) You Only Live Twice (1967) Chitty Chitty Bang Bang (1968) Goodbye Mr. Chips (1969) The Owl And The Pussycat (1970) Diamonds Are Forever (1971) Sleuth (1972) The Last of Sheila (1973) Barry Lyndon (1975) The Seven-Per-Cent Solution (1976) The Spy Who Loved Me (1977) https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/371e3e82-df2a -464b-8edd-518931f70daf.jpg Ken Adams on the set of Goldfingerpetsc-users at mcs.anl.gov If you buy the entire collection, you will save bunches. It is only $90.00 for the set. You can purchase it here: Ken Adams Collection https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/1da5ab87-f059 -4222-9b4c-7faf9102f5d6.jpg Asian Spa from You Only Live Twice https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/1f7dfaf6-9e93 -4701-87d2-66881038e32d.jpg Set From Thunderball https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/507b810d-92b6 -4c5d-a531-1848cef4bf20.jpg On The Set of Dr. Strangelove https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/bca8b2d4-5157 -49bd-a745-ff4f2b30122d.jpg On The Set of Dr. No I hope you have enjoyed perusing this collection fit for a King. https://gallery.mailchimp.com/d34fa5b478b5cba8468e4116b/images/a4884beb-1f0d -47d7-91f7-56740d1800c7.jpg Copyright C 2014 Queensbury DVDs, All rights reserved. You are receiving this email because you have expressed interest in products found at Queensbury DVDs or its affiliated websites. Our mailing address is: Queensbury DVDs P.O. Box 121055 Ft Lauderdale, FL 33312 UNSUBSCRIBE http://queensburydvds.us8.list-manage.com/track/open.php?u=d34fa5b478b5cba84 68e4116b&id=32179c25c8&e=df77374bbd -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image001.jpg Type: image/jpeg Size: 39653 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image002.jpg Type: image/jpeg Size: 7220 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image003.jpg Type: image/jpeg Size: 88614 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image004.jpg Type: image/jpeg Size: 32769 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image005.jpg Type: image/jpeg Size: 37451 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image006.jpg Type: image/jpeg Size: 32497 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image007.jpg Type: image/jpeg Size: 39529 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image008.jpg Type: image/jpeg Size: 34812 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image009.jpg Type: image/jpeg Size: 17074 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image010.jpg Type: image/jpeg Size: 100920 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image011.jpg Type: image/jpeg Size: 35035 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image012.gif Type: image/gif Size: 35 bytes Desc: not available URL: From epscodes at gmail.com Fri Aug 22 13:24:58 2014 From: epscodes at gmail.com (Xiangdong) Date: Fri, 22 Aug 2014 14:24:58 -0400 Subject: [petsc-users] flops performed on each processor Message-ID: Hello everyone, In the PETSc log_summary, it outputs the Max flops, the ratio of Max/Min flops. If it is far from 1.0, I would like to know the distributions of flops among all the procs. How can I obtain the flops performed on each proc? Thank you. Best, Xiangdong -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 22 13:28:07 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 22 Aug 2014 13:28:07 -0500 Subject: [petsc-users] flops performed on each processor In-Reply-To: References: Message-ID: On Fri, Aug 22, 2014 at 1:24 PM, Xiangdong wrote: > Hello everyone, > > In the PETSc log_summary, it outputs the Max flops, the ratio of Max/Min > flops. If it is far from 1.0, I would like to know the distributions of > flops among all the procs. How can I obtain the flops performed on each > proc? > -log_view ::ascii_info_detail Thanks, Matt > Thank you. > > Best, > Xiangdong > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 22 13:53:46 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 22 Aug 2014 13:53:46 -0500 Subject: [petsc-users] flops performed on each processor In-Reply-To: References: Message-ID: <76DF1352-93FA-4A8E-AD2D-128CC79B19A0@mcs.anl.gov> On Aug 22, 2014, at 1:28 PM, Matthew Knepley wrote: > On Fri, Aug 22, 2014 at 1:24 PM, Xiangdong wrote: > Hello everyone, > > In the PETSc log_summary, it outputs the Max flops, the ratio of Max/Min flops. If it is far from 1.0, I would like to know the distributions of flops among all the procs. How can I obtain the flops performed on each proc? > > -log_view ::ascii_info_detail We don?t have it properly documented yet but this outputs python dictionaries that contain the various performance counters for each process and stages and events. You can then write simple Python code to process the data any way you like, for example plotting distributions etc. I recommend starting by collecting data for just 2 or 3 processes and using that data to write your python scripts. Once you have the scripts you want you can make parallel runs with more processes and use the already debugged scripts. > > Thanks, > > Matt > > Thank you. > > Best, > Xiangdong > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener From epscodes at gmail.com Fri Aug 22 13:58:06 2014 From: epscodes at gmail.com (Xiangdong) Date: Fri, 22 Aug 2014 14:58:06 -0400 Subject: [petsc-users] flops performed on each processor In-Reply-To: <76DF1352-93FA-4A8E-AD2D-128CC79B19A0@mcs.anl.gov> References: <76DF1352-93FA-4A8E-AD2D-128CC79B19A0@mcs.anl.gov> Message-ID: simply replacing -log_summary with -log_view ::ascii_info_detail does not produce anything. (Sams as -log_view ascii:filename:ascii_info_detail.) Where does it dump the log? Is this the feature of new petsc? I am using petsc-3.4.3. Thanks. Xiangdong On Fri, Aug 22, 2014 at 2:53 PM, Barry Smith wrote: > > On Aug 22, 2014, at 1:28 PM, Matthew Knepley wrote: > > > On Fri, Aug 22, 2014 at 1:24 PM, Xiangdong wrote: > > Hello everyone, > > > > In the PETSc log_summary, it outputs the Max flops, the ratio of Max/Min > flops. If it is far from 1.0, I would like to know the distributions of > flops among all the procs. How can I obtain the flops performed on each > proc? > > > > -log_view ::ascii_info_detail > > We don?t have it properly documented yet but this outputs python > dictionaries that contain the various performance counters for each process > and stages and events. You can then write simple Python code to process the > data any way you like, for example plotting distributions etc. I recommend > starting by collecting data for just 2 or 3 processes and using that data > to write your python scripts. Once you have the scripts you want you can > make parallel runs with more processes and use the already debugged scripts. > > > > Thanks, > > > > Matt > > > > Thank you. > > > > Best, > > Xiangdong > > > > > > > > -- > > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > > -- Norbert Wiener > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 22 14:08:07 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 22 Aug 2014 14:08:07 -0500 Subject: [petsc-users] flops performed on each processor In-Reply-To: References: <76DF1352-93FA-4A8E-AD2D-128CC79B19A0@mcs.anl.gov> Message-ID: <212BE698-B38B-4232-9342-6C13AD5BEF7D@mcs.anl.gov> You will need to upgrade to 3.5 We don?t provide any convenient way to dump the information per process for 3.4 On Aug 22, 2014, at 1:58 PM, Xiangdong wrote: > simply replacing -log_summary with -log_view ::ascii_info_detail does not produce anything. (Sams as -log_view ascii:filename:ascii_info_detail.) Where does it dump the log? Is this the feature of new petsc? I am using petsc-3.4.3. > > Thanks. > > Xiangdong > > > On Fri, Aug 22, 2014 at 2:53 PM, Barry Smith wrote: > > On Aug 22, 2014, at 1:28 PM, Matthew Knepley wrote: > > > On Fri, Aug 22, 2014 at 1:24 PM, Xiangdong wrote: > > Hello everyone, > > > > In the PETSc log_summary, it outputs the Max flops, the ratio of Max/Min flops. If it is far from 1.0, I would like to know the distributions of flops among all the procs. How can I obtain the flops performed on each proc? > > > > -log_view ::ascii_info_detail > > We don?t have it properly documented yet but this outputs python dictionaries that contain the various performance counters for each process and stages and events. You can then write simple Python code to process the data any way you like, for example plotting distributions etc. I recommend starting by collecting data for just 2 or 3 processes and using that data to write your python scripts. Once you have the scripts you want you can make parallel runs with more processes and use the already debugged scripts. > > > > Thanks, > > > > Matt > > > > Thank you. > > > > Best, > > Xiangdong > > > > > > > > -- > > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > > -- Norbert Wiener > > From gianmail at gmail.com Fri Aug 22 21:15:09 2014 From: gianmail at gmail.com (Gianluca Meneghello) Date: Fri, 22 Aug 2014 19:15:09 -0700 Subject: [petsc-users] petsc4py getVecArray magic Message-ID: Dear all, I just discovered that x = da.getVecArray(X) does not return a numpy array but rather a _DMDA_Vec_array, which has (I guess) the great advantage of allowing for a starting index which is not zero. So x[87] makes sense even if the actual length of x is only 50. What I would like to do is to split the _DMDA_Vec_array x into multiple variables, e.g. x1,x2,x3 = x[:,0:12] , x[:,12:16], x[:,16:28] which, written in this way, returns x1,x2,x3 as numpy view() arrays starting from zero and of length equal to the length of the global X divided by the number of processors. The arrays x1,x2,x3 thus becomes unaccessible when using global indices. Using local indices does not look like a good idea because of the presence of ghost entries. I was wondering if there is any good way to address this situation besides not splitting x in x1,x2,x3. Thanks for your help, Gianluca -------------- next part -------------- An HTML attachment was scrubbed... URL: From dalcinl at gmail.com Sun Aug 24 04:02:33 2014 From: dalcinl at gmail.com (Lisandro Dalcin) Date: Sun, 24 Aug 2014 12:02:33 +0300 Subject: [petsc-users] petsc4py getVecArray magic In-Reply-To: References: Message-ID: On 23 August 2014 05:15, Gianluca Meneghello wrote: > Dear all, > > I just discovered that > > x = da.getVecArray(X) > > does not return a numpy array but rather a _DMDA_Vec_array, which has (I > guess) the great advantage of allowing for a starting index which is not > zero. So x[87] makes sense even if the actual length of x is only 50. > > What I would like to do is to split the _DMDA_Vec_array x into multiple > variables, e.g. > > x1,x2,x3 = x[:,0:12] , x[:,12:16], x[:,16:28] > > which, written in this way, returns x1,x2,x3 as numpy view() arrays starting > from zero and of length equal to the length of the global X divided by the > number of processors. The arrays x1,x2,x3 thus becomes unaccessible when > using global indices. Using local indices does not look like a good idea > because of the presence of ghost entries. > > I was wondering if there is any good way to address this situation besides > not splitting x in x1,x2,x3. > Sorry, but I'm not following you. -- Lisandro Dalcin ============ Research Scientist Computer, Electrical and Mathematical Sciences & Engineering (CEMSE) Numerical Porous Media Center (NumPor) King Abdullah University of Science and Technology (KAUST) http://numpor.kaust.edu.sa/ 4700 King Abdullah University of Science and Technology al-Khawarizmi Bldg (Bldg 1), Office # 4332 Thuwal 23955-6900, Kingdom of Saudi Arabia http://www.kaust.edu.sa Office Phone: +966 12 808-0459 From friedmud at gmail.com Sun Aug 24 21:06:05 2014 From: friedmud at gmail.com (Derek Gaston) Date: Sun, 24 Aug 2014 20:06:05 -0600 Subject: [petsc-users] SNESSetFunctionDomainError Message-ID: There must be something I'm missing about SNESSetFunctionDomainError(). I'm using a matrix free newton solve and I was hoping that calling SNESSetFunctionDomainError() would completely stop the nonlinear solver... but that doesn't appear to be the case. Now - if I call that function during the initial residual computation it appears to work (the solve never starts). However, if I call it during the _middle_ of a matrix free nonlinear solve during a residual calculation - it appears to do absolutely nothing. Here's my stupid debugging code that's at the top of my residual callback method: static int count = 0; count++; if (count == 5) { std::cout<<"stopping solve!"< From bsmith at mcs.anl.gov Sun Aug 24 21:40:53 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 24 Aug 2014 21:40:53 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Aug 24, 2014, at 9:06 PM, Derek Gaston wrote: > There must be something I'm missing about SNESSetFunctionDomainError(). > > I'm using a matrix free newton solve and I was hoping that calling SNESSetFunctionDomainError() would completely stop the nonlinear solver... but that doesn't appear to be the case. > > Now - if I call that function during the initial residual computation it appears to work (the solve never starts). However, if I call it during the _middle_ of a matrix free nonlinear solve during a residual calculation - it appears to do absolutely nothing. You are not missing anything. The way SNESSetFunctionDomainError() works is it merely sets a flag in the SNES object. The solver code then can check that flag after a function evaluation and generate an if that flag is set (or perhaps do some kind of recovery). So, for example, at the beginning of SNESSolve_NewtonLS() we have } else { if (!snes->vec_func_init_set) { ierr = SNESComputeFunction(snes,X,F);CHKERRQ(ierr); ierr = SNESGetFunctionDomainError(snes, &domainerror);CHKERRQ(ierr); if (domainerror) { snes->reason = SNES_DIVERGED_FUNCTION_DOMAIN; PetscFunctionReturn(0); Now the reason it is not erroring out for you is because 1) our MatMult_MFFD() totally ignores the SNES domain error business because it doesn?t even know about SNES 2) inside the various nonlinear solvers and many complicated line search codes we may not always be checking the domainerror flag. Both of these things, of course, should be fixed. We need to add support to the MatMult_MFFD() to indicate domain errors and we need to check all the code to make sure we always handle the domain error flag. Barry > > Here's my stupid debugging code that's at the top of my residual callback method: > > static int count = 0; > count++; > > if (count == 5) > { > std::cout<<"stopping solve!"< SNESSetFunctionDomainError(snes); > } > > > During the solve "stopping solve!" gets printed out after computing the 3rd linear iteration of the first newton step... but the solve just continues without stopping... > > Is there something more I need to do here? > > Thanks! > > Derek From karpeev at mcs.anl.gov Sun Aug 24 22:20:47 2014 From: karpeev at mcs.anl.gov (Dmitry Karpeyev) Date: Sun, 24 Aug 2014 22:20:47 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Sun, Aug 24, 2014 at 9:40 PM, Barry Smith wrote: > > On Aug 24, 2014, at 9:06 PM, Derek Gaston wrote: > > > There must be something I'm missing about SNESSetFunctionDomainError(). > > > > I'm using a matrix free newton solve and I was hoping that calling > SNESSetFunctionDomainError() would completely stop the nonlinear solver... > but that doesn't appear to be the case. > > > > Now - if I call that function during the initial residual computation it > appears to work (the solve never starts). However, if I call it during the > _middle_ of a matrix free nonlinear solve during a residual calculation - > it appears to do absolutely nothing. > > You are not missing anything. The way SNESSetFunctionDomainError() > works is it merely sets a flag in the SNES object. The solver code then can > check that flag after a function evaluation and generate an if that flag is > set (or perhaps do some kind of recovery). So, for example, at the > beginning of SNESSolve_NewtonLS() we have > > } else { > if (!snes->vec_func_init_set) { > ierr = SNESComputeFunction(snes,X,F);CHKERRQ(ierr); > ierr = SNESGetFunctionDomainError(snes, &domainerror);CHKERRQ(ierr); > if (domainerror) { > snes->reason = SNES_DIVERGED_FUNCTION_DOMAIN; > PetscFunctionReturn(0); > Now the reason it is not erroring out for you is because > > 1) our MatMult_MFFD() totally ignores the SNES domain error business > because it doesn?t even know about SNES > > 2) inside the various nonlinear solvers and many complicated line search > codes we may not always be checking the domainerror flag. > > Both of these things, of course, should be fixed. We need to add support > to the MatMult_MFFD() to indicate domain errors and we need to check all > the code to make sure we always handle the domain error flag. > > In particular, we check for domain errors inside the linesearch and after the linear update. Which means that, if after the linear update you are still hitting a domain error, the solver will quit. This problem is somewhat related to the question of what to do inside SNESVI (bounded) MF solves: if a constraint is active, it's quite possible that differencing in a given direction will cause a domain error (this situation might arise, for example, in Relap-7 with its bounds on densities). For reduced space methods we might simply mask out the active components of a differencing direction, since the linear solve ignores those anyway. It's less clear to me what to do with the bounds that are hit, but are inactive. Or even interior points that are within a differencing parameter of the boundary of the feasible set? The same goes for semismooth solvers (or, perhaps, other methods that we might want to eventually incorporate from Tao). Also, while we are at it, we ought to unify MatMFFD with SNESComputeJacobianDefault(), which more or less duplicates the MFFD algorithms. Dmitry. > Barry > > > > > > Here's my stupid debugging code that's at the top of my residual > callback method: > > > > static int count = 0; > > count++; > > > > if (count == 5) > > { > > std::cout<<"stopping solve!"< > SNESSetFunctionDomainError(snes); > > } > > > > > > During the solve "stopping solve!" gets printed out after computing the > 3rd linear iteration of the first newton step... but the solve just > continues without stopping... > > > > Is there something more I need to do here? > > > > Thanks! > > > > Derek > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From karpeev at mcs.anl.gov Sun Aug 24 22:37:46 2014 From: karpeev at mcs.anl.gov (Dmitry Karpeyev) Date: Sun, 24 Aug 2014 22:37:46 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Aug 24, 2014 9:40 PM, "Barry Smith" wrote: > > > On Aug 24, 2014, at 9:06 PM, Derek Gaston wrote: > > > There must be something I'm missing about SNESSetFunctionDomainError(). > > > > I'm using a matrix free newton solve and I was hoping that calling SNESSetFunctionDomainError() would completely stop the nonlinear solver... but that doesn't appear to be the case. > > > > Now - if I call that function during the initial residual computation it appears to work (the solve never starts). However, if I call it during the _middle_ of a matrix free nonlinear solve during a residual calculation - it appears to do absolutely nothing. > > You are not missing anything. The way SNESSetFunctionDomainError() works is it merely sets a flag in the SNES object. The solver code then can check that flag after a function evaluation and generate an if that flag is set (or perhaps do some kind of recovery). So, for example, at the beginning of SNESSolve_NewtonLS() we have > > } else { > if (!snes->vec_func_init_set) { > ierr = SNESComputeFunction(snes,X,F);CHKERRQ(ierr); > ierr = SNESGetFunctionDomainError(snes, &domainerror);CHKERRQ(ierr); > if (domainerror) { > snes->reason = SNES_DIVERGED_FUNCTION_DOMAIN; > PetscFunctionReturn(0); > > Now the reason it is not erroring out for you is because > > 1) our MatMult_MFFD() totally ignores the SNES domain error business because it doesn?t even know about SNES This could potentially be fixed by letting domain errors be treated as regular PETSc errors. In particular, solvers could push and pop (e.g., before the linear solve) custom error handlers that would set an appropriate converged reason. I think there would be no noticeable performance penalty, since the error handler would only fire when there is an actual domain error, and then the expectation of high performance is out. > > 2) inside the various nonlinear solvers and many complicated line search codes we may not always be checking the domainerror flag. > > Both of these things, of course, should be fixed. We need to add support to the MatMult_MFFD() to indicate domain errors and we need to check all the code to make sure we always handle the domain error flag. > > Barry > > > > > > Here's my stupid debugging code that's at the top of my residual callback method: > > > > static int count = 0; > > count++; > > > > if (count == 5) > > { > > std::cout<<"stopping solve!"< > SNESSetFunctionDomainError(snes); > > } > > > > > > During the solve "stopping solve!" gets printed out after computing the 3rd linear iteration of the first newton step... but the solve just continues without stopping... > > > > Is there something more I need to do here? > > > > Thanks! > > > > Derek > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 24 22:45:30 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 24 Aug 2014 22:45:30 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Aug 24, 2014, at 10:37 PM, Dmitry Karpeyev wrote: > > On Aug 24, 2014 9:40 PM, "Barry Smith" wrote: > > > > > > On Aug 24, 2014, at 9:06 PM, Derek Gaston wrote: > > > > > There must be something I'm missing about SNESSetFunctionDomainError(). > > > > > > I'm using a matrix free newton solve and I was hoping that calling SNESSetFunctionDomainError() would completely stop the nonlinear solver... but that doesn't appear to be the case. > > > > > > Now - if I call that function during the initial residual computation it appears to work (the solve never starts). However, if I call it during the _middle_ of a matrix free nonlinear solve during a residual calculation - it appears to do absolutely nothing. > > > > You are not missing anything. The way SNESSetFunctionDomainError() works is it merely sets a flag in the SNES object. The solver code then can check that flag after a function evaluation and generate an if that flag is set (or perhaps do some kind of recovery). So, for example, at the beginning of SNESSolve_NewtonLS() we have > > > > } else { > > if (!snes->vec_func_init_set) { > > ierr = SNESComputeFunction(snes,X,F);CHKERRQ(ierr); > > ierr = SNESGetFunctionDomainError(snes, &domainerror);CHKERRQ(ierr); > > if (domainerror) { > > snes->reason = SNES_DIVERGED_FUNCTION_DOMAIN; > > PetscFunctionReturn(0); > > > > Now the reason it is not erroring out for you is because > > > > 1) our MatMult_MFFD() totally ignores the SNES domain error business because it doesn?t even know about SNES > > This could potentially be fixed by letting domain errors be treated as regular PETSc errors. In particular, solvers could push and pop (e.g., before the linear solve) custom error handlers that would set an appropriate converged reason. I think there would be no noticeable performance penalty, since the error handler would only fire when there is an actual domain error, and then the expectation of high performance is out. I tried once to convert PETSc errors to be more ?exception like? and let them be caught and handled. It worked but was kind of clunky so I gave up on it and decided that anything we wanted to be ?handled? instead of just passed up as an error would be code instead of errors. This may even be when the SNESFunctionDomainError was introduced. The simplest fix is for MatMult_MFFD() to generate a regular error when it sees a domain error which will stop the code; in the longer run we may want to propagate it up without generating a full error. Derek, What are your current needs? Do you want the program to just end in this case or do you want some kind of recovery when the matrix-free multiply causes a domain error? Barry > > > > > 2) inside the various nonlinear solvers and many complicated line search codes we may not always be checking the domainerror flag. > > > > Both of these things, of course, should be fixed. We need to add support to the MatMult_MFFD() to indicate domain errors and we need to check all the code to make sure we always handle the domain error flag. > > > > Barry > > > > > > > > > > Here's my stupid debugging code that's at the top of my residual callback method: > > > > > > static int count = 0; > > > count++; > > > > > > if (count == 5) > > > { > > > std::cout<<"stopping solve!"< > > SNESSetFunctionDomainError(snes); > > > } > > > > > > > > > During the solve "stopping solve!" gets printed out after computing the 3rd linear iteration of the first newton step... but the solve just continues without stopping... > > > > > > Is there something more I need to do here? > > > > > > Thanks! > > > > > > Derek > > From karpeev at mcs.anl.gov Sun Aug 24 22:49:38 2014 From: karpeev at mcs.anl.gov (Dmitry Karpeyev) Date: Sun, 24 Aug 2014 22:49:38 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Aug 24, 2014 10:45 PM, "Barry Smith" wrote: > > > On Aug 24, 2014, at 10:37 PM, Dmitry Karpeyev wrote: > > > > > On Aug 24, 2014 9:40 PM, "Barry Smith" wrote: > > > > > > > > > On Aug 24, 2014, at 9:06 PM, Derek Gaston wrote: > > > > > > > There must be something I'm missing about SNESSetFunctionDomainError(). > > > > > > > > I'm using a matrix free newton solve and I was hoping that calling SNESSetFunctionDomainError() would completely stop the nonlinear solver... but that doesn't appear to be the case. > > > > > > > > Now - if I call that function during the initial residual computation it appears to work (the solve never starts). However, if I call it during the _middle_ of a matrix free nonlinear solve during a residual calculation - it appears to do absolutely nothing. > > > > > > You are not missing anything. The way SNESSetFunctionDomainError() works is it merely sets a flag in the SNES object. The solver code then can check that flag after a function evaluation and generate an if that flag is set (or perhaps do some kind of recovery). So, for example, at the beginning of SNESSolve_NewtonLS() we have > > > > > > } else { > > > if (!snes->vec_func_init_set) { > > > ierr = SNESComputeFunction(snes,X,F);CHKERRQ(ierr); > > > ierr = SNESGetFunctionDomainError(snes, &domainerror);CHKERRQ(ierr); > > > if (domainerror) { > > > snes->reason = SNES_DIVERGED_FUNCTION_DOMAIN; > > > PetscFunctionReturn(0); > > > > > > Now the reason it is not erroring out for you is because > > > > > > 1) our MatMult_MFFD() totally ignores the SNES domain error business because it doesn?t even know about SNES > > > > This could potentially be fixed by letting domain errors be treated as regular PETSc errors. In particular, solvers could push and pop (e.g., before the linear solve) custom error handlers that would set an appropriate converged reason. I think there would be no noticeable performance penalty, since the error handler would only fire when there is an actual domain error, and then the expectation of high performance is out. > > I tried once to convert PETSc errors to be more ?exception like? and let them be caught and handled. It worked but was kind of clunky so I gave up on it and decided that anything we wanted to be ?handled? instead of just passed up as an error would be code instead of errors. This may even be when the SNESFunctionDomainError was introduced. The simplest fix is for MatMult_MFFD() to generate a regular error when it sees a domain error Since, as you point out, MatMFFD doesn't know anything about SNES, it has nowhere to check for the domain error. Unless it becomes a regular PETSc error, in which case MatMFFD will abort automatically as part of the default error handling procedure. which will stop the code; in the longer run we may want to propagate it up without generating a full error. > > Derek, > > What are your current needs? Do you want the program to just end in this case or do you want some kind of recovery when the matrix-free multiply causes a domain error? > > Barry > > > > > > > > > 2) inside the various nonlinear solvers and many complicated line search codes we may not always be checking the domainerror flag. > > > > > > Both of these things, of course, should be fixed. We need to add support to the MatMult_MFFD() to indicate domain errors and we need to check all the code to make sure we always handle the domain error flag. > > > > > > Barry > > > > > > > > > > > > > > Here's my stupid debugging code that's at the top of my residual callback method: > > > > > > > > static int count = 0; > > > > count++; > > > > > > > > if (count == 5) > > > > { > > > > std::cout<<"stopping solve!"< > > > SNESSetFunctionDomainError(snes); > > > > } > > > > > > > > > > > > During the solve "stopping solve!" gets printed out after computing the 3rd linear iteration of the first newton step... but the solve just continues without stopping... > > > > > > > > Is there something more I need to do here? > > > > > > > > Thanks! > > > > > > > > Derek > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sun Aug 24 23:05:05 2014 From: jed at jedbrown.org (Jed Brown) Date: Sun, 24 Aug 2014 22:05:05 -0600 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: <877g1xgqoe.fsf@jedbrown.org> Barry Smith writes: > I tried once to convert PETSc errors to be more ?exception like? > and let them be caught and handled. It worked but was kind of > clunky so I gave up on it and decided that anything we wanted to be > ?handled? instead of just passed up as an error would be code > instead of errors. This is valuable for debugging. Using exceptions for control flow breaks the ability to find real errors by simply breaking on PetscError. > This may even be when the SNESFunctionDomainError was > introduced. The simplest fix is for MatMult_MFFD() to generate a > regular error when it sees a domain error which will stop the code; > in the longer run we may want to propagate it up without generating > a full error. SETERRQ is not an option here because the application wants to handle the error. Better to mark the result Vec as invalid (either in-band or out-of-band). -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From mfadams at lbl.gov Mon Aug 25 09:49:35 2014 From: mfadams at lbl.gov (Mark Adams) Date: Mon, 25 Aug 2014 10:49:35 -0400 Subject: [petsc-users] dynamic matrix type & dense matrix. Message-ID: I have a matrix that is logically dense and I create it like this: call MatCreate(solver%comm,solver%schur,ierr); call MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) call MatSetType(solver%schur,MATAIJ,ierr) call MatSeqAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,ierr) call MatMPIAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,i,PETSC_NULL_INTEGER,ierr) !call MatSetFromOptions(solver%schur,ierr) This works but if I uncomment MatSetFromOptions, and comment out the AIJ lines, and have '-mat_type dense' I get an error that the row is too large. I can see from the trace that this happens in MatSetValues_MPIDense. If I don't comment out the AIJ calls then I get a segv in MatSetValues, that is called from MatSetValues_MPIDense. It segvs on the first line that uses the 'mat' so it looks like it is being called with garbage. Any ideas? Mark -------------- next part -------------- An HTML attachment was scrubbed... URL: From lu_qin_2000 at yahoo.com Mon Aug 25 09:53:23 2014 From: lu_qin_2000 at yahoo.com (Qin Lu) Date: Mon, 25 Aug 2014 07:53:23 -0700 Subject: [petsc-users] Solve of subdomains without connections Message-ID: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> Hello, ? I am using PETSc ksp solver to solve a problem on a physical domain. The domain is splitted to subdomains in such a way that there is no connections between them, but I still have to solve the whole domain as a single linear system. My questions are: ? 1. Does PETSc detect that the matrix is a block diagonal matrix and solve it efficiently? 2. In parallel solve, each subdoamin is assigned to a separate process. Does PETSc solve the system efficiently by avoiding all the unnecessary parallel message passing since there is no connections between processes? ? Thanks, Qin -------------- next part -------------- An HTML attachment was scrubbed... URL: From sylvainmercier85 at gmail.com Mon Aug 25 09:59:20 2014 From: sylvainmercier85 at gmail.com (Sylvain Mercier) Date: Mon, 25 Aug 2014 16:59:20 +0200 Subject: [petsc-users] Petsc with mumps single precision In-Reply-To: References: Message-ID: Thank you Matthew and Hong. That's too bad... I was wondering if it would be possible to add this alternative only in the MUMPS interface. Indeed, in the field of solid mechanics (where 3D, beams and shell are often mixed thanks to Lagrange multipliers), it's very usefull to factorize a matrix in single precision thanks to MUMPS, and use it to precondition a sequence of systems solved in double precision. It turns to be very robust and quite fast. In *src/mat/impls/aij/mpi/mumps/mumps.c,* a new type, say PetscMumpsSingleScalar, could be defined in order to pass the required information to the single precision MUMPS solver. Would the Petsc team accept to integrate such a feature? Thanks, Sylvain 2014-08-20 17:57 GMT+02:00 Matthew Knepley : > On Wed, Aug 20, 2014 at 7:53 AM, Sylvain Mercier < > sylvainmercier85 at gmail.com> wrote: > >> Hi everyone, >> >> I'm using PETSc to solve saddle point systems. I have found a block >> preconditionner which requires to solve a smaller symmetric positive >> definite system. I do it with MUMPS which is fast an robust. >> However, I would like to use this solver in single precision in order to >> compare the performances. >> >> So is it possible to use MUMPS in single precision inside a double >> precision solving with PETSc? >> > > No, right now PETSc must have all the same precision. We have investigated > several methods for > using multi-precision, but none has satisfied all our needs. > > Thanks, > > Matt > > >> Thanks, >> Sylvain >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 25 11:34:32 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 25 Aug 2014 11:34:32 -0500 Subject: [petsc-users] dynamic matrix type & dense matrix. In-Reply-To: References: Message-ID: On Mon, Aug 25, 2014 at 9:49 AM, Mark Adams wrote: > I have a matrix that is logically dense and I create it like this: > > call MatCreate(solver%comm,solver%schur,ierr); > call > MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) > call MatSetType(solver%schur,MATAIJ,ierr) > call > MatSeqAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,ierr) > call > MatMPIAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,i,PETSC_NULL_INTEGER,ierr) > !call MatSetFromOptions(solver%schur,ierr) > Send the full error from call MatCreate(solver%comm,solver%schur,ierr); call MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) call MatSetFromOptions(solver%schur,ierr) call MatSetUp(solver%schur, ierr) Thanks, Matt > This works but if I uncomment MatSetFromOptions, and comment out the AIJ > lines, and have '-mat_type dense' I get an error that the row is too large. > I can see from the trace that this happens in MatSetValues_MPIDense. If I > don't comment out the AIJ calls then I get a segv in MatSetValues, that is > called from MatSetValues_MPIDense. It segvs on the first line that uses > the 'mat' so it looks like it is being called with garbage. > > Any ideas? > Mark > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From cedric.doucet at inria.fr Mon Aug 25 11:43:05 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Mon, 25 Aug 2014 18:43:05 +0200 (CEST) Subject: [petsc-users] Error and success codes In-Reply-To: <309567480.13702269.1408984267762.JavaMail.zimbra@inria.fr> Message-ID: <1500811367.13704385.1408984985660.JavaMail.zimbra@inria.fr> Hello, I want to manage errors with CHKERRQ macro in void functions. I do not want to use CHKERRV. I prefer to modify void functions so that they return an error code. However, it seems CHKERRQ returns a value in case of failure only. Example below does not seem to compile without warning (Wreturn-type flag): -------------------------- PetscErrorCode foo() { PetscErrorCode code = somePetscFunction(); CHKERRQ(code); } -------------------------- I guess I need to return a success code like this: -------------------------- PetscErrorCode foo() { PetscErrorCode code = somePetscFunction(); CHKERRQ(code); return PETSC_SUCCESS_CODE; } -------------------------- However, I do not know the value of the success code of Petsc. I guess it is zero but I would prefer to use a macro sucha as PETSC_SUCCESS_CODE in the above example. Does such a macro exist? Best, C?dric -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 25 11:47:25 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 25 Aug 2014 10:47:25 -0600 Subject: [petsc-users] Error and success codes In-Reply-To: <1500811367.13704385.1408984985660.JavaMail.zimbra@inria.fr> References: <1500811367.13704385.1408984985660.JavaMail.zimbra@inria.fr> Message-ID: <87oav8frdu.fsf@jedbrown.org> Cedric Doucet writes: > Hello, > > I want to manage errors with CHKERRQ macro in void functions. > > I do not want to use CHKERRV. > I prefer to modify void functions so that they return an error code. > > However, it seems CHKERRQ returns a value in case of failure only. > Example below does not seem to compile without warning (Wreturn-type flag): > > -------------------------- > PetscErrorCode foo() > { > PetscErrorCode code = somePetscFunction(); > CHKERRQ(code); > } > -------------------------- > > I guess I need to return a success code like this: > > -------------------------- > PetscErrorCode foo() > { > PetscErrorCode code = somePetscFunction(); > CHKERRQ(code); > return PETSC_SUCCESS_CODE; > } > -------------------------- > > However, I do not know the value of the success code of Petsc. > I guess it is zero but I would prefer to use a macro sucha as PETSC_SUCCESS_CODE in the above example. > Does such a macro exist? No, use 0. It's less typing and that is something that will definitely never change. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From mfadams at lbl.gov Mon Aug 25 11:57:47 2014 From: mfadams at lbl.gov (Mark Adams) Date: Mon, 25 Aug 2014 12:57:47 -0400 Subject: [petsc-users] dynamic matrix type & dense matrix. In-Reply-To: References: Message-ID: MatSetup was the issues: this seems to work with and w/o -mat_type dense: call MatCreate(solver%comm,solver%schur,ierr); call MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) call MatSetType(solver%schur,MATAIJ,ierr) call MatSeqAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,ierr) call MatMPIAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,i,PETSC_NULL_INTEGER,ierr) call MatSetFromOptions(solver%schur,ierr) call MatSetup(solver%schur,ierr) On Mon, Aug 25, 2014 at 12:34 PM, Matthew Knepley wrote: > On Mon, Aug 25, 2014 at 9:49 AM, Mark Adams wrote: > >> I have a matrix that is logically dense and I create it like this: >> >> call MatCreate(solver%comm,solver%schur,ierr); >> call >> MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) >> call MatSetType(solver%schur,MATAIJ,ierr) >> call >> MatSeqAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,ierr) >> call >> MatMPIAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,i,PETSC_NULL_INTEGER,ierr) >> !call MatSetFromOptions(solver%schur,ierr) >> > > Send the full error from > > call MatCreate(solver%comm,solver%schur,ierr); > call > MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) > call MatSetFromOptions(solver%schur,ierr) > call MatSetUp(solver%schur, ierr) > > Thanks, > > Matt > > >> This works but if I uncomment MatSetFromOptions, and comment out the AIJ >> lines, and have '-mat_type dense' I get an error that the row is too large. >> I can see from the trace that this happens in MatSetValues_MPIDense. If I >> don't comment out the AIJ calls then I get a segv in MatSetValues, that is >> called from MatSetValues_MPIDense. It segvs on the first line that uses >> the 'mat' so it looks like it is being called with garbage. >> >> Any ideas? >> Mark >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 25 13:02:17 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 25 Aug 2014 13:02:17 -0500 Subject: [petsc-users] Petsc with mumps single precision In-Reply-To: References: Message-ID: <983484A0-3747-417C-9A96-7DBF16692689@mcs.anl.gov> On Aug 25, 2014, at 9:59 AM, Sylvain Mercier wrote: > Thank you Matthew and Hong. > > That's too bad... > I was wondering if it would be possible to add this alternative only in the MUMPS interface. > Indeed, in the field of solid mechanics (where 3D, beams and shell are often mixed thanks to Lagrange multipliers), it's very usefull to factorize a matrix in single precision thanks to MUMPS, and use it to precondition a sequence of systems solved in double precision. It turns to be very robust and quite fast. > > In src/mat/impls/aij/mpi/mumps/mumps.c, a new type, say PetscMumpsSingleScalar, could be defined in order to pass the required information to the single precision > MUMPS solver. > > Would the Petsc team accept to integrate such a feature? Sylvain, Yes this would be possible; it is the maintenance and clarity of the code that becomes an issue. Basically all the MatConvertToTriples() routines would need to optionally make a copy of the numerical values into single precision and similarly the right hand side would need to do the same when some option on the factorization saying to use single precision is set. Barry > > Thanks, > Sylvain > > > 2014-08-20 17:57 GMT+02:00 Matthew Knepley : > On Wed, Aug 20, 2014 at 7:53 AM, Sylvain Mercier wrote: > Hi everyone, > > I'm using PETSc to solve saddle point systems. I have found a block preconditionner which requires to solve a smaller symmetric positive definite system. I do it with MUMPS which is fast an robust. > However, I would like to use this solver in single precision in order to compare the performances. > > So is it possible to use MUMPS in single precision inside a double precision solving with PETSc? > > No, right now PETSc must have all the same precision. We have investigated several methods for > using multi-precision, but none has satisfied all our needs. > > Thanks, > > Matt > > Thanks, > Sylvain > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > From jychang48 at gmail.com Mon Aug 25 14:10:33 2014 From: jychang48 at gmail.com (Justin Chang) Date: Mon, 25 Aug 2014 14:10:33 -0500 Subject: [petsc-users] Identifying mesh points within DMPlex FEM Message-ID: Hi all, In the discretization schemes for the DMPlex FEM examples (ex12 and ex62), it lets us specify equations as pointwise functions. But what if I wanted to assign "regions" to different points within the domain? In one of my problems, I want the diffusivity tensor and/or forcing function to differ for various layers/regions within the computational domain. I would imagine calling something like DMPlexGetLabelValue() to identify a region associated with a given mesh point but is it possible to do something like this within the f0/f1/g3/etc functions? Thanks, Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From sahai2 at illinois.edu Mon Aug 25 16:09:27 2014 From: sahai2 at illinois.edu (Sahai, Amal) Date: Mon, 25 Aug 2014 21:09:27 +0000 Subject: [petsc-users] command line option for displaying solver details Message-ID: <54F02FA4CAB5E646927484F9ADCEFBD11A07D37A@chimbx4.ad.uillinois.edu> Hi What is the command line argument for displaying details of the linear solver being used for a problem (PCType, KSPType, Tolerance)? Regards Amal -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 25 16:19:21 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 25 Aug 2014 15:19:21 -0600 Subject: [petsc-users] command line option for displaying solver details In-Reply-To: <54F02FA4CAB5E646927484F9ADCEFBD11A07D37A@chimbx4.ad.uillinois.edu> References: <54F02FA4CAB5E646927484F9ADCEFBD11A07D37A@chimbx4.ad.uillinois.edu> Message-ID: <874mx0fesm.fsf@jedbrown.org> "Sahai, Amal" writes: > Hi > > What is the command line argument for displaying details of the linear solver being used for a problem (PCType, KSPType, Tolerance)? -ksp_view -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From knepley at gmail.com Mon Aug 25 16:33:18 2014 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 25 Aug 2014 16:33:18 -0500 Subject: [petsc-users] Identifying mesh points within DMPlex FEM In-Reply-To: References: Message-ID: On Mon, Aug 25, 2014 at 2:10 PM, Justin Chang wrote: > Hi all, > > In the discretization schemes for the DMPlex FEM examples (ex12 and ex62), > it lets us specify equations as pointwise functions. But what if I wanted > to assign "regions" to different points within the domain? In one of my > problems, I want the diffusivity tensor and/or forcing function to differ > for various layers/regions within the computational domain. I would imagine > calling something like DMPlexGetLabelValue() to identify a region > associated with a given mesh point but is it possible to do something like > this within the f0/f1/g3/etc functions? > 1) Changing parameters across the domain is straightforward. ex12 does this for "diffusivity". 2) Changing the function across the domain should probably be accomplished by changing a marker parameter, which is checked inside the function itself. Matt > Thanks, > Justin > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From lu_qin_2000 at yahoo.com Mon Aug 25 17:18:16 2014 From: lu_qin_2000 at yahoo.com (Qin Lu) Date: Mon, 25 Aug 2014 15:18:16 -0700 Subject: [petsc-users] Solve of subdomains without connections In-Reply-To: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> References: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> Message-ID: <1409005096.26414.YahooMailNeo@web160206.mail.bf1.yahoo.com> Hello, I am using PETSc ksp solver to solve a problem on a physical domain. The domain is splitted to subdomains in such a way that there is no connections between them, but I still have to solve the whole domain as a single linear system. My questions are: 1. Does PETSc detect that the matrix is a block diagonal matrix and solve it efficiently? 2. In parallel solve, each subdoamin is assigned to a separate process. Does PETSc solve the system efficiently by avoiding all the unnecessary parallel message passing since there is no connections between processes? Thanks, Qin -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 25 17:48:04 2014 From: jed at jedbrown.org (Jed Brown) Date: Mon, 25 Aug 2014 16:48:04 -0600 Subject: [petsc-users] dynamic matrix type & dense matrix. In-Reply-To: References: Message-ID: <874mx0dw4b.fsf@jedbrown.org> Mark Adams writes: > MatSetup was the issues: this seems to work with and w/o -mat_type dense: > > call MatCreate(solver%comm,solver%schur,ierr); > call > MatSetSizes(solver%schur,nloc,nloc,PETSC_DECIDE,PETSC_DECIDE,ierr) > call MatSetType(solver%schur,MATAIJ,ierr) > call > MatSeqAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,ierr) > call > MatMPIAIJSetPreallocation(solver%schur,nloc,PETSC_NULL_INTEGER,i,PETSC_NULL_INTEGER,ierr) > call MatSetFromOptions(solver%schur,ierr) Changing the matrix type (-mat_type) after calling the preallocation functions above will lose that preallocation information. Better to call MatSetFromOptions first. > call MatSetup(solver%schur,ierr) How is A->preallocated being set? MatSetValues checks for it and MatSetType makes it false. We need to find out why so that users don't stumble over this. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From bsmith at mcs.anl.gov Mon Aug 25 20:19:16 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 25 Aug 2014 20:19:16 -0500 Subject: [petsc-users] Solve of subdomains without connections In-Reply-To: <1409005096.26414.YahooMailNeo@web160206.mail.bf1.yahoo.com> References: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> <1409005096.26414.YahooMailNeo@web160206.mail.bf1.yahoo.com> Message-ID: On Aug 25, 2014, at 5:18 PM, Qin Lu wrote: > Hello, > > I am using PETSc ksp solver to solve a problem on a physical domain. The domain is splitted to subdomains in such a way that there is no connections between them, but I still have to solve the whole domain as a single linear system. My questions are: > > 1. Does PETSc detect that the matrix is a block diagonal matrix and solve it efficiently? > 2. In parallel solve, each subdoamin is assigned to a separate process. Does PETSc solve the system efficiently by avoiding all the unnecessary parallel message passing since there is no connections between processes? If you use block Jacobi preconditioner then there will be no communication during the matrix-vector product nor the preconditioner. However the global reductions for the default Krylov method GMRES will still occur. To eliminate the global reductions use for a solve -ksp_type preonly -pc_type bjacobi -sub_ksp_type gmres (or whatever Krylov method you want on each process) -sub_pc_type ilu (or whatever preconditioner you want on each process). Now there will be no communication during the linear solve. Barry > > Thanks, > Qin > > From lu_qin_2000 at yahoo.com Mon Aug 25 21:33:03 2014 From: lu_qin_2000 at yahoo.com (Qin Lu) Date: Mon, 25 Aug 2014 19:33:03 -0700 Subject: [petsc-users] Solve of subdomains without connections In-Reply-To: References: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> <1409005096.26414.YahooMailNeo@web160206.mail.bf1.yahoo.com> Message-ID: <1409020383.97370.YahooMailNeo@web160201.mail.bf1.yahoo.com> What if I use?-pc_type?asm? Will the communication be avoided in this special case? Thanks, Qin ________________________________ From: Barry Smith To: Qin Lu Cc: Petsc-users Sent: Monday, August 25, 2014 8:19 PM Subject: Re: [petsc-users] Solve of subdomains without connections On Aug 25, 2014, at 5:18 PM, Qin Lu wrote: > Hello, >? > I am using PETSc ksp solver to solve a problem on a physical domain. The domain is splitted to subdomains in such a way that there is no connections between them, but I still have to solve the whole domain as a single linear system. My questions are: >? > 1. Does PETSc detect that the matrix is a block diagonal matrix and solve it efficiently? > 2. In parallel solve, each subdoamin is assigned to a separate process. Does PETSc solve the system efficiently by avoiding all the unnecessary parallel message passing since there is no connections between processes? ? If you use block Jacobi preconditioner then there will be no communication during the matrix-vector product nor the preconditioner. However the global reductions for the default Krylov method GMRES will still occur.? To eliminate the global reductions use for a solve ? -ksp_type preonly -pc_type bjacobi? -sub_ksp_type gmres (or whatever Krylov method you want on each process) -sub_pc_type ilu (or whatever preconditioner you want on each process). ? Now there will be no communication during the linear solve. ? Barry >? > Thanks, > Qin > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 25 21:36:13 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 25 Aug 2014 21:36:13 -0500 Subject: [petsc-users] Solve of subdomains without connections In-Reply-To: <1409020383.97370.YahooMailNeo@web160201.mail.bf1.yahoo.com> References: <1408978403.68884.YahooMailNeo@web160220.mail.bf1.yahoo.com> <1409005096.26414.YahooMailNeo@web160206.mail.bf1.yahoo.com> <1409020383.97370.YahooMailNeo@web160201.mail.bf1.yahoo.com> Message-ID: <085E50ED-5D4B-4131-87BA-7D4F99E0DC2F@mcs.anl.gov> On Aug 25, 2014, at 9:33 PM, Qin Lu wrote: > What if I use -pc_type asm? Will the communication be avoided in this special case? It will do one reduction at the beginning of building the preconditioner when it determines that there is no overlap between subdomains. Otherwise it will have no more communication than bjacobi. But the solver will end up being identical to using bjacobi so why bother with ASM? Barry > > Thanks, > Qin > > From: Barry Smith > To: Qin Lu > Cc: Petsc-users > Sent: Monday, August 25, 2014 8:19 PM > Subject: Re: [petsc-users] Solve of subdomains without connections > > > On Aug 25, 2014, at 5:18 PM, Qin Lu wrote: > > > Hello, > > > > I am using PETSc ksp solver to solve a problem on a physical domain. The domain is splitted to subdomains in such a way that there is no connections between them, but I still have to solve the whole domain as a single linear system. My questions are: > > > > 1. Does PETSc detect that the matrix is a block diagonal matrix and solve it efficiently? > > 2. In parallel solve, each subdoamin is assigned to a separate process. Does PETSc solve the system efficiently by avoiding all the unnecessary parallel message passing since there is no connections between processes? > > If you use block Jacobi preconditioner then there will be no communication during the matrix-vector product nor the preconditioner. However the global reductions for the default Krylov method GMRES will still occur. To eliminate the global reductions use for a solve > > -ksp_type preonly -pc_type bjacobi -sub_ksp_type gmres (or whatever Krylov method you want on each process) -sub_pc_type ilu (or whatever preconditioner you want on each process). > > Now there will be no communication during the linear solve. > > Barry > > > > > > Thanks, > > Qin > > > > > > From ncreati at inogs.it Tue Aug 26 01:33:11 2014 From: ncreati at inogs.it (Nicola Creati) Date: Tue, 26 Aug 2014 08:33:11 +0200 Subject: [petsc-users] PETSc/petsc4py error detection Message-ID: <53FC2A27.2080008@inogs.it> Hello, I'm writing a large application in Python that uses petsc4py to solve some equations. Running my code I note that PETSc detects errors in sections (I believe in Cython extensions and packages) where petsc4py is not imported or used. I do not need to fix the problem, I already did it. Is there a way to avoid petsc4py/PETSc to catch errors in not PETSc sections of the code? This is an example of the error message I got: [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors [0]PETSC ERROR: likely location of problem given in stack below [0]PETSC ERROR: --------------------- Stack Frames ------------------------------------ [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, [0]PETSC ERROR: INSTEAD the line number of the start of the function [0]PETSC ERROR: is given. -------------------------------------------------------------------------- mpiexec noticed that process rank 0 with PID 25694 on node daisy exited on signal 11 (Segmentation fault). -------------------------------------------------------------------------- I'm using Python 2.7.6, petsc4py 3.4 and PETSc 3.4.3. Thanks. Nicola -- _____________________________________________________________________ Nicola Creati Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS IRI (Ricerca Teconologica e Infrastrutture) Department B.go Grotta Gigante - Brisciki 42/c 34010 Sgonico - Zgonik (TS) - Italy Tel. +39-0402140213 Fax +39-040327307 From jychang48 at gmail.com Tue Aug 26 02:11:47 2014 From: jychang48 at gmail.com (Justin Chang) Date: Tue, 26 Aug 2014 02:11:47 -0500 Subject: [petsc-users] Identifying mesh points within DMPlex FEM In-Reply-To: References: Message-ID: Matt, I see how parameters (e.g., nu) change across the domain, but from what I understand they are all functions of the point coordinate x[ ]. This would be no problem if my parameters were analytical functions as shown in your examples or if the domain has several nicely layered regions which can be easily distinguished (i.e., I could simply use conditionals to determine a mesh point's region based on the coordinates). However, what if I wanted nu (or any parameter for that matter) to be supplied through a user created data file? In PFLOTRAN, that's how physical data and parameters are associated with a given cell or mesh point. Here's the way I imagine my PETSc code would look using DMPlex: 1) Create DMPlex mesh from an input mesh file 2) Read data file that links physical parameters (e.g., diffusivity, source, etc) to DMPlex mesh points. This should create some sort of data structure or Vec that maps these parameters to the corresponding DMPlex mesh points. 3) Set up FEM discretization and boundary conditions. Like the physical parameters, boundary conditions are also generated/specified through the data file. 4) Solve problem 5) Post-process solution to mesh file. In step 4, the pointwise functions f0_u, f1_u, g3_uu, etc are called upon for each element/mesh point iteration. I suppose my question is, is there any way to incorporate the data formulated from step 2 into said pointwise functions? Thanks, Justin On Mon, Aug 25, 2014 at 4:33 PM, Matthew Knepley wrote: > On Mon, Aug 25, 2014 at 2:10 PM, Justin Chang wrote: > >> Hi all, >> >> In the discretization schemes for the DMPlex FEM examples (ex12 and >> ex62), it lets us specify equations as pointwise functions. But what if I >> wanted to assign "regions" to different points within the domain? In one of >> my problems, I want the diffusivity tensor and/or forcing function to >> differ for various layers/regions within the computational domain. I would >> imagine calling something like DMPlexGetLabelValue() to identify a region >> associated with a given mesh point but is it possible to do something like >> this within the f0/f1/g3/etc functions? >> > > 1) Changing parameters across the domain is straightforward. ex12 does > this for "diffusivity". > > 2) Changing the function across the domain should probably be accomplished > by changing > a marker parameter, which is checked inside the function itself. > > Matt > > >> Thanks, >> Justin >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 26 05:06:56 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 26 Aug 2014 05:06:56 -0500 Subject: [petsc-users] PETSc/petsc4py error detection In-Reply-To: <53FC2A27.2080008@inogs.it> References: <53FC2A27.2080008@inogs.it> Message-ID: On Tue, Aug 26, 2014 at 1:33 AM, Nicola Creati wrote: > Hello, > I'm writing a large application in Python that uses petsc4py to solve some > equations. Running my code I note that PETSc detects errors in sections (I > believe in Cython extensions and packages) where petsc4py is not imported > or used. I do not need to fix the problem, I already did it. Is there a way > to avoid petsc4py/PETSc to catch errors in not PETSc sections of the code? > This is an example of the error message I got: > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/ > documentation/faq.html#valgrind[0]PETSC ERROR: or try http://valgrind.org > on GNU/linux and Apple Mac OS X to find memory corruption errors > [0]PETSC ERROR: likely location of problem given in stack below > [0]PETSC ERROR: --------------------- Stack Frames > ------------------------------------ > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not > available, > [0]PETSC ERROR: INSTEAD the line number of the start of the function > [0]PETSC ERROR: is given. > -------------------------------------------------------------------------- > mpiexec noticed that process rank 0 with PID 25694 on node daisy exited on > signal 11 (Segmentation fault). > -------------------------------------------------------------------------- > > I'm using Python 2.7.6, petsc4py 3.4 and PETSc 3.4.3. > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Sys/PetscPopSignalHandler.html Thanks, Matt > Thanks. > > Nicola > > -- > _____________________________________________________________________ > Nicola Creati > Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS > IRI (Ricerca Teconologica e Infrastrutture) Department > B.go Grotta Gigante - Brisciki 42/c > 34010 Sgonico - Zgonik (TS) - Italy > Tel. +39-0402140213 > Fax +39-040327307 > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 26 05:09:00 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 26 Aug 2014 05:09:00 -0500 Subject: [petsc-users] Identifying mesh points within DMPlex FEM In-Reply-To: References: Message-ID: On Tue, Aug 26, 2014 at 2:11 AM, Justin Chang wrote: > Matt, > > I see how parameters (e.g., nu) change across the domain, but from what I > understand they are all functions of the point coordinate x[ ]. This would > be no problem if my parameters were analytical functions as shown in your > examples or if the domain has several nicely layered regions which can be > easily distinguished (i.e., I could simply use conditionals to determine a > mesh point's region based on the coordinates). > No, they need not be functions. They are only a collection of basis function coefficients, like any FEM field. > However, what if I wanted nu (or any parameter for that matter) to be > supplied through a user created data file? In PFLOTRAN, that's how physical > data and parameters are associated with a given cell or mesh point. Here's > the way I imagine my PETSc code would look using DMPlex: > > 1) Create DMPlex mesh from an input mesh file > 2) Read data file that links physical parameters (e.g., diffusivity, > source, etc) to DMPlex mesh points. This should create some sort of data > structure or Vec that maps these parameters to the corresponding DMPlex > mesh points. > 3) Set up FEM discretization and boundary conditions. Like the physical > parameters, boundary conditions are also generated/specified through the > data file. > 4) Solve problem > 5) Post-process solution to mesh file. > > In step 4, the pointwise functions f0_u, f1_u, g3_uu, etc are called upon > for each element/mesh point iteration. I suppose my question is, is there > any way to incorporate the data formulated from step 2 into said pointwise > functions? > You project the input data into the finite element space. Then this field can be used just as in ex12. Thanks, Matt > > Thanks, > Justin > > On Mon, Aug 25, 2014 at 4:33 PM, Matthew Knepley > wrote: > >> On Mon, Aug 25, 2014 at 2:10 PM, Justin Chang >> wrote: >> >>> Hi all, >>> >>> In the discretization schemes for the DMPlex FEM examples (ex12 and >>> ex62), it lets us specify equations as pointwise functions. But what if I >>> wanted to assign "regions" to different points within the domain? In one of >>> my problems, I want the diffusivity tensor and/or forcing function to >>> differ for various layers/regions within the computational domain. I would >>> imagine calling something like DMPlexGetLabelValue() to identify a region >>> associated with a given mesh point but is it possible to do something like >>> this within the f0/f1/g3/etc functions? >>> >> >> 1) Changing parameters across the domain is straightforward. ex12 does >> this for "diffusivity". >> >> 2) Changing the function across the domain should probably be >> accomplished by changing >> a marker parameter, which is checked inside the function itself. >> >> Matt >> >> >>> Thanks, >>> Justin >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From ncreati at inogs.it Tue Aug 26 05:24:53 2014 From: ncreati at inogs.it (Nicola Creati) Date: Tue, 26 Aug 2014 12:24:53 +0200 Subject: [petsc-users] PETSc/petsc4py error detection In-Reply-To: References: <53FC2A27.2080008@inogs.it> Message-ID: <53FC6075.9020103@inogs.it> On 08/26/2014 12:06 PM, Matthew Knepley wrote: > On Tue, Aug 26, 2014 at 1:33 AM, Nicola Creati > wrote: > > Hello, > I'm writing a large application in Python that uses petsc4py to > solve some equations. Running my code I note that PETSc detects > errors in sections (I believe in Cython extensions and packages) > where petsc4py is not imported or used. I do not need to fix the > problem, I already did it. Is there a way to avoid petsc4py/PETSc > to catch errors in not PETSc sections of the code? > This is an example of the error message I got: > > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation > Violation, probably memory access out of range > [0]PETSC ERROR: Try option -start_in_debugger or > -on_error_attach_debugger > [0]PETSC ERROR: or see > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC > ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X > to find memory corruption errors > [0]PETSC ERROR: likely location of problem given in stack below > [0]PETSC ERROR: --------------------- Stack Frames > ------------------------------------ > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not > available, > [0]PETSC ERROR: INSTEAD the line number of the start of the > function > [0]PETSC ERROR: is given. > -------------------------------------------------------------------------- > mpiexec noticed that process rank 0 with PID 25694 on node daisy > exited on signal 11 (Segmentation fault). > -------------------------------------------------------------------------- > > I'm using Python 2.7.6, petsc4py 3.4 and PETSc 3.4.3. > > > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Sys/PetscPopSignalHandler.html > > Thanks, > > Matt > > Thanks. > > Nicola > > -- > _____________________________________________________________________ > Nicola Creati > Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS > IRI (Ricerca Teconologica e Infrastrutture) Department > B.go Grotta Gigante - Brisciki 42/c > 34010 Sgonico - Zgonik (TS) - Italy > Tel. +39-0402140213 > Fax +39-040327307 > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener Thank you, but PetscPopSignalHandler has not been wrapped in petsc4py. Nicola -- _____________________________________________________________________ Nicola Creati Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS IRI (Ricerca Teconologica e Infrastrutture) Department B.go Grotta Gigante - Brisciki 42/c 34010 Sgonico - Zgonik (TS) - Italy Tel. +39-0402140213 Fax +39-040327307 -------------- next part -------------- An HTML attachment was scrubbed... URL: From dalcinl at gmail.com Tue Aug 26 06:55:11 2014 From: dalcinl at gmail.com (Lisandro Dalcin) Date: Tue, 26 Aug 2014 14:55:11 +0300 Subject: [petsc-users] PETSc/petsc4py error detection In-Reply-To: <53FC6075.9020103@inogs.it> References: <53FC2A27.2080008@inogs.it> <53FC6075.9020103@inogs.it> Message-ID: On 26 August 2014 13:24, Nicola Creati wrote: > > Thank you, but PetscPopSignalHandler has not been wrapped in petsc4py. > What about overriding the signal handler using Python's builtin "signal" module? -- Lisandro Dalcin ============ Research Scientist Computer, Electrical and Mathematical Sciences & Engineering (CEMSE) Numerical Porous Media Center (NumPor) King Abdullah University of Science and Technology (KAUST) http://numpor.kaust.edu.sa/ 4700 King Abdullah University of Science and Technology al-Khawarizmi Bldg (Bldg 1), Office # 4332 Thuwal 23955-6900, Kingdom of Saudi Arabia http://www.kaust.edu.sa Office Phone: +966 12 808-0459 From dominik at itis.ethz.ch Tue Aug 26 07:08:45 2014 From: dominik at itis.ethz.ch (Dominik Szczerba) Date: Tue, 26 Aug 2014 14:08:45 +0200 Subject: [petsc-users] Opposite to MatGetSubMatrix? Message-ID: Is there a function acting the opposite way to MatGetSubMatrix, i.e. enlarging the existing matrix with (empty) rows/columns? Thanks! -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 26 07:15:59 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 26 Aug 2014 07:15:59 -0500 Subject: [petsc-users] Opposite to MatGetSubMatrix? In-Reply-To: References: Message-ID: On Tue, Aug 26, 2014 at 7:08 AM, Dominik Szczerba wrote: > Is there a function acting the opposite way to MatGetSubMatrix, i.e. > enlarging the existing matrix with (empty) rows/columns? > Nope. Matt > Thanks! > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 26 07:26:45 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 26 Aug 2014 07:26:45 -0500 Subject: [petsc-users] PETSc/petsc4py error detection In-Reply-To: <53FC2A27.2080008@inogs.it> References: <53FC2A27.2080008@inogs.it> Message-ID: <780D6F81-5625-442B-9A41-56FFD802B62C@mcs.anl.gov> You can run PETSc with the option -no_signal_handler and it will not catch these errors. Barry On Aug 26, 2014, at 1:33 AM, Nicola Creati wrote: > Hello, > I'm writing a large application in Python that uses petsc4py to solve some equations. Running my code I note that PETSc detects errors in sections (I believe in Cython extensions and packages) where petsc4py is not imported or used. I do not need to fix the problem, I already did it. Is there a way to avoid petsc4py/PETSc to catch errors in not PETSc sections of the code? > This is an example of the error message I got: > > [0]PETSC ERROR: ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[0]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors > [0]PETSC ERROR: likely location of problem given in stack below > [0]PETSC ERROR: --------------------- Stack Frames ------------------------------------ > [0]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, > [0]PETSC ERROR: INSTEAD the line number of the start of the function > [0]PETSC ERROR: is given. > -------------------------------------------------------------------------- > mpiexec noticed that process rank 0 with PID 25694 on node daisy exited on signal 11 (Segmentation fault). > -------------------------------------------------------------------------- > > I'm using Python 2.7.6, petsc4py 3.4 and PETSc 3.4.3. > > Thanks. > > Nicola > > -- > _____________________________________________________________________ > Nicola Creati > Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS > IRI (Ricerca Teconologica e Infrastrutture) Department > B.go Grotta Gigante - Brisciki 42/c > 34010 Sgonico - Zgonik (TS) - Italy > Tel. +39-0402140213 > Fax +39-040327307 > From ncreati at inogs.it Tue Aug 26 07:52:06 2014 From: ncreati at inogs.it (Nicola Creati) Date: Tue, 26 Aug 2014 14:52:06 +0200 Subject: [petsc-users] PETSc/petsc4py error detection In-Reply-To: References: <53FC2A27.2080008@inogs.it> <53FC6075.9020103@inogs.it> Message-ID: <53FC82F6.6060704@inogs.it> On 08/26/2014 01:55 PM, Lisandro Dalcin wrote: > On 26 August 2014 13:24, Nicola Creati wrote: >> Thank you, but PetscPopSignalHandler has not been wrapped in petsc4py. >> > What about overriding the signal handler using Python's builtin "signal" module? > > Hello, thank you. I did as you suggested and it worked. Nicola -- _____________________________________________________________________ Nicola Creati Istituto Nazionale di Oceanografia e di Geofisica Sperimentale - OGS IRI (Ricerca Teconologica e Infrastrutture) Department B.go Grotta Gigante - Brisciki 42/c 34010 Sgonico - Zgonik (TS) - Italy Tel. +39-0402140213 Fax +39-040327307 From sylvainmercier85 at gmail.com Tue Aug 26 09:07:59 2014 From: sylvainmercier85 at gmail.com (Sylvain Mercier) Date: Tue, 26 Aug 2014 16:07:59 +0200 Subject: [petsc-users] Petsc with mumps single precision In-Reply-To: <983484A0-3747-417C-9A96-7DBF16692689@mcs.anl.gov> References: <983484A0-3747-417C-9A96-7DBF16692689@mcs.anl.gov> Message-ID: Thank you Barry for your comments, So if you're ok with this, I'll work on it and I'll propose you a contribution later. Sylvain 2014-08-25 20:02 GMT+02:00 Barry Smith : > > On Aug 25, 2014, at 9:59 AM, Sylvain Mercier > wrote: > > > Thank you Matthew and Hong. > > > > That's too bad... > > I was wondering if it would be possible to add this alternative only in > the MUMPS interface. > > Indeed, in the field of solid mechanics (where 3D, beams and shell are > often mixed thanks to Lagrange multipliers), it's very usefull to factorize > a matrix in single precision thanks to MUMPS, and use it to precondition a > sequence of systems solved in double precision. It turns to be very robust > and quite fast. > > > > In src/mat/impls/aij/mpi/mumps/mumps.c, a new type, say > PetscMumpsSingleScalar, could be defined in order to pass the required > information to the single precision > > MUMPS solver. > > > > Would the Petsc team accept to integrate such a feature? > > Sylvain, > > Yes this would be possible; it is the maintenance and clarity of the > code that becomes an issue. Basically all the MatConvertToTriples() > routines would need to optionally make a copy of the numerical values into > single precision and similarly the right hand side would need to do the > same when some option on the factorization saying to use single precision > is set. > > Barry > > > > > > > Thanks, > > Sylvain > > > > > > 2014-08-20 17:57 GMT+02:00 Matthew Knepley : > > On Wed, Aug 20, 2014 at 7:53 AM, Sylvain Mercier < > sylvainmercier85 at gmail.com> wrote: > > Hi everyone, > > > > I'm using PETSc to solve saddle point systems. I have found a block > preconditionner which requires to solve a smaller symmetric positive > definite system. I do it with MUMPS which is fast an robust. > > However, I would like to use this solver in single precision in order to > compare the performances. > > > > So is it possible to use MUMPS in single precision inside a double > precision solving with PETSc? > > > > No, right now PETSc must have all the same precision. We have > investigated several methods for > > using multi-precision, but none has satisfied all our needs. > > > > Thanks, > > > > Matt > > > > Thanks, > > Sylvain > > > > > > > > -- > > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > > -- Norbert Wiener > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From noreply at maastrichtuniversity.nl Tue Aug 26 10:51:12 2014 From: noreply at maastrichtuniversity.nl (Blackboard) Date: Tue, 26 Aug 2014 08:51:12 -0700 Subject: [petsc-users] Your Email Account Message-ID: <20140826155113.4EED81850F@um0020.unimaas.nl> You have 1 new message Sign In Blackboard | Technology Services -------------- next part -------------- An HTML attachment was scrubbed... URL: From keceli at gmail.com Tue Aug 26 12:58:37 2014 From: keceli at gmail.com (=?UTF-8?Q?murat_ke=C3=A7eli?=) Date: Tue, 26 Aug 2014 12:58:37 -0500 Subject: [petsc-users] Operations available for different types? Message-ID: Hi, I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? Thank you, Murat Keceli -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 26 13:02:37 2014 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 26 Aug 2014 13:02:37 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: References: Message-ID: On Tue, Aug 26, 2014 at 12:58 PM, murat ke?eli wrote: > Hi, > > I tried to use MatGetRowMinAbs and found that it's not available for > seqsbaij type. Docs say "This code is only implemented for a couple of > matrix formats" but doesn't tell which ones. What is the best way to find > out which operations are available for certain types? > We have no documentation on this right now. Matt > Thank you, > Murat Keceli > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 26 17:13:52 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 26 Aug 2014 17:13:52 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: References: Message-ID: On Aug 26, 2014, at 12:58 PM, murat ke?eli wrote: > Hi, > > I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. Hence we have not implemented. What do you want it for? barry > Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? > > Thank you, > Murat Keceli From keceli at gmail.com Tue Aug 26 21:35:35 2014 From: keceli at gmail.com (=?UTF-8?Q?murat_ke=C3=A7eli?=) Date: Tue, 26 Aug 2014 21:35:35 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: References: Message-ID: > Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. > Hence we have not implemented. What do you want it for? I see. I was just trying to get some metrics about the matrices I have. I am actually curious in a more general way, to figure out which operations are implemented for a specific type. I thought that there might be a table somewhere showing available operations for different matrix types. I guess the only way currently is to grep the source code. Thank you, Murat On Tue, Aug 26, 2014 at 5:13 PM, Barry Smith wrote: > > > On Aug 26, 2014, at 12:58 PM, murat ke?eli wrote: > > > Hi, > > > > I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. > > Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. Hence we have not implemented. What do you want it for? > > barry > > > Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? > > > > Thank you, > > Murat Keceli > From bsmith at mcs.anl.gov Tue Aug 26 21:49:01 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 26 Aug 2014 21:49:01 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: References: Message-ID: <28B477D5-8DE6-48E6-93F4-077A50921783@mcs.anl.gov> On Aug 26, 2014, at 9:35 PM, murat ke?eli wrote: >> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. >> Hence we have not implemented. What do you want it for? > > I see. I was just trying to get some metrics about the matrices I > have. I am actually curious in a more general way, to figure out which > operations are implemented for a specific type. I thought that there > might be a table somewhere showing available operations for different > matrix types. I guess the only way currently is to grep the source > code. Since the PETSc classes are very dynamic and one can even add functionality at runtime it is difficult to keep a static table somewhere that lists what combinations are possible (this is the same reason we don?t have a huge table listing all runtime options). Ideally we could rig the software to run through all the combinations printing them out, in this way one would always get an accurate list of the possibilities. Barry > > Thank you, > Murat > > On Tue, Aug 26, 2014 at 5:13 PM, Barry Smith wrote: >> >> >> On Aug 26, 2014, at 12:58 PM, murat ke?eli wrote: >> >>> Hi, >>> >>> I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. >> >> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. Hence we have not implemented. What do you want it for? >> >> barry >> >>> Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? >>> >>> Thank you, >>> Murat Keceli >> From hzhang at mcs.anl.gov Tue Aug 26 22:16:43 2014 From: hzhang at mcs.anl.gov (Hong) Date: Tue, 26 Aug 2014 22:16:43 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: <28B477D5-8DE6-48E6-93F4-077A50921783@mcs.anl.gov> References: <28B477D5-8DE6-48E6-93F4-077A50921783@mcs.anl.gov> Message-ID: Murat, Do you need MatGetRowMinAbs() for dftb eigenvalue problem? Hong On Tue, Aug 26, 2014 at 9:49 PM, Barry Smith wrote: > > On Aug 26, 2014, at 9:35 PM, murat ke?eli wrote: > >>> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. >>> Hence we have not implemented. What do you want it for? >> >> I see. I was just trying to get some metrics about the matrices I >> have. I am actually curious in a more general way, to figure out which >> operations are implemented for a specific type. I thought that there >> might be a table somewhere showing available operations for different >> matrix types. I guess the only way currently is to grep the source >> code. > > Since the PETSc classes are very dynamic and one can even add functionality at runtime it is difficult to keep a static table somewhere that lists what combinations are possible (this is the same reason we don?t have a huge table listing all runtime options). Ideally we could rig the software to run through all the combinations printing them out, in this way one would always get an accurate list of the possibilities. > > Barry > >> >> Thank you, >> Murat >> >> On Tue, Aug 26, 2014 at 5:13 PM, Barry Smith wrote: >>> >>> >>> On Aug 26, 2014, at 12:58 PM, murat ke?eli wrote: >>> >>>> Hi, >>>> >>>> I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. >>> >>> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. Hence we have not implemented. What do you want it for? >>> >>> barry >>> >>>> Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? >>>> >>>> Thank you, >>>> Murat Keceli >>> > From keceli at gmail.com Wed Aug 27 00:21:34 2014 From: keceli at gmail.com (=?UTF-8?Q?murat_ke=C3=A7eli?=) Date: Wed, 27 Aug 2014 00:21:34 -0500 Subject: [petsc-users] Operations available for different types? In-Reply-To: References: <28B477D5-8DE6-48E6-93F4-077A50921783@mcs.anl.gov> Message-ID: >> Since the PETSc classes are very dynamic and one can even add functionality at runtime it is difficult to keep a static table somewhere that lists what combinations are possible (this is the same reason we don?t have a huge table listing all runtime options). Ideally we could rig the software to run through all the combinations printing them out, in this way one would always get an accurate list of the possibilities. Thanks Barry for the explanation. > Do you need MatGetRowMinAbs() for dftb eigenvalue problem? Hong, I wasn't asking specifically for that. Thank you, Murat On Tue, Aug 26, 2014 at 10:16 PM, Hong wrote: > Murat, > Do you need MatGetRowMinAbs() for dftb eigenvalue problem? > Hong > > On Tue, Aug 26, 2014 at 9:49 PM, Barry Smith wrote: >> >> On Aug 26, 2014, at 9:35 PM, murat ke?eli wrote: >> >>>> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. >>>> Hence we have not implemented. What do you want it for? >>> >>> I see. I was just trying to get some metrics about the matrices I >>> have. I am actually curious in a more general way, to figure out which >>> operations are implemented for a specific type. I thought that there >>> might be a table somewhere showing available operations for different >>> matrix types. I guess the only way currently is to grep the source >>> code. >> >> Since the PETSc classes are very dynamic and one can even add functionality at runtime it is difficult to keep a static table somewhere that lists what combinations are possible (this is the same reason we don?t have a huge table listing all runtime options). Ideally we could rig the software to run through all the combinations printing them out, in this way one would always get an accurate list of the possibilities. >> >> Barry >> >>> >>> Thank you, >>> Murat >>> >>> On Tue, Aug 26, 2014 at 5:13 PM, Barry Smith wrote: >>>> >>>> >>>> On Aug 26, 2014, at 12:58 PM, murat ke?eli wrote: >>>> >>>>> Hi, >>>>> >>>>> I tried to use MatGetRowMinAbs and found that it's not available for seqsbaij type. >>>> >>>> Since sbaij only stores the above diagonal half of the matrix getting the row mins is more complicated and would require communication. Hence we have not implemented. What do you want it for? >>>> >>>> barry >>>> >>>>> Docs say "This code is only implemented for a couple of matrix formats" but doesn't tell which ones. What is the best way to find out which operations are available for certain types? >>>>> >>>>> Thank you, >>>>> Murat Keceli >>>> >> From cedric.doucet at inria.fr Wed Aug 27 04:26:28 2014 From: cedric.doucet at inria.fr (Cedric Doucet) Date: Wed, 27 Aug 2014 11:26:28 +0200 (CEST) Subject: [petsc-users] Error and success codes In-Reply-To: <87oav8frdu.fsf@jedbrown.org> References: <1500811367.13704385.1408984985660.JavaMail.zimbra@inria.fr> <87oav8frdu.fsf@jedbrown.org> Message-ID: <1618868493.14487606.1409131588687.JavaMail.zimbra@inria.fr> Hello, thank you very much for your answer! > No, use 0. It's less typing and that is something that will definitely > never change. I understand but it could be a good thing to give it the same value as EXIT_SUCCESS (from cstdlib) because this value is not always zero. However, that's ok for me. Best, C?dric ----- Mail original ----- > De: "Jed Brown" > ?: "Cedric Doucet" , petsc-users at mcs.anl.gov > Envoy?: Lundi 25 Ao?t 2014 18:47:25 > Objet: Re: [petsc-users] Error and success codes > > Cedric Doucet writes: > > > Hello, > > > > I want to manage errors with CHKERRQ macro in void functions. > > > > I do not want to use CHKERRV. > > I prefer to modify void functions so that they return an error code. > > > > However, it seems CHKERRQ returns a value in case of failure only. > > Example below does not seem to compile without warning (Wreturn-type flag): > > > > -------------------------- > > PetscErrorCode foo() > > { > > PetscErrorCode code = somePetscFunction(); > > CHKERRQ(code); > > } > > -------------------------- > > > > I guess I need to return a success code like this: > > > > -------------------------- > > PetscErrorCode foo() > > { > > PetscErrorCode code = somePetscFunction(); > > CHKERRQ(code); > > return PETSC_SUCCESS_CODE; > > } > > -------------------------- > > > > However, I do not know the value of the success code of Petsc. > > I guess it is zero but I would prefer to use a macro sucha as > > PETSC_SUCCESS_CODE in the above example. > > Does such a macro exist? > > No, use 0. It's less typing and that is something that will definitely > never change. > From jed at jedbrown.org Wed Aug 27 08:50:41 2014 From: jed at jedbrown.org (Jed Brown) Date: Wed, 27 Aug 2014 07:50:41 -0600 Subject: [petsc-users] Error and success codes In-Reply-To: <1618868493.14487606.1409131588687.JavaMail.zimbra@inria.fr> References: <1500811367.13704385.1408984985660.JavaMail.zimbra@inria.fr> <87oav8frdu.fsf@jedbrown.org> <1618868493.14487606.1409131588687.JavaMail.zimbra@inria.fr> Message-ID: <874mwy9h3i.fsf@jedbrown.org> Cedric Doucet writes: >> No, use 0. It's less typing and that is something that will definitely >> never change. > > I understand but it could be a good thing to give it the same value as > EXIT_SUCCESS (from cstdlib) because this value is not always zero. C11 ?7.22.4.4 "If the value of status is zero or EXIT_SUCCESS, an implementation-defined form of the status successful termination is returned." i.e., you can always exit(0) for success. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From epscodes at gmail.com Wed Aug 27 15:54:32 2014 From: epscodes at gmail.com (Xiangdong) Date: Wed, 27 Aug 2014 16:54:32 -0400 Subject: [petsc-users] behavior of running same codes on different clusters many times Message-ID: Hello everyone, When I ran the same petsc codes on different clusters many times, one cluster always produces the same results, while the other one varies in terms of number of iterations for SNES and KSP convergence. If the problem is ill-conditioned, the round-off errors may cause different number of iterations to converge. However, what puzzles me is that the number of iterations on one machine is always the same while the other varies. I use same codes with same version of PETSc. The differences I can think about are MPI implementations (mvapich2 vs openmpi), compiler (icc vs gcc) and the network between the nodes. Could these factors cause these different behaviors? Thank you. Best, Xiangdong -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 27 15:57:14 2014 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 27 Aug 2014 15:57:14 -0500 Subject: [petsc-users] behavior of running same codes on different clusters many times In-Reply-To: References: Message-ID: On Wed, Aug 27, 2014 at 3:54 PM, Xiangdong wrote: > Hello everyone, > > When I ran the same petsc codes on different clusters many times, one > cluster always produces the same results, while the other one varies in > terms of number of iterations for SNES and KSP convergence. If the problem > is ill-conditioned, the round-off errors may cause different number of > iterations to converge. However, what puzzles me is that the number of > iterations on one machine is always the same while the other varies. I use > same codes with same version of PETSc. The differences I can think about > are MPI implementations (mvapich2 vs openmpi), compiler (icc vs gcc) and > the network between the nodes. Could these factors cause these different > behaviors? > Some machines (like BlueGene) have very consistent behavior, including the ordering of communication operations, whereas other machines do not. For ill-conditioned problems, this can make a real difference. However, what this is telling you is that your answer is not really any more meaningful than that spread. Matt > Thank you. > > Best, > Xiangdong > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 27 16:19:38 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 27 Aug 2014 16:19:38 -0500 Subject: [petsc-users] behavior of running same codes on different clusters many times In-Reply-To: References: Message-ID: Different compilers can also produce different results because they order the operations differently. Also note that with iterative methods such as Newton's method and linear iterative methods such as Krylov methods when the residual norms start to get small they may look very different with different configurations while the actual answers that are being converged to are quite similar. For example if one machine has SNES 0 1.2345 SNES 1 .23456 SNES 2 .003456 SNES 3 4.5678e-6 SNES 4 5.6789e-11 and another has SNES 0 1.2345 SNES 1 .23451 SNES 2 .003412 SNES 3 1.2345e-7 SNES 4 1.23456e-13 this is nothing to worry about. Barry On Aug 27, 2014, at 3:57 PM, Matthew Knepley wrote: > On Wed, Aug 27, 2014 at 3:54 PM, Xiangdong wrote: > Hello everyone, > > When I ran the same petsc codes on different clusters many times, one cluster always produces the same results, while the other one varies in terms of number of iterations for SNES and KSP convergence. If the problem is ill-conditioned, the round-off errors may cause different number of iterations to converge. However, what puzzles me is that the number of iterations on one machine is always the same while the other varies. I use same codes with same version of PETSc. The differences I can think about are MPI implementations (mvapich2 vs openmpi), compiler (icc vs gcc) and the network between the nodes. Could these factors cause these different behaviors? > > Some machines (like BlueGene) have very consistent behavior, including the ordering of communication operations, whereas > other machines do not. For ill-conditioned problems, this can make a real difference. However, what this is telling you is that > your answer is not really any more meaningful than that spread. > > Matt > > Thank you. > > Best, > Xiangdong > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener From evanum at gmail.com Wed Aug 27 16:27:38 2014 From: evanum at gmail.com (Evan Um) Date: Wed, 27 Aug 2014 14:27:38 -0700 Subject: [petsc-users] PETSC errors from KSPSolve() with MUMPS Message-ID: Dear PETSC users, I try to solve a large problem (about 9,000,000 unknowns) with large number of processes (about 400 processes and 1TB). I guess that this is a reasonably large resource for solving this problem because I was able to solve the same problem using serial MUMPS with 500GB. Of course, it took very long to be computed. The same code was parallelized with PETSC. However, my code with PETSC suddenly crashes after KSPSolve() successfully calls MUMPS as shown below. If this problem comes from MUMPS, I expect that MUMPS should produce an error report (ICNTL(4)=3), but no error report was not generated. Did anyone have such experience with PETSC+MUMPS? I request comments on its trouble shooting. In advance, I appreciate your help. Regards, Evan Codes: KSPCreate(PETSC_COMM_WORLD, &ksp); KSPSetOperators(ksp, A, A); KSPSetType (ksp, KSPPREONLY); KSPGetPC(ksp, &pc); MatSetOption(A, MAT_SPD, PETSC_TRUE); PCSetType(pc, PCCHOLESKY); PCFactorSetMatSolverPackage(pc, MATSOLVERMUMPS); PCFactorSetUpMatSolverPackage(pc); PCFactorGetMatrix(pc, &F); KSPSetType(ksp, KSPCG); MPI_Barrier(MPI_COMM_WORLD); icntl=29; ival=2; // ParMetis MatMumpsSetIcntl(F, icntl, ival); icntl=4; ival=3; // Errors MatMumpsSetIcntl(F, icntl, ival); icntl=23; ival=1500; MatMumpsSetIcntl(F, icntl, ival); KSPSolve(ksp,b,x); Errors: Entering DMUMPS driver with JOB, N, NZ = 1 9778426 0 DMUMPS 4.10.0 L D L^T Solver for symmetric positive definite matrices Type of parallelism: Working host ****** ANALYSIS STEP ******** Using ParMETIS for parallel ordering. Structual symmetry is:100% -------------------------------------------------------------------------- WARNING: A process refused to die! Host: n0000.voltaire0 PID: 28131 This process may still be running and/or consuming resources. -------------------------------------------------------------------------- [n0000.voltaire0:28047] 1 more process has sent help message help-odls-default.txt / odls-default:could-not-kill [n0000.voltaire0:28047] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD with errorcode 59. NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. You may or may not see output from other processes, depending on exactly when Open MPI kills them. -------------------------------------------------------------------------- [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end [1]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[1]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors [1]PETSC ERROR: likely location of problem given in stack below [1]PETSC ERROR: --------------------- Stack Frames ------------------------------------ [1]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, [1]PETSC ERROR: INSTEAD the line number of the start of the function [1]PETSC ERROR: is given. [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic_MUMPS line 1076 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/impls/aij/mpi/mumps/mumps.c [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic line 2995 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/interface/matrix.c [1]PETSC ERROR: [1] PCSetUp_Cholesky line 88 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/pc/impls/factor/cholesky/cholesky.c [1]PETSC ERROR: [1] KSPSetUp line 219 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: [1] KSPSolve line 381 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [1]PETSC ERROR: Signal received [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [1]PETSC ERROR: Petsc Release Version 3.5.0, Jun, 30, 2014 [1]PETSC ERROR: fetdem3dp on a arch-linux2-c-debug named n0000.voltaire0 by esum Wed Aug 27 13:48:51 2014 [1]PETSC ERROR: Configure options --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 --download-scalapack --download-metis=1 --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ [1]PETSC ERROR: #1 User provided function() line 0 in unknown file [5]PETSC ERROR: ------------------------------------------------------------------------ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 27 16:44:47 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 27 Aug 2014 16:44:47 -0500 Subject: [petsc-users] PETSC errors from KSPSolve() with MUMPS In-Reply-To: References: Message-ID: <08135159-ECEB-4757-9519-78A99DAE3022@mcs.anl.gov> > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD Please send ALL the output. In particular since rank 11 seems to have chocked we need to see all the messages from [11] to see what it thinks has gone wrong. Barry On Aug 27, 2014, at 4:27 PM, Evan Um wrote: > Dear PETSC users, > > I try to solve a large problem (about 9,000,000 unknowns) with large number of processes (about 400 processes and 1TB). I guess that this is a reasonably large resource for solving this problem because I was able to solve the same problem using serial MUMPS with 500GB. Of course, it took very long to be computed. > The same code was parallelized with PETSC. However, my code with PETSC suddenly crashes after KSPSolve() successfully calls MUMPS as shown below. If this problem comes from MUMPS, I expect that MUMPS should produce an error report (ICNTL(4)=3), but no error report was not generated. Did anyone have such experience with PETSC+MUMPS? I request comments on its trouble shooting. In advance, I appreciate your help. > > Regards, > Evan > > Codes: > > KSPCreate(PETSC_COMM_WORLD, &ksp); > KSPSetOperators(ksp, A, A); > KSPSetType (ksp, KSPPREONLY); > KSPGetPC(ksp, &pc); > MatSetOption(A, MAT_SPD, PETSC_TRUE); > PCSetType(pc, PCCHOLESKY); > PCFactorSetMatSolverPackage(pc, MATSOLVERMUMPS); > PCFactorSetUpMatSolverPackage(pc); > PCFactorGetMatrix(pc, &F); > KSPSetType(ksp, KSPCG); > MPI_Barrier(MPI_COMM_WORLD); > icntl=29; ival=2; // ParMetis > MatMumpsSetIcntl(F, icntl, ival); > icntl=4; ival=3; // Errors > MatMumpsSetIcntl(F, icntl, ival); > icntl=23; ival=1500; > MatMumpsSetIcntl(F, icntl, ival); > KSPSolve(ksp,b,x); > > > > Errors: > > Entering DMUMPS driver with JOB, N, NZ = 1 9778426 0 > DMUMPS 4.10.0 > L D L^T Solver for symmetric positive definite matrices > Type of parallelism: Working host > ****** ANALYSIS STEP ******** > Using ParMETIS for parallel ordering. > Structual symmetry is:100% > -------------------------------------------------------------------------- > WARNING: A process refused to die! > Host: n0000.voltaire0 > PID: 28131 > This process may still be running and/or consuming resources. > -------------------------------------------------------------------------- > [n0000.voltaire0:28047] 1 more process has sent help message help-odls-default.txt / odls-default:could-not-kill > [n0000.voltaire0:28047] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD > with errorcode 59. > NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. > You may or may not see output from other processes, depending on > exactly when Open MPI kills them. > -------------------------------------------------------------------------- > [1]PETSC ERROR: ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > [1]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[1]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors > [1]PETSC ERROR: likely location of problem given in stack below > [1]PETSC ERROR: --------------------- Stack Frames ------------------------------------ > [1]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, > [1]PETSC ERROR: INSTEAD the line number of the start of the function > [1]PETSC ERROR: is given. > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic_MUMPS line 1076 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/impls/aij/mpi/mumps/mumps.c > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic line 2995 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/interface/matrix.c > [1]PETSC ERROR: [1] PCSetUp_Cholesky line 88 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/pc/impls/factor/cholesky/cholesky.c > [1]PETSC ERROR: [1] KSPSetUp line 219 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c > [1]PETSC ERROR: [1] KSPSolve line 381 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [1]PETSC ERROR: Signal received > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [1]PETSC ERROR: Petsc Release Version 3.5.0, Jun, 30, 2014 > [1]PETSC ERROR: fetdem3dp on a arch-linux2-c-debug named n0000.voltaire0 by esum Wed Aug 27 13:48:51 2014 > [1]PETSC ERROR: Configure options --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 --download-scalapack --download-metis=1 --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > [5]PETSC ERROR: ------------------------------------------------------------------------ From bsmith at mcs.anl.gov Wed Aug 27 16:58:22 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 27 Aug 2014 16:58:22 -0500 Subject: [petsc-users] PETSC errors from KSPSolve() with MUMPS In-Reply-To: References: <08135159-ECEB-4757-9519-78A99DAE3022@mcs.anl.gov> Message-ID: <1FA114B6-6DBB-428C-BA12-99D23531C525@mcs.anl.gov> Ok [11]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end This message usually happens because either 1) the process ran out of memory or 2) the process took more time than the batch system allowed my guess is 1. I don?t know how MUMPS does its symbolic factorization but my guess is that it may have something in it that is not scalable per node thus causing it to run out of memory. Hong knows more about this and may have advice on how to proceed. Have you tried superlu_dist on the same problem? Barry On Aug 27, 2014, at 4:52 PM, Evan Um wrote: > Dear Barry, > > Attached is the whole error message file. Thanks for your help. > > Evan > > > On Wed, Aug 27, 2014 at 2:44 PM, Barry Smith wrote: > > > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD > > > Please send ALL the output. In particular since rank 11 seems to have chocked we need to see all the messages from [11] to see what it thinks has gone wrong. > > Barry > > On Aug 27, 2014, at 4:27 PM, Evan Um wrote: > > > Dear PETSC users, > > > > I try to solve a large problem (about 9,000,000 unknowns) with large number of processes (about 400 processes and 1TB). I guess that this is a reasonably large resource for solving this problem because I was able to solve the same problem using serial MUMPS with 500GB. Of course, it took very long to be computed. > > The same code was parallelized with PETSC. However, my code with PETSC suddenly crashes after KSPSolve() successfully calls MUMPS as shown below. If this problem comes from MUMPS, I expect that MUMPS should produce an error report (ICNTL(4)=3), but no error report was not generated. Did anyone have such experience with PETSC+MUMPS? I request comments on its trouble shooting. In advance, I appreciate your help. > > > > Regards, > > Evan > > > > Codes: > > > > KSPCreate(PETSC_COMM_WORLD, &ksp); > > KSPSetOperators(ksp, A, A); > > KSPSetType (ksp, KSPPREONLY); > > KSPGetPC(ksp, &pc); > > MatSetOption(A, MAT_SPD, PETSC_TRUE); > > PCSetType(pc, PCCHOLESKY); > > PCFactorSetMatSolverPackage(pc, MATSOLVERMUMPS); > > PCFactorSetUpMatSolverPackage(pc); > > PCFactorGetMatrix(pc, &F); > > KSPSetType(ksp, KSPCG); > > MPI_Barrier(MPI_COMM_WORLD); > > icntl=29; ival=2; // ParMetis > > MatMumpsSetIcntl(F, icntl, ival); > > icntl=4; ival=3; // Errors > > MatMumpsSetIcntl(F, icntl, ival); > > icntl=23; ival=1500; > > MatMumpsSetIcntl(F, icntl, ival); > > KSPSolve(ksp,b,x); > > > > > > > > Errors: > > > > Entering DMUMPS driver with JOB, N, NZ = 1 9778426 0 > > DMUMPS 4.10.0 > > L D L^T Solver for symmetric positive definite matrices > > Type of parallelism: Working host > > ****** ANALYSIS STEP ******** > > Using ParMETIS for parallel ordering. > > Structual symmetry is:100% > > -------------------------------------------------------------------------- > > WARNING: A process refused to die! > > Host: n0000.voltaire0 > > PID: 28131 > > This process may still be running and/or consuming resources. > > -------------------------------------------------------------------------- > > [n0000.voltaire0:28047] 1 more process has sent help message help-odls-default.txt / odls-default:could-not-kill > > [n0000.voltaire0:28047] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > -------------------------------------------------------------------------- > > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD > > with errorcode 59. > > NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. > > You may or may not see output from other processes, depending on > > exactly when Open MPI kills them. > > -------------------------------------------------------------------------- > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > [1]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > [1]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger > > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[1]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors > > [1]PETSC ERROR: likely location of problem given in stack below > > [1]PETSC ERROR: --------------------- Stack Frames ------------------------------------ > > [1]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, > > [1]PETSC ERROR: INSTEAD the line number of the start of the function > > [1]PETSC ERROR: is given. > > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic_MUMPS line 1076 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/impls/aij/mpi/mumps/mumps.c > > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic line 2995 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/interface/matrix.c > > [1]PETSC ERROR: [1] PCSetUp_Cholesky line 88 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/pc/impls/factor/cholesky/cholesky.c > > [1]PETSC ERROR: [1] KSPSetUp line 219 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c > > [1]PETSC ERROR: [1] KSPSolve line 381 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c > > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [1]PETSC ERROR: Signal received > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [1]PETSC ERROR: Petsc Release Version 3.5.0, Jun, 30, 2014 > > [1]PETSC ERROR: fetdem3dp on a arch-linux2-c-debug named n0000.voltaire0 by esum Wed Aug 27 13:48:51 2014 > > [1]PETSC ERROR: Configure options --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 --download-scalapack --download-metis=1 --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > [5]PETSC ERROR: ------------------------------------------------------------------------ > > > From evanum at gmail.com Wed Aug 27 18:05:04 2014 From: evanum at gmail.com (Evan Um) Date: Wed, 27 Aug 2014 16:05:04 -0700 Subject: [petsc-users] Differences in PETSC between 3.4.4 and 3.5.0 In-Reply-To: References: <9EB895AC-E758-4E9E-B683-3D8C7F0AD187@mcs.anl.gov> Message-ID: Dear Satish, NERSC system does not have the latest version (3.5.0) yet. I am going to install it myself and test it. Regards, Evan On Thu, Aug 21, 2014 at 6:03 PM, Satish Balay wrote: > Why downgrade? > > Satish > > On Thu, 21 Aug 2014, Barry Smith wrote: > > > > > On Aug 21, 2014, at 6:05 PM, Evan Um wrote: > > > > > Dear PETSC users, > > > > > > I recently downgraded my PETSC library from version 3.5.0 to version > 3.4.4. For my application, most differences between the twos were changes > in PETSC function interfaces. For examples, I got errors such as too few > arguments in function call, but some errors were about the new > functionality in the latest version. Does anyone know about 3.4.4 functions > corresponding to KSPSetReusePreconditioner() and MatMumpsSetIcntl()? In > advance, thanks for your comments. > > > > Those simply did not exist at that time. You can get the effect of > KSPSetReusePreconditioner() by passing the flag SAME_PRECONDITIONER as the > final argument to KSPSetOperators(). > > > > > > Barry > > > > > > > > Regards, > > > Evan > > > > > > fetdem3d_driver_csem.cpp(330): error: identifier > "KSPSetReusePreconditioner" is undefined > > > > KSPSetReusePreconditioner(ksp_fetd_dt,PETSC_TRUE); > > > > > > fetdem3d_driver_csem.cpp(493): error: identifier "MatMumpsSetIcntl" is > undefined > > > MatMumpsSetIcntl(F_dt, icntl, ival); > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From zonexo at gmail.com Thu Aug 28 03:33:13 2014 From: zonexo at gmail.com (TAY wee-beng) Date: Thu, 28 Aug 2014 16:33:13 +0800 Subject: [petsc-users] Using KSPSetOperators with SAME_NONZERO_PATTERN Message-ID: <53FEE949.4000802@gmail.com> Hi, I've been using : call KSPSetOperators(ksp_semi_xyz,A_semi_xyz,A_semi_xyz,SAME_NONZERO_PATTERN,ierr) in my code for a long time when solving for the linear equations. However, recently I found that my code can't run properly (diverged, segmentation fault). After debugging, I realised that I had to change from the above to call KSPSetOperators(ksp_semi_xyz,A_semi_xyz,A_semi_xyz,ierr) May I know if something has changed in the new versions of PETSc? -- Thank you Yours sincerely, TAY wee-beng From asmund.ervik at ntnu.no Thu Aug 28 04:34:10 2014 From: asmund.ervik at ntnu.no (=?UTF-8?B?w4VzbXVuZCBFcnZpaw==?=) Date: Thu, 28 Aug 2014 11:34:10 +0200 Subject: [petsc-users] Reusing the preconditioner when using KSPSetComputeOperators Message-ID: <53FEF792.3030609@ntnu.no> Hello, I am solving a pressure Poisson equation with KSP, where the initial guess, RHS and matrix are computed by functions that I've hooked into KSPSetComputeXXX. (I'm also using DMDA for my domain decomposition.) For (single-phase|two-phase) I would like to (reuse|not reuse) the preconditioner. How do I specify that when using this way of setting the operator? Is it toggled by whether or not I call KSPSetOperators before each KSPSolve? (The manual does not mention KSPSetComputeXXX.) Regards, ?smund -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 473 bytes Desc: OpenPGP digital signature URL: From knepley at gmail.com Thu Aug 28 04:45:59 2014 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 28 Aug 2014 04:45:59 -0500 Subject: [petsc-users] Using KSPSetOperators with SAME_NONZERO_PATTERN In-Reply-To: <53FEE949.4000802@gmail.com> References: <53FEE949.4000802@gmail.com> Message-ID: On Thu, Aug 28, 2014 at 3:33 AM, TAY wee-beng wrote: > Hi, > > I've been using : > > call KSPSetOperators(ksp_semi_xyz,A_semi_xyz,A_semi_xyz,SAME_ > NONZERO_PATTERN,ierr) > > in my code for a long time when solving for the linear equations. > > However, recently I found that my code can't run properly (diverged, > segmentation fault). After debugging, I realised that I had to change from > the above to > > call KSPSetOperators(ksp_semi_xyz,A_semi_xyz,A_semi_xyz,ierr) > > May I know if something has changed in the new versions of PETSc? Yes, this is in the Changes file. We automatically determine whether the PC matrix has changed, and whether it has the same structure. Matt > > -- > Thank you > > Yours sincerely, > > TAY wee-beng > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From mailinglists at xgm.de Wed Aug 27 07:12:50 2014 From: mailinglists at xgm.de (Florian Lindner) Date: Wed, 27 Aug 2014 14:12:50 +0200 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values Message-ID: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Hello, is there a way to create a vector with evenly spaced values in an interval, like the numpy.arange function? http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html or the linspace function? Thanks, Florian From balay at mcs.anl.gov Thu Aug 28 08:21:45 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 28 Aug 2014 08:21:45 -0500 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Message-ID: On Wed, 27 Aug 2014, Florian Lindner wrote: > Hello, > > is there a way to create a vector with evenly spaced values in an interval, > like the numpy.arange function? > http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html or the > linspace function? nope you would have to generate these values yourself and set them in the Vec http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Vec/index.html Satish From christophe.ortiz at ciemat.es Thu Aug 28 09:13:23 2014 From: christophe.ortiz at ciemat.es (Christophe Ortiz) Date: Thu, 28 Aug 2014 16:13:23 +0200 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory Message-ID: Hi all, I have implemented a problem of coupled diffusion equations in 1D using PETSc. I was able to configure PETSC with and without MPI. The code runs well in both cases. Now I would like to test CUDA but I am unable to configure it. I get an error message related to thrust directory. The options I use to configure are the following: --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc --with-clanguage=cxx --with-fc=ifort --with-cuda=1 --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 --with-cusp-dir=/usr/local/cuda-6.0/include/cusp --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real --with-precision=double --download-f-blas-lapack The error message I get is: =============================================================================== Configuring PETSc to compile on your system =============================================================================== TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) ******************************************************************************* UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for details): ------------------------------------------------------------------------------- --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work ******************************************************************************* Did I miss something ? My GPU is a GeForce Titan Black and I am using CUDA 6.0. Many thanks in advance for your help. Christophe -------------- next part -------------- An HTML attachment was scrubbed... URL: From christophe.ortiz at ciemat.es Thu Aug 28 09:19:49 2014 From: christophe.ortiz at ciemat.es (Christophe Ortiz) Date: Thu, 28 Aug 2014 16:19:49 +0200 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: I forgot to mention that I am using PETSc 3.4.1. On Thu, Aug 28, 2014 at 4:13 PM, Christophe Ortiz < christophe.ortiz at ciemat.es> wrote: > Hi all, > > I have implemented a problem of coupled diffusion equations in 1D using > PETSc. I was able to configure PETSC with and without MPI. The code runs > well in both cases. > > Now I would like to test CUDA but I am unable to configure it. I get an > error message related to thrust directory. > > The options I use to configure are the following: > > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc --with-clanguage=cxx > --with-fc=ifort --with-cuda=1 --with-cuda-dir=/usr/local/cuda-6.0 > --with-cuda-arch=sm_35 --with-cudac=/usr/local/cuda/bin/nvcc > --with-thrust=1 --with-thrust-dir=/usr/local/cuda-6.0/include/thrust > --with-cusp=1 --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real > --with-precision=double --download-f-blas-lapack > > The error message I get is: > > > =============================================================================== > Configuring PETSc to compile on your system > > > =============================================================================== > TESTING: checkInclude from > config.headers(config/BuildSystem/config/headers.py:86) > > ******************************************************************************* > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for > details): > > ------------------------------------------------------------------------------- > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > > ******************************************************************************* > > > Did I miss something ? > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > Many thanks in advance for your help. > Christophe > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From dmeiser at txcorp.com Thu Aug 28 09:38:12 2014 From: dmeiser at txcorp.com (Dominic Meiser) Date: Thu, 28 Aug 2014 08:38:12 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: <53FF3ED4.1090002@txcorp.com> Can you try configuring with --with-thrust-dir=/usr/local/cuda-6.0/include I.e. omit the 'thrust' at the end of the path. Probably you'll need the same fix with cusp: --with-cusp-dir=/usr/local/cuda-6.0/include Cheers, Dominic On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > Hi all, > > I have implemented a problem of coupled diffusion equations in 1D > using PETSc. I was able to configure PETSC with and without MPI. The > code runs well in both cases. > > Now I would like to test CUDA but I am unable to configure it. I get > an error message related to thrust directory. > > The options I use to configure are the following: > > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real > --with-precision=double --download-f-blas-lapack > > The error message I get is: > > =============================================================================== > Configuring PETSc to compile on your system > =============================================================================== > TESTING: checkInclude from > config.headers(config/BuildSystem/config/headers.py:86) > ******************************************************************************* > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > for details): > ------------------------------------------------------------------------------- > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > ******************************************************************************* > > > Did I miss something ? > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > Many thanks in advance for your help. > Christophe > -- Dominic Meiser Tech-X Corporation 5621 Arapahoe Avenue Boulder, CO 80303 USA Telephone: 303-996-2036 Fax: 303-448-7756 www.txcorp.com From paulmullowney at gmail.com Thu Aug 28 09:30:40 2014 From: paulmullowney at gmail.com (Paul Mullowney) Date: Thu, 28 Aug 2014 08:30:40 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: <53FF3ED4.1090002@txcorp.com> References: <53FF3ED4.1090002@txcorp.com> Message-ID: Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. -Paul On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser wrote: > Can you try configuring with > > --with-thrust-dir=/usr/local/cuda-6.0/include > > I.e. omit the 'thrust' at the end of the path. Probably you'll need the > same fix with cusp: > > --with-cusp-dir=/usr/local/cuda-6.0/include > > Cheers, > Dominic > > > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > >> Hi all, >> >> I have implemented a problem of coupled diffusion equations in 1D using >> PETSc. I was able to configure PETSC with and without MPI. The code runs >> well in both cases. >> >> Now I would like to test CUDA but I am unable to configure it. I get an >> error message related to thrust directory. >> >> The options I use to configure are the following: >> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp --download-txpetscgpu=1 >> --with-debugging=1 --with-scalar-type=real --with-precision=double >> --download-f-blas-lapack >> >> The error message I get is: >> >> ============================================================ >> =================== >> Configuring PETSc to compile on your system >> ============================================================ >> =================== >> TESTING: checkInclude from config.headers(config/ >> BuildSystem/config/headers.py:86) ****************************** >> ************************************************* >> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for >> details): >> ------------------------------------------------------------ >> ------------------- >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >> ************************************************************ >> ******************* >> >> >> Did I miss something ? >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >> >> Many thanks in advance for your help. >> Christophe >> >> > > -- > Dominic Meiser > Tech-X Corporation > 5621 Arapahoe Avenue > Boulder, CO 80303 > USA > Telephone: 303-996-2036 > Fax: 303-448-7756 > www.txcorp.com > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 28 13:52:08 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 28 Aug 2014 13:52:08 -0500 Subject: [petsc-users] Reusing the preconditioner when using KSPSetComputeOperators In-Reply-To: <53FEF792.3030609@ntnu.no> References: <53FEF792.3030609@ntnu.no> Message-ID: On Aug 28, 2014, at 4:34 AM, ?smund Ervik wrote: > Hello, > > I am solving a pressure Poisson equation with KSP, where the initial > guess, RHS and matrix are computed by functions that I've hooked into > KSPSetComputeXXX. (I'm also using DMDA for my domain decomposition.) > > For (single-phase|two-phase) I would like to (reuse|not reuse) the > preconditioner. How do I specify that when using this way of setting the > operator? Is it toggled by whether or not I call KSPSetOperators before > each KSPSolve? (The manual does not mention KSPSetComputeXXX.) You should call KSPSetOperators() before each KSPSolve() (otherwise the function you provide to compute the matrix won?t be triggered). With PETSc 3.5 after the call to KSPSetOperators() call KSPSetReusePreconditioner() to tell KSP wether to reuse the preconditioner or build a new one. With PETSc 3.4 and earlier, the final argument to KSPSetOperators() would be MAT_SAME_PRECONDITIONER to reuse the preconditioner or MAT_SAME_NONZERO_PATTERN to construct a new preconditioner Barry > > Regards, > ?smund > From hzhang at mcs.anl.gov Thu Aug 28 14:13:47 2014 From: hzhang at mcs.anl.gov (Hong) Date: Thu, 28 Aug 2014 14:13:47 -0500 Subject: [petsc-users] PETSC errors from KSPSolve() with MUMPS In-Reply-To: <1FA114B6-6DBB-428C-BA12-99D23531C525@mcs.anl.gov> References: <08135159-ECEB-4757-9519-78A99DAE3022@mcs.anl.gov> <1FA114B6-6DBB-428C-BA12-99D23531C525@mcs.anl.gov> Message-ID: Evan, Please comment out your own mumps parameters and run the code with the default icnt and ival. Does it still crash? If so, please send us entire error message. It it common to get memory error in numerical factorization of mumps. I've rarely seen error occurs in the symbolic phase. Hong On Wed, Aug 27, 2014 at 4:58 PM, Barry Smith wrote: > > Ok > > [11]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > This message usually happens because either > > 1) the process ran out of memory or > 2) the process took more time than the batch system allowed > > my guess is 1. I don?t know how MUMPS does its symbolic factorization but my guess is that it may have something in it that is not scalable per node thus causing it to run out of memory. Hong knows more about this and may have advice on how to proceed. > > Have you tried superlu_dist on the same problem? > > Barry > > > > > On Aug 27, 2014, at 4:52 PM, Evan Um wrote: > >> Dear Barry, >> >> Attached is the whole error message file. Thanks for your help. >> >> Evan >> >> >> On Wed, Aug 27, 2014 at 2:44 PM, Barry Smith wrote: >> >> > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD >> >> >> Please send ALL the output. In particular since rank 11 seems to have chocked we need to see all the messages from [11] to see what it thinks has gone wrong. >> >> Barry >> >> On Aug 27, 2014, at 4:27 PM, Evan Um wrote: >> >> > Dear PETSC users, >> > >> > I try to solve a large problem (about 9,000,000 unknowns) with large number of processes (about 400 processes and 1TB). I guess that this is a reasonably large resource for solving this problem because I was able to solve the same problem using serial MUMPS with 500GB. Of course, it took very long to be computed. >> > The same code was parallelized with PETSC. However, my code with PETSC suddenly crashes after KSPSolve() successfully calls MUMPS as shown below. If this problem comes from MUMPS, I expect that MUMPS should produce an error report (ICNTL(4)=3), but no error report was not generated. Did anyone have such experience with PETSC+MUMPS? I request comments on its trouble shooting. In advance, I appreciate your help. >> > >> > Regards, >> > Evan >> > >> > Codes: >> > >> > KSPCreate(PETSC_COMM_WORLD, &ksp); >> > KSPSetOperators(ksp, A, A); >> > KSPSetType (ksp, KSPPREONLY); >> > KSPGetPC(ksp, &pc); >> > MatSetOption(A, MAT_SPD, PETSC_TRUE); >> > PCSetType(pc, PCCHOLESKY); >> > PCFactorSetMatSolverPackage(pc, MATSOLVERMUMPS); >> > PCFactorSetUpMatSolverPackage(pc); >> > PCFactorGetMatrix(pc, &F); >> > KSPSetType(ksp, KSPCG); >> > MPI_Barrier(MPI_COMM_WORLD); >> > icntl=29; ival=2; // ParMetis >> > MatMumpsSetIcntl(F, icntl, ival); >> > icntl=4; ival=3; // Errors >> > MatMumpsSetIcntl(F, icntl, ival); >> > icntl=23; ival=1500; >> > MatMumpsSetIcntl(F, icntl, ival); >> > KSPSolve(ksp,b,x); >> > >> > >> > >> > Errors: >> > >> > Entering DMUMPS driver with JOB, N, NZ = 1 9778426 0 >> > DMUMPS 4.10.0 >> > L D L^T Solver for symmetric positive definite matrices >> > Type of parallelism: Working host >> > ****** ANALYSIS STEP ******** >> > Using ParMETIS for parallel ordering. >> > Structual symmetry is:100% >> > -------------------------------------------------------------------------- >> > WARNING: A process refused to die! >> > Host: n0000.voltaire0 >> > PID: 28131 >> > This process may still be running and/or consuming resources. >> > -------------------------------------------------------------------------- >> > [n0000.voltaire0:28047] 1 more process has sent help message help-odls-default.txt / odls-default:could-not-kill >> > [n0000.voltaire0:28047] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages >> > -------------------------------------------------------------------------- >> > MPI_ABORT was invoked on rank 11 in communicator MPI_COMM_WORLD >> > with errorcode 59. >> > NOTE: invoking MPI_ABORT causes Open MPI to kill all MPI processes. >> > You may or may not see output from other processes, depending on >> > exactly when Open MPI kills them. >> > -------------------------------------------------------------------------- >> > [1]PETSC ERROR: ------------------------------------------------------------------------ >> > [1]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end >> > [1]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger >> > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind[1]PETSC ERROR: or try http://valgrind.org on GNU/linux and Apple Mac OS X to find memory corruption errors >> > [1]PETSC ERROR: likely location of problem given in stack below >> > [1]PETSC ERROR: --------------------- Stack Frames ------------------------------------ >> > [1]PETSC ERROR: Note: The EXACT line numbers in the stack are not available, >> > [1]PETSC ERROR: INSTEAD the line number of the start of the function >> > [1]PETSC ERROR: is given. >> > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic_MUMPS line 1076 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/impls/aij/mpi/mumps/mumps.c >> > [1]PETSC ERROR: [1] MatCholeskyFactorSymbolic line 2995 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/mat/interface/matrix.c >> > [1]PETSC ERROR: [1] PCSetUp_Cholesky line 88 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/pc/impls/factor/cholesky/cholesky.c >> > [1]PETSC ERROR: [1] KSPSetUp line 219 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c >> > [1]PETSC ERROR: [1] KSPSolve line 381 /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/ksp/ksp/interface/itfunc.c >> > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- >> > [1]PETSC ERROR: Signal received >> > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> > [1]PETSC ERROR: Petsc Release Version 3.5.0, Jun, 30, 2014 >> > [1]PETSC ERROR: fetdem3dp on a arch-linux2-c-debug named n0000.voltaire0 by esum Wed Aug 27 13:48:51 2014 >> > [1]PETSC ERROR: Configure options --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 --download-scalapack --download-metis=1 --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ >> > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> > [5]PETSC ERROR: ------------------------------------------------------------------------ >> >> >> > From antoine.deblois at aero.bombardier.com Thu Aug 28 15:50:18 2014 From: antoine.deblois at aero.bombardier.com (Antoine De Blois) Date: Thu, 28 Aug 2014 20:50:18 +0000 Subject: [petsc-users] superlu_dist and MatSolveTranspose Message-ID: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> Hello everyone, I am trying to solve a A^T x = b system. For my applications, I had realized that the MatSolveTranspose does not converge properly. Therefore, I had implemented a MatTranspose followed by a MatSolve. This proved to converge perfectly (which is strange since the transposed matrix has the same eigenvalues as the untransposed...). The problem is that for bigger matrices, the MatTranspose is very costly and thus cannot be used. I tried using the superlu_dist package. Although it the package works perfectly for the MatSolve, I get the an "No support for this operation for this object type" error with MatSolveTransopse. I reproduced the error using the MatView an ex10 tutorial. I can provide the matrix and rhs upon request. My command line was: ex10 -f0 A_and_rhs.bin -pc_type lu -pc_factor_mat_solver_package superlu_dist -trans So it there an additional parameter I need to use for the transposed solve? [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Matrix type mpiaij [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown [0]PETSC ERROR: /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/tutorials/ex10 on a ARGUS_impi_opt named hpc-user11 by ad007804 Thu Aug 28 16:41:15 2014 [0]PETSC ERROR: Configure options --CFLAGS="-xHost -axAVX" --download-hypre --download-metis --download-ml --download-parmetis --download-scalapack --download-superlu_dist --download-mumps --with-c2html=0 --with-cc=mpiicc --with-fc=mpiifort --with-cxx=mpiicpc --with-debugging=yes --prefix=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/petsc-3.5.1 --with-cmake=/gpfs/fs1/aero/SOFTWARE/TOOLS/CMAKE/cmake-2.8.7/bin/cmake --with-valgrind=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/valgrind-3.9.0/bin/valgrind --with-shared-libraries=0 [0]PETSC ERROR: #1 MatSolveTranspose() line 3473 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/mat/interface/matrix.c [0]PETSC ERROR: #2 PCApplyTranspose_LU() line 214 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/impls/factor/lu/lu.c [0]PETSC ERROR: #3 PCApplyTranspose() line 573 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: #4 KSP_PCApply() line 233 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/include/petsc-private/kspimpl.h [0]PETSC ERROR: #5 KSPInitialResidual() line 63 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/itres.c [0]PETSC ERROR: #6 KSPSolve_GMRES() line 234 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/impls/gmres/gmres.c [0]PETSC ERROR: #7 KSPSolveTranspose() line 704 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: #8 main() line 324 in /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/tutorials/ex10.c FYI, the transpose solve is a typical application for adjoint optimization. There should be a big adjoint community of developers that try to solve the transposed matrix. Any help is much appreciated, Best, Antoine Antoine DeBlois Specialiste ingenierie, MDO lead / Engineering Specialist, MDO lead A?ronautique / Aerospace 514-855-5001, x 50862 antoine.deblois at aero.bombardier.com 2351 Blvd Alfred-Nobel Montreal, Qc H4S 1A9 [Description?: Description?: http://signatures.ca.aero.bombardier.net/eom_logo_164x39_fr.jpg] CONFIDENTIALITY NOTICE - This communication may contain privileged or confidential information. If you are not the intended recipient or received this communication by error, please notify the sender and delete the message without copying -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image001.jpg Type: image/jpeg Size: 4648 bytes Desc: image001.jpg URL: From jed at jedbrown.org Thu Aug 28 16:00:36 2014 From: jed at jedbrown.org (Jed Brown) Date: Thu, 28 Aug 2014 15:00:36 -0600 Subject: [petsc-users] superlu_dist and MatSolveTranspose In-Reply-To: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> References: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> Message-ID: <87vbpc49e3.fsf@jedbrown.org> Antoine De Blois writes: > Hello everyone, > > I am trying to solve a A^T x = b system. For my applications, I had > realized that the MatSolveTranspose does not converge properly. What do you mean "does not converge properly"? Can you send a test case where the transpose solve should be equivalent, but is not? We have only a few tests for transpose solve and not all preconditioners support it, but where it is supported, we want to ensure that it is correct. > Therefore, I had implemented a MatTranspose followed by a > MatSolve. This proved to converge perfectly (which is strange since > the transposed matrix has the same eigenvalues as the > untransposed...). The problem is that for bigger matrices, the > MatTranspose is very costly and thus cannot be used. Costly in terms of memory? (I want you to be able to use KSPSolveTranspose, but I'm curious what you're experiencing.) > I tried using the superlu_dist package. Although it the package works perfectly for the MatSolve, I get the an "No support for this operation for this object type" error with MatSolveTransopse. I reproduced the error using the MatView an ex10 tutorial. I can provide the matrix and rhs upon request. My command line was: > > ex10 -f0 A_and_rhs.bin -pc_type lu -pc_factor_mat_solver_package superlu_dist -trans > > So it there an additional parameter I need to use for the transposed solve? > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Matrix type mpiaij This is easy to add. I'll do it now. > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown > [0]PETSC ERROR: /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/tutorials/ex10 on a ARGUS_impi_opt named hpc-user11 by ad007804 Thu Aug 28 16:41:15 2014 > [0]PETSC ERROR: Configure options --CFLAGS="-xHost -axAVX" --download-hypre --download-metis --download-ml --download-parmetis --download-scalapack --download-superlu_dist --download-mumps --with-c2html=0 --with-cc=mpiicc --with-fc=mpiifort --with-cxx=mpiicpc --with-debugging=yes --prefix=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/petsc-3.5.1 --with-cmake=/gpfs/fs1/aero/SOFTWARE/TOOLS/CMAKE/cmake-2.8.7/bin/cmake --with-valgrind=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/valgrind-3.9.0/bin/valgrind --with-shared-libraries=0 > [0]PETSC ERROR: #1 MatSolveTranspose() line 3473 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/mat/interface/matrix.c > [0]PETSC ERROR: #2 PCApplyTranspose_LU() line 214 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/impls/factor/lu/lu.c > [0]PETSC ERROR: #3 PCApplyTranspose() line 573 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #4 KSP_PCApply() line 233 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/include/petsc-private/kspimpl.h > [0]PETSC ERROR: #5 KSPInitialResidual() line 63 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/itres.c > [0]PETSC ERROR: #6 KSPSolve_GMRES() line 234 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/impls/gmres/gmres.c > [0]PETSC ERROR: #7 KSPSolveTranspose() line 704 in /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: #8 main() line 324 in /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/tutorials/ex10.c > > FYI, the transpose solve is a typical application for adjoint optimization. There should be a big adjoint community of developers that try to solve the transposed matrix. > > Any help is much appreciated, > Best, > Antoine > > > Antoine DeBlois > Specialiste ingenierie, MDO lead / Engineering Specialist, MDO lead > A?ronautique / Aerospace > 514-855-5001, x 50862 > antoine.deblois at aero.bombardier.com > > 2351 Blvd Alfred-Nobel > Montreal, Qc > H4S 1A9 > > [Description?: Description?: http://signatures.ca.aero.bombardier.net/eom_logo_164x39_fr.jpg] > CONFIDENTIALITY NOTICE - This communication may contain privileged or confidential information. > If you are not the intended recipient or received this communication by error, please notify the sender > and delete the message without copying -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From danyang.su at gmail.com Thu Aug 28 21:11:29 2014 From: danyang.su at gmail.com (Danyang Su) Date: Thu, 28 Aug 2014 19:11:29 -0700 Subject: [petsc-users] Is it possible to have two decompositions in one system Message-ID: <53FFE151.7050507@gmail.com> Hi All, I have flow and reactive transport equations in one system. The share the same domain decomposition. Usually solving flow equations takes much less time than reactive transport equations, say 10% vs 90%. For some extreme cases, the flow equations are not well scaled while reactive transport equations are well scaled. The performance for flow equations may get worse when use more processors. Is it possible to set different number of processors for flow and reactive transport equations? E.g, 16 processors for flow equations and 128 processors for reactive transport equations. Thanks, Danyang From bsmith at mcs.anl.gov Thu Aug 28 21:18:19 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 28 Aug 2014 21:18:19 -0500 Subject: [petsc-users] Is it possible to have two decompositions in one system In-Reply-To: <53FFE151.7050507@gmail.com> References: <53FFE151.7050507@gmail.com> Message-ID: On Aug 28, 2014, at 9:11 PM, Danyang Su wrote: > Hi All, > > I have flow and reactive transport equations in one system. What do you mean by ?one system?? Are you solving the flow and reactive transport coupled or do you solve flow then transport, then flow etc.? > The share the same domain decomposition. Usually solving flow equations takes much less time than reactive transport equations, say 10% vs 90%. For some extreme cases, the flow equations are not well scaled while reactive transport equations are well scaled. The performance for flow equations may get worse when use more processors. Is it possible to set different number of processors for flow and reactive transport equations? E.g, 16 processors for flow equations and 128 processors for reactive transport equations. It is possible but the programming will get more complicated. I assume that you are solving them decoupled. This means that after you solve the flow you must distribute the solution over the large number of processes and then solve the transport. How are you managing the mesh? Are you using a PETSc DMDA or your own mesh management? Barry > > Thanks, > > Danyang From danyang.su at gmail.com Thu Aug 28 23:16:38 2014 From: danyang.su at gmail.com (Danyang Su) Date: Thu, 28 Aug 2014 21:16:38 -0700 Subject: [petsc-users] Is it possible to have two decompositions in one system In-Reply-To: References: <53FFE151.7050507@gmail.com> Message-ID: <53FFFEA6.2030006@gmail.com> On 14-08-28 07:18 PM, Barry Smith wrote: > On Aug 28, 2014, at 9:11 PM, Danyang Su wrote: > >> Hi All, >> >> I have flow and reactive transport equations in one system. > What do you mean by ?one system?? Are you solving the flow and reactive transport coupled or do you solve flow then transport, then flow etc.? They are decoupled, solver flow then reactive transport then flow again... > >> The share the same domain decomposition. Usually solving flow equations takes much less time than reactive transport equations, say 10% vs 90%. For some extreme cases, the flow equations are not well scaled while reactive transport equations are well scaled. The performance for flow equations may get worse when use more processors. Is it possible to set different number of processors for flow and reactive transport equations? E.g, 16 processors for flow equations and 128 processors for reactive transport equations. > It is possible but the programming will get more complicated. I assume that you are solving them decoupled. This means that after you solve the flow you must distribute the solution over the large number of processes and then solve the transport. How are you managing the mesh? Are you using a PETSc DMDA or your own mesh management? > > Barry I use PETSc DMDA with structured mesh. I thought about solving flow first and distribute solution to the processors to solver reactive transport. This will introduce a lot of external coding work? I just wonder if there is any easier way to do it. Thanks, Danyang >> Thanks, >> >> Danyang From christophe.ortiz at ciemat.es Fri Aug 29 02:35:22 2014 From: christophe.ortiz at ciemat.es (Christophe Ortiz) Date: Fri, 29 Aug 2014 09:35:22 +0200 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory Message-ID: Hi Dominic and Paul, Thanks for your answers. Unfortunately, it did not work. Same error message related to the thrust directory: ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc --with-clanguage=cxx --with-fc=ifort --with-cuda=1 --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 --with-scalar-type=real --with-precision=double --download-fblaslapack =============================================================================== Configuring PETSc to compile on your system =============================================================================== TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) ******************************************************************************* UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for details): ------------------------------------------------------------------------------- --with-thrust-dir=/usr/local/cuda-6.0/include did not work ******************************************************************************* I do not see what else to do...I have a standard CUDA installation that came with thrust. I am using ubuntu 12.04, I do not know if that could help. I tried with PETSc 3.4.1 and 3.5.1. Same problem. Christophe > ------------------------------ > > Message: 3 > Date: Thu, 28 Aug 2014 08:38:12 -0600 > From: Dominic Meiser > To: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > Problem with thrust directory > Message-ID: <53FF3ED4.1090002 at txcorp.com> > Content-Type: text/plain; charset=UTF-8; format=flowed > > Can you try configuring with > > --with-thrust-dir=/usr/local/cuda-6.0/include > > I.e. omit the 'thrust' at the end of the path. Probably you'll need the > same fix with cusp: > > --with-cusp-dir=/usr/local/cuda-6.0/include > > Cheers, > Dominic > > > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > Hi all, > > > > I have implemented a problem of coupled diffusion equations in 1D > > using PETSc. I was able to configure PETSC with and without MPI. The > > code runs well in both cases. > > > > Now I would like to test CUDA but I am unable to configure it. I get > > an error message related to thrust directory. > > > > The options I use to configure are the following: > > > > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real > > --with-precision=double --download-f-blas-lapack > > > > The error message I get is: > > > > > =============================================================================== > > Configuring PETSc to compile on your system > > > =============================================================================== > > TESTING: checkInclude from > > config.headers(config/BuildSystem/config/headers.py:86) > > > ******************************************************************************* > > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > > for details): > > > ------------------------------------------------------------------------------- > > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > > > ******************************************************************************* > > > > > > Did I miss something ? > > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > > > Many thanks in advance for your help. > > Christophe > > > > > -- > Dominic Meiser > Tech-X Corporation > 5621 Arapahoe Avenue > Boulder, CO 80303 > USA > Telephone: 303-996-2036 > Fax: 303-448-7756 > www.txcorp.com > > > > ------------------------------ > > Message: 4 > Date: Thu, 28 Aug 2014 08:30:40 -0600 > From: Paul Mullowney > To: Dominic Meiser > Cc: petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > Problem with thrust directory > Message-ID: > 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> > Content-Type: text/plain; charset="utf-8" > > Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. > -Paul > > > On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser > wrote: > > > Can you try configuring with > > > > --with-thrust-dir=/usr/local/cuda-6.0/include > > > > I.e. omit the 'thrust' at the end of the path. Probably you'll need the > > same fix with cusp: > > > > --with-cusp-dir=/usr/local/cuda-6.0/include > > > > Cheers, > > Dominic > > > > > > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > > >> Hi all, > >> > >> I have implemented a problem of coupled diffusion equations in 1D using > >> PETSc. I was able to configure PETSC with and without MPI. The code runs > >> well in both cases. > >> > >> Now I would like to test CUDA but I am unable to configure it. I get an > >> error message related to thrust directory. > >> > >> The options I use to configure are the following: > >> > >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp --download-txpetscgpu=1 > >> --with-debugging=1 --with-scalar-type=real --with-precision=double > >> --download-f-blas-lapack > >> > >> The error message I get is: > >> > >> ============================================================ > >> =================== > >> Configuring PETSc to compile on your system > >> ============================================================ > >> =================== > >> TESTING: checkInclude from config.headers(config/ > >> BuildSystem/config/headers.py:86) ****************************** > >> ************************************************* > >> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > for > >> details): > >> ------------------------------------------------------------ > >> ------------------- > >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > >> ************************************************************ > >> ******************* > >> > >> > >> Did I miss something ? > >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. > >> > >> Many thanks in advance for your help. > >> Christophe > >> > >> > > > > -- > > Dominic Meiser > > Tech-X Corporation > > 5621 Arapahoe Avenue > > Boulder, CO 80303 > > USA > > Telephone: 303-996-2036 > > Fax: 303-448-7756 > > www.txcorp.com > > > > > -------------- next part -------------- > An HTML attachment was scrubbed... > URL: < > http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html > > > > ------------------------------ > > _______________________________________________ > petsc-users mailing list > petsc-users at mcs.anl.gov > https://lists.mcs.anl.gov/mailman/listinfo/petsc-users > > > End of petsc-users Digest, Vol 68, Issue 63 > ******************************************* > > ---------------------------- > Confidencialidad: > Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su > destinatario y puede contener informaci?n privilegiada o confidencial. Si > no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, > divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la > legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que > nos lo comunique inmediatamente respondiendo al mensaje y proceda a su > destrucci?n. > > Disclaimer: > This message and its attached files is intended exclusively for its > recipients and may contain confidential information. If you received this > e-mail in error you are hereby notified that any dissemination, copy or > disclosure of this communication is strictly prohibited and may be > unlawful. In this case, please notify us by a reply and delete this email > and its contents immediately. > ---------------------------- > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 29 08:28:28 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 08:28:28 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: Always attach configure.log or we cannot see what went wrong. Matt On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < christophe.ortiz at ciemat.es> wrote: > Hi Dominic and Paul, > > Thanks for your answers. Unfortunately, it did not work. Same error > message related to the thrust directory: > > > ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 > --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 > --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 > --with-scalar-type=real --with-precision=double --download-fblaslapack > > =============================================================================== > Configuring PETSc to compile on your system > > > =============================================================================== > TESTING: checkInclude from > config.headers(config/BuildSystem/config/headers.py:86) > > ******************************************************************************* > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for > details): > > ------------------------------------------------------------------------------- > --with-thrust-dir=/usr/local/cuda-6.0/include did not work > > ******************************************************************************* > > > I do not see what else to do...I have a standard CUDA installation that > came with thrust. > I am using ubuntu 12.04, I do not know if that could help. > I tried with PETSc 3.4.1 and 3.5.1. Same problem. > > Christophe > > > > > >> ------------------------------ >> >> Message: 3 >> Date: Thu, 28 Aug 2014 08:38:12 -0600 >> From: Dominic Meiser >> To: petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >> Problem with thrust directory >> Message-ID: <53FF3ED4.1090002 at txcorp.com> >> Content-Type: text/plain; charset=UTF-8; format=flowed >> >> Can you try configuring with >> >> --with-thrust-dir=/usr/local/cuda-6.0/include >> >> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >> same fix with cusp: >> >> --with-cusp-dir=/usr/local/cuda-6.0/include >> >> Cheers, >> Dominic >> > > > >> >> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >> > Hi all, >> > >> > I have implemented a problem of coupled diffusion equations in 1D >> > using PETSc. I was able to configure PETSC with and without MPI. The >> > code runs well in both cases. >> > >> > Now I would like to test CUDA but I am unable to configure it. I get >> > an error message related to thrust directory. >> > >> > The options I use to configure are the following: >> > >> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >> > --with-precision=double --download-f-blas-lapack >> > >> > The error message I get is: >> > >> > >> =============================================================================== >> > Configuring PETSc to compile on your system >> > >> =============================================================================== >> > TESTING: checkInclude from >> > config.headers(config/BuildSystem/config/headers.py:86) >> > >> ******************************************************************************* >> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >> > for details): >> > >> ------------------------------------------------------------------------------- >> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >> > >> ******************************************************************************* >> > >> > >> > Did I miss something ? >> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >> > >> > Many thanks in advance for your help. >> > Christophe >> > >> >> >> -- >> Dominic Meiser >> Tech-X Corporation >> 5621 Arapahoe Avenue >> Boulder, CO 80303 >> USA >> Telephone: 303-996-2036 >> Fax: 303-448-7756 >> www.txcorp.com >> >> >> >> ------------------------------ >> >> Message: 4 >> Date: Thu, 28 Aug 2014 08:30:40 -0600 >> From: Paul Mullowney >> To: Dominic Meiser >> Cc: petsc-users at mcs.anl.gov >> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >> Problem with thrust directory >> Message-ID: >> > 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >> Content-Type: text/plain; charset="utf-8" >> >> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >> -Paul >> >> >> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >> wrote: >> >> > Can you try configuring with >> > >> > --with-thrust-dir=/usr/local/cuda-6.0/include >> > >> > I.e. omit the 'thrust' at the end of the path. Probably you'll need the >> > same fix with cusp: >> > >> > --with-cusp-dir=/usr/local/cuda-6.0/include >> > >> > Cheers, >> > Dominic >> > >> > >> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >> > >> >> Hi all, >> >> >> >> I have implemented a problem of coupled diffusion equations in 1D using >> >> PETSc. I was able to configure PETSC with and without MPI. The code >> runs >> >> well in both cases. >> >> >> >> Now I would like to test CUDA but I am unable to configure it. I get an >> >> error message related to thrust directory. >> >> >> >> The options I use to configure are the following: >> >> >> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >> --download-txpetscgpu=1 >> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >> >> --download-f-blas-lapack >> >> >> >> The error message I get is: >> >> >> >> ============================================================ >> >> =================== >> >> Configuring PETSc to compile on your system >> >> ============================================================ >> >> =================== >> >> TESTING: checkInclude from config.headers(config/ >> >> BuildSystem/config/headers.py:86) ****************************** >> >> ************************************************* >> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >> for >> >> details): >> >> ------------------------------------------------------------ >> >> ------------------- >> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >> >> ************************************************************ >> >> ******************* >> >> >> >> >> >> Did I miss something ? >> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >> >> >> >> Many thanks in advance for your help. >> >> Christophe >> >> >> >> >> > >> > -- >> > Dominic Meiser >> > Tech-X Corporation >> > 5621 Arapahoe Avenue >> > Boulder, CO 80303 >> > USA >> > Telephone: 303-996-2036 >> > Fax: 303-448-7756 >> > www.txcorp.com >> > >> > >> -------------- next part -------------- >> An HTML attachment was scrubbed... >> URL: < >> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >> > >> >> ------------------------------ >> >> _______________________________________________ >> petsc-users mailing list >> petsc-users at mcs.anl.gov >> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >> >> >> End of petsc-users Digest, Vol 68, Issue 63 >> ******************************************* >> >> ---------------------------- >> Confidencialidad: >> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >> destinatario y puede contener informaci?n privilegiada o confidencial. Si >> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >> destrucci?n. >> >> Disclaimer: >> This message and its attached files is intended exclusively for its >> recipients and may contain confidential information. If you received this >> e-mail in error you are hereby notified that any dissemination, copy or >> disclosure of this communication is strictly prohibited and may be >> unlawful. In this case, please notify us by a reply and delete this email >> and its contents immediately. >> ---------------------------- >> >> > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Fri Aug 29 08:55:03 2014 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Fri, 29 Aug 2014 13:55:03 +0000 Subject: [petsc-users] PCFieldSplitSetSchurPre in fortran Message-ID: I'm trying PCFieldSplitSetSchurPre with PC_FIELDSPLIT_SCHUR_PRE_SELFP in petsc-3.5.1 using fortran. The first problem is that PC_FIELDSPLIT_SCHUR_PRE_SELFP seems to be missing in fortran, I get the compile error: This name does not have a type, and must have an explicit type. [PC_FIELDSPLIT_SCHUR_PRE_SELFP] while compilation works fine with _A11, _SELF and _USER. The second problem is that the call doesn't seem to have any effect. For example, I have CALL PCFieldSplitSetSchurPre(pc,PC_FIELDSPLIT_SCHUR_PRE_USER,aa,ierr) CALL PCFieldSplitSetSchurFactType(pc,PC_FIELDSPLIT_SCHUR_FACT_LOWER,ierr) This compiles and runs, but ksp_view tells me PC Object:(sys_) 3 MPI processes type: fieldsplit FieldSplit with Schur preconditioner, factorization LOWER Preconditioner for the Schur complement formed from A11 So changing the factorization from the default FULL to LOWER did work, but changing the preconditioner from A11 to USER didn't. I've also tried to run directly from the command line using -sys_pc_fieldsplit_schur_precondition user -sys_ksp_view This works in the sense that I don't get the "WARNING! There are options you set that were not used!" message, but still ksp_view reports A11 instead of user provided matrix. Chris dr. ir. Christiaan Klaij CFD Researcher Research & Development E mailto:C.Klaij at marin.nl T +31 317 49 33 44 MARIN 2, Haagsteeg, P.O. Box 28, 6700 AA Wageningen, The Netherlands T +31 317 49 39 11, F +31 317 49 32 45, I www.marin.nl From mailinglists at xgm.de Fri Aug 29 08:55:31 2014 From: mailinglists at xgm.de (Florian Lindner) Date: Fri, 29 Aug 2014 15:55:31 +0200 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Message-ID: Am 27.08.2014 14:12, schrieb Florian Lindner: > Hello, > > is there a way to create a vector with evenly spaced values in an > interval, like the numpy.arange function? > http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html > or the linspace function? Ok, I gave it as try. Do I need the VecAssembly the vector? void arange(size_t start, size_t stop) { // given a vector of appropriate size PetscScalar ierr; PetscScalar *a; ierr = PetscMalloc(sizeof(PetscScalar) * (stop-start), &a); CHKERRV(ierr); size_t pos = 0; for (size_t i = start; i < stop; i++) { a[pos] = i; pos++; } cout << "Array filled." << endl; VecReplaceArray(vector, a); // VecAssemblyBegin(vector); VecAssemblyEnd(vector); Do I need that? } Any comments? Thanks, Florian From knepley at gmail.com Fri Aug 29 09:08:44 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 09:08:44 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < christophe.ortiz at ciemat.es> wrote: > Sorry about that. > > Please find in attachment the configure.log file. Hope it will help you > find the error. > Here is the problem: Possible ERROR while running preprocessor: nvcc warning : The 'compute_10' and 'sm_10' architectures are deprecated, and may be removed in a future release. error message = {nvcc warning : The 'compute_10' and 'sm_10' architectures are deprecated, and may be removed in a future release. } meaning the nvcc compiler does not "work" as provided. Here is a workaround: --with-cudac='nvcc --arch=sm_35' Dominic, I think that thrust.py should depend on cuda.py. Do you know why it does not? Thanks, Matt > Christophe > > CIEMAT > Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico > Unidad de Materiales > Edificio 2 - Planta 0 - Despacho 28m > Avenida Complutense 40, > 28040 Madrid, Spain > Tel: +34 91496 2582 > Fax: +34 91346 6442 > > -- > Q > Por favor, piense en el medio ambiente antes de imprimir este mensaje. > Please consider the environment before printing this email. > > > On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley > wrote: > >> Always attach configure.log or we cannot see what went wrong. >> >> Matt >> >> >> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < >> christophe.ortiz at ciemat.es> wrote: >> >>> Hi Dominic and Paul, >>> >>> Thanks for your answers. Unfortunately, it did not work. Same error >>> message related to the thrust directory: >>> >>> >>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >>> --with-scalar-type=real --with-precision=double --download-fblaslapack >>> >>> =============================================================================== >>> Configuring PETSc to compile on your system >>> >>> >>> =============================================================================== >>> TESTING: checkInclude from >>> config.headers(config/BuildSystem/config/headers.py:86) >>> >>> ******************************************************************************* >>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>> for details): >>> >>> ------------------------------------------------------------------------------- >>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >>> >>> ******************************************************************************* >>> >>> >>> I do not see what else to do...I have a standard CUDA installation that >>> came with thrust. >>> I am using ubuntu 12.04, I do not know if that could help. >>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >>> >>> Christophe >>> >>> >>> >>> >>> >>>> ------------------------------ >>>> >>>> Message: 3 >>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>>> From: Dominic Meiser >>>> To: petsc-users at mcs.anl.gov >>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>> Problem with thrust directory >>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>>> Content-Type: text/plain; charset=UTF-8; format=flowed >>>> >>>> Can you try configuring with >>>> >>>> --with-thrust-dir=/usr/local/cuda-6.0/include >>>> >>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>>> same fix with cusp: >>>> >>>> --with-cusp-dir=/usr/local/cuda-6.0/include >>>> >>>> Cheers, >>>> Dominic >>>> >>> >>> >>> >>>> >>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>> > Hi all, >>>> > >>>> > I have implemented a problem of coupled diffusion equations in 1D >>>> > using PETSc. I was able to configure PETSC with and without MPI. The >>>> > code runs well in both cases. >>>> > >>>> > Now I would like to test CUDA but I am unable to configure it. I get >>>> > an error message related to thrust directory. >>>> > >>>> > The options I use to configure are the following: >>>> > >>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>>> > --with-precision=double --download-f-blas-lapack >>>> > >>>> > The error message I get is: >>>> > >>>> > >>>> =============================================================================== >>>> > Configuring PETSc to compile on your system >>>> > >>>> =============================================================================== >>>> > TESTING: checkInclude from >>>> > config.headers(config/BuildSystem/config/headers.py:86) >>>> > >>>> ******************************************************************************* >>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>> > for details): >>>> > >>>> ------------------------------------------------------------------------------- >>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>> > >>>> ******************************************************************************* >>>> > >>>> > >>>> > Did I miss something ? >>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>> > >>>> > Many thanks in advance for your help. >>>> > Christophe >>>> > >>>> >>>> >>>> -- >>>> Dominic Meiser >>>> Tech-X Corporation >>>> 5621 Arapahoe Avenue >>>> Boulder, CO 80303 >>>> USA >>>> Telephone: 303-996-2036 >>>> Fax: 303-448-7756 >>>> www.txcorp.com >>>> >>>> >>>> >>>> ------------------------------ >>>> >>>> Message: 4 >>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>>> From: Paul Mullowney >>>> To: Dominic Meiser >>>> Cc: petsc-users at mcs.anl.gov >>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>> Problem with thrust directory >>>> Message-ID: >>>> >>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>>> Content-Type: text/plain; charset="utf-8" >>>> >>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>>> -Paul >>>> >>>> >>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>>> wrote: >>>> >>>> > Can you try configuring with >>>> > >>>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>>> > >>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>> the >>>> > same fix with cusp: >>>> > >>>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>>> > >>>> > Cheers, >>>> > Dominic >>>> > >>>> > >>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>> > >>>> >> Hi all, >>>> >> >>>> >> I have implemented a problem of coupled diffusion equations in 1D >>>> using >>>> >> PETSc. I was able to configure PETSC with and without MPI. The code >>>> runs >>>> >> well in both cases. >>>> >> >>>> >> Now I would like to test CUDA but I am unable to configure it. I get >>>> an >>>> >> error message related to thrust directory. >>>> >> >>>> >> The options I use to configure are the following: >>>> >> >>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>> --download-txpetscgpu=1 >>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>>> >> --download-f-blas-lapack >>>> >> >>>> >> The error message I get is: >>>> >> >>>> >> ============================================================ >>>> >> =================== >>>> >> Configuring PETSc to compile on your system >>>> >> ============================================================ >>>> >> =================== >>>> >> TESTING: checkInclude from config.headers(config/ >>>> >> BuildSystem/config/headers.py:86) ****************************** >>>> >> ************************************************* >>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>> configure.log for >>>> >> details): >>>> >> ------------------------------------------------------------ >>>> >> ------------------- >>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>> >> ************************************************************ >>>> >> ******************* >>>> >> >>>> >> >>>> >> Did I miss something ? >>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>> >> >>>> >> Many thanks in advance for your help. >>>> >> Christophe >>>> >> >>>> >> >>>> > >>>> > -- >>>> > Dominic Meiser >>>> > Tech-X Corporation >>>> > 5621 Arapahoe Avenue >>>> > Boulder, CO 80303 >>>> > USA >>>> > Telephone: 303-996-2036 >>>> > Fax: 303-448-7756 >>>> > www.txcorp.com >>>> > >>>> > >>>> -------------- next part -------------- >>>> An HTML attachment was scrubbed... >>>> URL: < >>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>>> > >>>> >>>> ------------------------------ >>>> >>>> _______________________________________________ >>>> petsc-users mailing list >>>> petsc-users at mcs.anl.gov >>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>>> >>>> >>>> End of petsc-users Digest, Vol 68, Issue 63 >>>> ******************************************* >>>> >>>> ---------------------------- >>>> Confidencialidad: >>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>>> destrucci?n. >>>> >>>> Disclaimer: >>>> This message and its attached files is intended exclusively for its >>>> recipients and may contain confidential information. If you received this >>>> e-mail in error you are hereby notified that any dissemination, copy or >>>> disclosure of this communication is strictly prohibited and may be >>>> unlawful. In this case, please notify us by a reply and delete this email >>>> and its contents immediately. >>>> ---------------------------- >>>> >>>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 29 09:14:53 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 09:14:53 -0500 Subject: [petsc-users] PCFieldSplitSetSchurPre in fortran In-Reply-To: References: Message-ID: On Fri, Aug 29, 2014 at 8:55 AM, Klaij, Christiaan wrote: > I'm trying PCFieldSplitSetSchurPre with > PC_FIELDSPLIT_SCHUR_PRE_SELFP in petsc-3.5.1 using fortran. > > The first problem is that PC_FIELDSPLIT_SCHUR_PRE_SELFP seems to > be missing in fortran, I get the compile error: > > This name does not have a type, and must have an explicit type. > [PC_FIELDSPLIT_SCHUR_PRE_SELFP] > > while compilation works fine with _A11, _SELF and _USER. > Mark Adams has just fixed this. > The second problem is that the call doesn't seem to have any > effect. For example, I have > > CALL PCFieldSplitSetSchurPre(pc,PC_FIELDSPLIT_SCHUR_PRE_USER,aa,ierr) > CALL PCFieldSplitSetSchurFactType(pc,PC_FIELDSPLIT_SCHUR_FACT_LOWER,ierr) > > This compiles and runs, but ksp_view tells me > > PC Object:(sys_) 3 MPI processes > type: fieldsplit > FieldSplit with Schur preconditioner, factorization LOWER > Preconditioner for the Schur complement formed from A11 > > So changing the factorization from the default FULL to LOWER did > work, but changing the preconditioner from A11 to USER didn't. > > I've also tried to run directly from the command line using > > -sys_pc_fieldsplit_schur_precondition user -sys_ksp_view > > This works in the sense that I don't get the "WARNING! There are > options you set that were not used!" message, but still ksp_view > reports A11 instead of user provided matrix. > Can you send a small test code, since I use this everyday here and it works. Thanks, Matt > Chris > > > dr. ir. Christiaan Klaij > CFD Researcher > Research & Development > E mailto:C.Klaij at marin.nl > T +31 317 49 33 44 > > > MARIN > 2, Haagsteeg, P.O. Box 28, 6700 AA Wageningen, The Netherlands > T +31 317 49 39 11, F +31 317 49 32 45, I www.marin.nl > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From paulmullowney at gmail.com Fri Aug 29 09:24:47 2014 From: paulmullowney at gmail.com (Paul Mullowney) Date: Fri, 29 Aug 2014 08:24:47 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: Isn't thrust typically in /usr/local/cuda-6.0/include/thrust so you need --with-thrust-dir=/usr/local/cuda-6.0/include/thrust There may be a similar issue with your cusp path. -Paul On Fri, Aug 29, 2014 at 8:08 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < > christophe.ortiz at ciemat.es> wrote: > >> Sorry about that. >> >> Please find in attachment the configure.log file. Hope it will help you >> find the error. >> > > Here is the problem: > > Possible ERROR while running preprocessor: nvcc warning : The 'compute_10' > and 'sm_10' architectures are deprecated, and may be removed in a future > release. > error message = {nvcc warning : The 'compute_10' and 'sm_10' architectures > are deprecated, and may be removed in a future release. > } > > meaning the nvcc compiler does not "work" as provided. Here is a > workaround: > > --with-cudac='nvcc --arch=sm_35' > > Dominic, I think that thrust.py should depend on cuda.py. Do you know why > it does not? > > Thanks, > > Matt > > > >> Christophe >> >> CIEMAT >> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico >> Unidad de Materiales >> Edificio 2 - Planta 0 - Despacho 28m >> Avenida Complutense 40, >> 28040 Madrid, Spain >> Tel: +34 91496 2582 >> Fax: +34 91346 6442 >> >> -- >> Q >> Por favor, piense en el medio ambiente antes de imprimir este mensaje. >> Please consider the environment before printing this email. >> >> >> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley >> wrote: >> >>> Always attach configure.log or we cannot see what went wrong. >>> >>> Matt >>> >>> >>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < >>> christophe.ortiz at ciemat.es> wrote: >>> >>>> Hi Dominic and Paul, >>>> >>>> Thanks for your answers. Unfortunately, it did not work. Same error >>>> message related to the thrust directory: >>>> >>>> >>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >>>> --with-scalar-type=real --with-precision=double --download-fblaslapack >>>> >>>> =============================================================================== >>>> Configuring PETSc to compile on your system >>>> >>>> >>>> =============================================================================== >>>> TESTING: checkInclude from >>>> config.headers(config/BuildSystem/config/headers.py:86) >>>> >>>> ******************************************************************************* >>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>> for details): >>>> >>>> ------------------------------------------------------------------------------- >>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >>>> >>>> ******************************************************************************* >>>> >>>> >>>> I do not see what else to do...I have a standard CUDA installation that >>>> came with thrust. >>>> I am using ubuntu 12.04, I do not know if that could help. >>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >>>> >>>> Christophe >>>> >>>> >>>> >>>> >>>> >>>>> ------------------------------ >>>>> >>>>> Message: 3 >>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>>>> From: Dominic Meiser >>>>> To: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>>>> Content-Type: text/plain; charset=UTF-8; format=flowed >>>>> >>>>> Can you try configuring with >>>>> >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> >>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>>>> same fix with cusp: >>>>> >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> >>>>> Cheers, >>>>> Dominic >>>>> >>>> >>>> >>>> >>>>> >>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > Hi all, >>>>> > >>>>> > I have implemented a problem of coupled diffusion equations in 1D >>>>> > using PETSc. I was able to configure PETSC with and without MPI. The >>>>> > code runs well in both cases. >>>>> > >>>>> > Now I would like to test CUDA but I am unable to configure it. I get >>>>> > an error message related to thrust directory. >>>>> > >>>>> > The options I use to configure are the following: >>>>> > >>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>>>> > --with-precision=double --download-f-blas-lapack >>>>> > >>>>> > The error message I get is: >>>>> > >>>>> > >>>>> =============================================================================== >>>>> > Configuring PETSc to compile on your system >>>>> > >>>>> =============================================================================== >>>>> > TESTING: checkInclude from >>>>> > config.headers(config/BuildSystem/config/headers.py:86) >>>>> > >>>>> ******************************************************************************* >>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>>> > for details): >>>>> > >>>>> ------------------------------------------------------------------------------- >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> > >>>>> ******************************************************************************* >>>>> > >>>>> > >>>>> > Did I miss something ? >>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> > >>>>> > Many thanks in advance for your help. >>>>> > Christophe >>>>> > >>>>> >>>>> >>>>> -- >>>>> Dominic Meiser >>>>> Tech-X Corporation >>>>> 5621 Arapahoe Avenue >>>>> Boulder, CO 80303 >>>>> USA >>>>> Telephone: 303-996-2036 >>>>> Fax: 303-448-7756 >>>>> www.txcorp.com >>>>> >>>>> >>>>> >>>>> ------------------------------ >>>>> >>>>> Message: 4 >>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>>>> From: Paul Mullowney >>>>> To: Dominic Meiser >>>>> Cc: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: >>>>> >>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>>>> Content-Type: text/plain; charset="utf-8" >>>>> >>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>>>> -Paul >>>>> >>>>> >>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>>>> wrote: >>>>> >>>>> > Can you try configuring with >>>>> > >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>>> the >>>>> > same fix with cusp: >>>>> > >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > Cheers, >>>>> > Dominic >>>>> > >>>>> > >>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > >>>>> >> Hi all, >>>>> >> >>>>> >> I have implemented a problem of coupled diffusion equations in 1D >>>>> using >>>>> >> PETSc. I was able to configure PETSC with and without MPI. The code >>>>> runs >>>>> >> well in both cases. >>>>> >> >>>>> >> Now I would like to test CUDA but I am unable to configure it. I >>>>> get an >>>>> >> error message related to thrust directory. >>>>> >> >>>>> >> The options I use to configure are the following: >>>>> >> >>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> --download-txpetscgpu=1 >>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>>>> >> --download-f-blas-lapack >>>>> >> >>>>> >> The error message I get is: >>>>> >> >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> Configuring PETSc to compile on your system >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> TESTING: checkInclude from config.headers(config/ >>>>> >> BuildSystem/config/headers.py:86) ****************************** >>>>> >> ************************************************* >>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>>> configure.log for >>>>> >> details): >>>>> >> ------------------------------------------------------------ >>>>> >> ------------------- >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> >> ************************************************************ >>>>> >> ******************* >>>>> >> >>>>> >> >>>>> >> Did I miss something ? >>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> >> >>>>> >> Many thanks in advance for your help. >>>>> >> Christophe >>>>> >> >>>>> >> >>>>> > >>>>> > -- >>>>> > Dominic Meiser >>>>> > Tech-X Corporation >>>>> > 5621 Arapahoe Avenue >>>>> > Boulder, CO 80303 >>>>> > USA >>>>> > Telephone: 303-996-2036 >>>>> > Fax: 303-448-7756 >>>>> > www.txcorp.com >>>>> > >>>>> > >>>>> -------------- next part -------------- >>>>> An HTML attachment was scrubbed... >>>>> URL: < >>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>>>> > >>>>> >>>>> ------------------------------ >>>>> >>>>> _______________________________________________ >>>>> petsc-users mailing list >>>>> petsc-users at mcs.anl.gov >>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>>>> >>>>> >>>>> End of petsc-users Digest, Vol 68, Issue 63 >>>>> ******************************************* >>>>> >>>>> ---------------------------- >>>>> Confidencialidad: >>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>>>> destrucci?n. >>>>> >>>>> Disclaimer: >>>>> This message and its attached files is intended exclusively for its >>>>> recipients and may contain confidential information. If you received this >>>>> e-mail in error you are hereby notified that any dissemination, copy or >>>>> disclosure of this communication is strictly prohibited and may be >>>>> unlawful. In this case, please notify us by a reply and delete this email >>>>> and its contents immediately. >>>>> ---------------------------- >>>>> >>>>> >>>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From dmeiser at txcorp.com Fri Aug 29 09:35:57 2014 From: dmeiser at txcorp.com (Dominic Meiser) Date: Fri, 29 Aug 2014 08:35:57 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: <54008FCD.4030604@txcorp.com> On 08/29/2014 08:08 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz > > wrote: > > Sorry about that. > > Please find in attachment the configure.log file. Hope it will > help you find the error. > > > Here is the problem: > > Possible ERROR while running preprocessor: nvcc warning : The > 'compute_10' and 'sm_10' architectures are deprecated, and may be > removed in a future release. > error message = {nvcc warning : The 'compute_10' and 'sm_10' > architectures are deprecated, and may be removed in a future release. > } > > meaning the nvcc compiler does not "work" as provided. Here is a > workaround: > > --with-cudac='nvcc --arch=sm_35' > > Dominic, I think that thrust.py should depend on cuda.py. Do you know > why it does not? In principle you are right, thrust.py should depend on cuda.py. However, in my opinion, thrust.py should go away as a separate package altogether. Thrust is shipped as part of any recent version of the cuda toolkit (I forget since which version, Paul might know) and it's always installed in $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically deduct the thrust location from the cuda location. Thrust should be considered part of cuda. Cheers, Dominic > > Thanks, > > Matt > > Christophe > > CIEMAT > Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico > Unidad de Materiales > Edificio 2 - Planta 0 - Despacho 28m > Avenida Complutense 40, > 28040 Madrid, Spain > Tel: +34 91496 2582 > Fax: +34 91346 6442 > > -- > Q > Por favor, piense en el medio ambiente antes de imprimir este > mensaje. > Please consider the environment before printing this email. > > > On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley > > wrote: > > Always attach configure.log or we cannot see what went wrong. > > Matt > > > On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz > > wrote: > > Hi Dominic and Paul, > > Thanks for your answers. Unfortunately, it did not work. > Same error message related to the thrust directory: > > > ./configure --with-x=1 --with-mpi=0 --with-cc=icc > --with-cxx=icpc --with-clanguage=cxx --with-fc=ifort > --with-cuda=1 --with-cuda-dir=/usr/local/cuda-6.0 > --with-cuda-arch=sm_35 --with-thrust=1 > --with-thrust-dir=/usr/local/cuda-6.0/include > --with-cusp=1 --with-cusp-dir=/usr/local/cuda-6.0/include > --with-debugging=1 --with-scalar-type=real > --with-precision=double --download-fblaslapack > =============================================================================== > Configuring PETSc to compile on your system > =============================================================================== > TESTING: checkInclude from > config.headers(config/BuildSystem/config/headers.py:86) > ******************************************************************************* > UNABLE to CONFIGURE with GIVEN OPTIONS (see > configure.log for details): > ------------------------------------------------------------------------------- > --with-thrust-dir=/usr/local/cuda-6.0/include did not work > ******************************************************************************* > > > I do not see what else to do...I have a standard CUDA > installation that came with thrust. > I am using ubuntu 12.04, I do not know if that could help. > I tried with PETSc 3.4.1 and 3.5.1. Same problem. > > Christophe > > > > ------------------------------ > > Message: 3 > Date: Thu, 28 Aug 2014 08:38:12 -0600 > From: Dominic Meiser > > To: petsc-users at mcs.anl.gov > > Subject: Re: [petsc-users] Unable to configure PETSc > with CUDA: > Problem with thrust directory > Message-ID: <53FF3ED4.1090002 at txcorp.com > > > Content-Type: text/plain; charset=UTF-8; format=flowed > > Can you try configuring with > > --with-thrust-dir=/usr/local/cuda-6.0/include > > I.e. omit the 'thrust' at the end of the path. > Probably you'll need the > same fix with cusp: > > --with-cusp-dir=/usr/local/cuda-6.0/include > > Cheers, > Dominic > > > > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > Hi all, > > > > I have implemented a problem of coupled diffusion > equations in 1D > > using PETSc. I was able to configure PETSC with and > without MPI. The > > code runs well in both cases. > > > > Now I would like to test CUDA but I am unable to > configure it. I get > > an error message related to thrust directory. > > > > The options I use to configure are the following: > > > > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > > --with-cuda-dir=/usr/local/cuda-6.0 > --with-cuda-arch=sm_35 > > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust > --with-cusp=1 > > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > > --download-txpetscgpu=1 --with-debugging=1 > --with-scalar-type=real > > --with-precision=double --download-f-blas-lapack > > > > The error message I get is: > > > > > =============================================================================== > > Configuring PETSc to compile on your system > > > =============================================================================== > > TESTING: checkInclude from > > config.headers(config/BuildSystem/config/headers.py:86) > > > ******************************************************************************* > > UNABLE to CONFIGURE with GIVEN OPTIONS > (see configure.log > > for details): > > > ------------------------------------------------------------------------------- > > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust > did not work > > > ******************************************************************************* > > > > > > Did I miss something ? > > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > > > Many thanks in advance for your help. > > Christophe > > > > > -- > Dominic Meiser > Tech-X Corporation > 5621 Arapahoe Avenue > Boulder, CO 80303 > USA > Telephone: 303-996-2036 > Fax: 303-448-7756 > www.txcorp.com > > > > ------------------------------ > > Message: 4 > Date: Thu, 28 Aug 2014 08:30:40 -0600 > From: Paul Mullowney > > To: Dominic Meiser > > Cc: petsc-users at mcs.anl.gov > > Subject: Re: [petsc-users] Unable to configure PETSc > with CUDA: > Problem with thrust directory > Message-ID: > > > Content-Type: text/plain; charset="utf-8" > > Also, get rid of --download-txpetscgpu=1. That doesn't > exist anymore. > -Paul > > > On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser > > wrote: > > > Can you try configuring with > > > > --with-thrust-dir=/usr/local/cuda-6.0/include > > > > I.e. omit the 'thrust' at the end of the path. > Probably you'll need the > > same fix with cusp: > > > > --with-cusp-dir=/usr/local/cuda-6.0/include > > > > Cheers, > > Dominic > > > > > > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > > >> Hi all, > >> > >> I have implemented a problem of coupled diffusion > equations in 1D using > >> PETSc. I was able to configure PETSC with and > without MPI. The code runs > >> well in both cases. > >> > >> Now I would like to test CUDA but I am unable to > configure it. I get an > >> error message related to thrust directory. > >> > >> The options I use to configure are the following: > >> > >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > >> --with-cuda-dir=/usr/local/cuda-6.0 > --with-cuda-arch=sm_35 > >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > >> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust > --with-cusp=1 > >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > --download-txpetscgpu=1 > >> --with-debugging=1 --with-scalar-type=real > --with-precision=double > >> --download-f-blas-lapack > >> > >> The error message I get is: > >> > >> > ============================================================ > >> =================== > >> Configuring PETSc to compile on your > system > >> > ============================================================ > >> =================== > >> TESTING: checkInclude from config.headers(config/ > >> BuildSystem/config/headers.py:86) > ****************************** > >> ************************************************* > >> UNABLE to CONFIGURE with GIVEN OPTIONS > (see configure.log for > >> details): > >> > ------------------------------------------------------------ > >> ------------------- > >> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust > did not work > >> > ************************************************************ > >> ******************* > >> > >> > >> Did I miss something ? > >> My GPU is a GeForce Titan Black and I am using CUDA > 6.0. > >> > >> Many thanks in advance for your help. > >> Christophe > >> > >> > > > > -- > > Dominic Meiser > > Tech-X Corporation > > 5621 Arapahoe Avenue > > Boulder, CO 80303 > > USA > > Telephone: 303-996-2036 > > Fax: 303-448-7756 > > www.txcorp.com > > > > > -------------- next part -------------- > An HTML attachment was scrubbed... > URL: > > > ------------------------------ > > _______________________________________________ > petsc-users mailing list > petsc-users at mcs.anl.gov > https://lists.mcs.anl.gov/mailman/listinfo/petsc-users > > > End of petsc-users Digest, Vol 68, Issue 63 > ******************************************* > > ---------------------------- > Confidencialidad: > Este mensaje y sus ficheros adjuntos se dirige > exclusivamente a su destinatario y puede contener > informaci?n privilegiada o confidencial. Si no es vd. > el destinatario indicado, queda notificado de que la > utilizaci?n, divulgaci?n y/o copia sin autorizaci?n > est? prohibida en virtud de la legislaci?n vigente. Si > ha recibido este mensaje por error, le rogamos que nos > lo comunique inmediatamente respondiendo al mensaje y > proceda a su destrucci?n. > > Disclaimer: > This message and its attached files is intended > exclusively for its recipients and may contain > confidential information. If you received this e-mail > in error you are hereby notified that any > dissemination, copy or disclosure of this > communication is strictly prohibited and may be > unlawful. In this case, please notify us by a reply > and delete this email and its contents immediately. > ---------------------------- > > > > > > -- > What most experimenters take for granted before they begin > their experiments is infinitely more interesting than any > results to which their experiments lead. > -- Norbert Wiener > > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener -- Dominic Meiser Tech-X Corporation 5621 Arapahoe Avenue Boulder, CO 80303 USA Telephone: 303-996-2036 Fax: 303-448-7756 www.txcorp.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From hong at aspiritech.org Fri Aug 29 09:29:21 2014 From: hong at aspiritech.org (hong at aspiritech.org) Date: Fri, 29 Aug 2014 09:29:21 -0500 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Message-ID: Florian : >> >> is there a way to create a vector with evenly spaced values in an >> interval, like the numpy.arange function? >> http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html >> or the linspace function? > > > Ok, I gave it as try. Do I need the VecAssembly the vector? No, but you need VecResetArray() when vector is no longer used. Hong > > > void arange(size_t start, size_t stop) > { > // given a vector of appropriate size > PetscScalar ierr; > PetscScalar *a; > ierr = PetscMalloc(sizeof(PetscScalar) * (stop-start), &a); > CHKERRV(ierr); > size_t pos = 0; > for (size_t i = start; i < stop; i++) { > a[pos] = i; > pos++; > } > cout << "Array filled." << endl; > VecReplaceArray(vector, a); > // VecAssemblyBegin(vector); VecAssemblyEnd(vector); Do I need that? > } > > Any comments? > > Thanks, > Florian From knepley at gmail.com Fri Aug 29 09:31:57 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 09:31:57 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: <54008FCD.4030604@txcorp.com> References: <54008FCD.4030604@txcorp.com> Message-ID: On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser wrote: > On 08/29/2014 08:08 AM, Matthew Knepley wrote: > > On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < > christophe.ortiz at ciemat.es> wrote: > >> Sorry about that. >> >> Please find in attachment the configure.log file. Hope it will help you >> find the error. >> > > Here is the problem: > > Possible ERROR while running preprocessor: nvcc warning : The > 'compute_10' and 'sm_10' architectures are deprecated, and may be removed > in a future release. > error message = {nvcc warning : The 'compute_10' and 'sm_10' architectures > are deprecated, and may be removed in a future release. > } > > meaning the nvcc compiler does not "work" as provided. Here is a > workaround: > > --with-cudac='nvcc --arch=sm_35' > > Dominic, I think that thrust.py should depend on cuda.py. Do you know > why it does not? > > In principle you are right, thrust.py should depend on cuda.py. > > However, in my opinion, thrust.py should go away as a separate package > altogether. Thrust is shipped as part of any recent version of the cuda > toolkit (I forget since which version, Paul might know) and it's always > installed in $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically > deduct the thrust location from the cuda location. Thrust should be > considered part of cuda. > That does not mean the configure modules should be organized that way. Thrust is a package included in CUDA, thus it should have an independent module, but depend on the CUDA module. Matt > Cheers, > Dominic > > > Thanks, > > Matt > > > >> Christophe >> >> CIEMAT >> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico >> Unidad de Materiales >> Edificio 2 - Planta 0 - Despacho 28m >> Avenida Complutense 40, >> 28040 Madrid, Spain >> Tel: +34 91496 2582 <%2B34%2091496%202582> >> Fax: +34 91346 6442 <%2B34%2091346%206442> >> >> -- >> Q >> Por favor, piense en el medio ambiente antes de imprimir este mensaje. >> Please consider the environment before printing this email. >> >> >> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley >> wrote: >> >>> Always attach configure.log or we cannot see what went wrong. >>> >>> Matt >>> >>> >>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < >>> christophe.ortiz at ciemat.es> wrote: >>> >>>> Hi Dominic and Paul, >>>> >>>> Thanks for your answers. Unfortunately, it did not work. Same error >>>> message related to the thrust directory: >>>> >>>> >>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >>>> --with-scalar-type=real --with-precision=double --download-fblaslapack >>>> >>>> =============================================================================== >>>> Configuring PETSc to compile on your system >>>> >>>> >>>> =============================================================================== >>>> TESTING: checkInclude from >>>> config.headers(config/BuildSystem/config/headers.py:86) >>>> >>>> ******************************************************************************* >>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>> for details): >>>> >>>> ------------------------------------------------------------------------------- >>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >>>> >>>> ******************************************************************************* >>>> >>>> >>>> I do not see what else to do...I have a standard CUDA installation >>>> that came with thrust. >>>> I am using ubuntu 12.04, I do not know if that could help. >>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >>>> >>>> Christophe >>>> >>>> >>>> >>>> >>>> >>>>> ------------------------------ >>>>> >>>>> Message: 3 >>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>>>> From: Dominic Meiser >>>>> To: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>>>> Content-Type: text/plain; charset=UTF-8; format=flowed >>>>> >>>>> Can you try configuring with >>>>> >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> >>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>>>> same fix with cusp: >>>>> >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> >>>>> Cheers, >>>>> Dominic >>>>> >>>> >>>> >>>> >>>>> >>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > Hi all, >>>>> > >>>>> > I have implemented a problem of coupled diffusion equations in 1D >>>>> > using PETSc. I was able to configure PETSC with and without MPI. The >>>>> > code runs well in both cases. >>>>> > >>>>> > Now I would like to test CUDA but I am unable to configure it. I get >>>>> > an error message related to thrust directory. >>>>> > >>>>> > The options I use to configure are the following: >>>>> > >>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>>>> > --with-precision=double --download-f-blas-lapack >>>>> > >>>>> > The error message I get is: >>>>> > >>>>> > >>>>> =============================================================================== >>>>> > Configuring PETSc to compile on your system >>>>> > >>>>> =============================================================================== >>>>> > TESTING: checkInclude from >>>>> > config.headers(config/BuildSystem/config/headers.py:86) >>>>> > >>>>> ******************************************************************************* >>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>>> > for details): >>>>> > >>>>> ------------------------------------------------------------------------------- >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> > >>>>> ******************************************************************************* >>>>> > >>>>> > >>>>> > Did I miss something ? >>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> > >>>>> > Many thanks in advance for your help. >>>>> > Christophe >>>>> > >>>>> >>>>> >>>>> -- >>>>> Dominic Meiser >>>>> Tech-X Corporation >>>>> 5621 Arapahoe Avenue >>>>> Boulder, CO 80303 >>>>> USA >>>>> Telephone: 303-996-2036 >>>>> Fax: 303-448-7756 >>>>> www.txcorp.com >>>>> >>>>> >>>>> >>>>> ------------------------------ >>>>> >>>>> Message: 4 >>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>>>> From: Paul Mullowney >>>>> To: Dominic Meiser >>>>> Cc: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: >>>>> >>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>>>> Content-Type: text/plain; charset="utf-8" >>>>> >>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>>>> -Paul >>>>> >>>>> >>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>>>> wrote: >>>>> >>>>> > Can you try configuring with >>>>> > >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>>> the >>>>> > same fix with cusp: >>>>> > >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > Cheers, >>>>> > Dominic >>>>> > >>>>> > >>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > >>>>> >> Hi all, >>>>> >> >>>>> >> I have implemented a problem of coupled diffusion equations in 1D >>>>> using >>>>> >> PETSc. I was able to configure PETSC with and without MPI. The code >>>>> runs >>>>> >> well in both cases. >>>>> >> >>>>> >> Now I would like to test CUDA but I am unable to configure it. I >>>>> get an >>>>> >> error message related to thrust directory. >>>>> >> >>>>> >> The options I use to configure are the following: >>>>> >> >>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> --download-txpetscgpu=1 >>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>>>> >> --download-f-blas-lapack >>>>> >> >>>>> >> The error message I get is: >>>>> >> >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> Configuring PETSc to compile on your system >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> TESTING: checkInclude from config.headers(config/ >>>>> >> BuildSystem/config/headers.py:86) ****************************** >>>>> >> ************************************************* >>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>>> configure.log for >>>>> >> details): >>>>> >> ------------------------------------------------------------ >>>>> >> ------------------- >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> >> ************************************************************ >>>>> >> ******************* >>>>> >> >>>>> >> >>>>> >> Did I miss something ? >>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> >> >>>>> >> Many thanks in advance for your help. >>>>> >> Christophe >>>>> >> >>>>> >> >>>>> > >>>>> > -- >>>>> > Dominic Meiser >>>>> > Tech-X Corporation >>>>> > 5621 Arapahoe Avenue >>>>> > Boulder, CO 80303 >>>>> > USA >>>>> > Telephone: 303-996-2036 >>>>> > Fax: 303-448-7756 >>>>> > www.txcorp.com >>>>> > >>>>> > >>>>> -------------- next part -------------- >>>>> An HTML attachment was scrubbed... >>>>> URL: < >>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>>>> > >>>>> >>>>> ------------------------------ >>>>> >>>>> _______________________________________________ >>>>> petsc-users mailing list >>>>> petsc-users at mcs.anl.gov >>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>>>> >>>>> >>>>> End of petsc-users Digest, Vol 68, Issue 63 >>>>> ******************************************* >>>>> >>>>> ---------------------------- >>>>> Confidencialidad: >>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>>>> destrucci?n. >>>>> >>>>> Disclaimer: >>>>> This message and its attached files is intended exclusively for its >>>>> recipients and may contain confidential information. If you received this >>>>> e-mail in error you are hereby notified that any dissemination, copy or >>>>> disclosure of this communication is strictly prohibited and may be >>>>> unlawful. In this case, please notify us by a reply and delete this email >>>>> and its contents immediately. >>>>> ---------------------------- >>>>> >>>>> >>>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > > > -- > Dominic Meiser > Tech-X Corporation > 5621 Arapahoe Avenue > Boulder, CO 80303 > USA > Telephone: 303-996-2036 > Fax: 303-448-7756www.txcorp.com > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From asmund.ervik at ntnu.no Fri Aug 29 09:35:20 2014 From: asmund.ervik at ntnu.no (=?utf-8?B?w4VzbXVuZCBFcnZpaw==?=) Date: Fri, 29 Aug 2014 14:35:20 +0000 Subject: [petsc-users] Reusing the preconditioner when using KSPSetComputeOperators Message-ID: <0E576811AB298343AC632BBCAAEFC37945D5AE5A@WAREHOUSE08.win.ntnu.no> > On 28. aug. 2014 20:52, Barry Smith wrote: > > > > On Aug 28, 2014, at 4:34 AM, ?smund Ervik wrote: > > > >> Hello, > >> > >> I am solving a pressure Poisson equation with KSP, where the initial > >> guess, RHS and matrix are computed by functions that I've hooked into > >> KSPSetComputeXXX. (I'm also using DMDA for my domain decomposition.) > >> > >> For (single-phase|two-phase) I would like to (reuse|not reuse) the > >> preconditioner. How do I specify that when using this way of setting the > >> operator? Is it toggled by whether or not I call KSPSetOperators before > >> each KSPSolve? (The manual does not mention KSPSetComputeXXX.) > > > > You should call KSPSetOperators() before each KSPSolve() (otherwise the function you provide to compute the matrix won?t be triggered). > > > > With PETSc 3.5 after the call to KSPSetOperators() call KSPSetReusePreconditioner() to tell KSP wether to reuse the preconditioner or build a new one. > > With PETSc 3.4 and earlier, the final argument to KSPSetOperators() would be MAT_SAME_PRECONDITIONER to reuse the preconditioner or MAT_SAME_NONZERO_PATTERN to construct a new preconditioner > > Thanks Barry for the clarification. Is there an example somewhere that does this? All the ones I can find which use KSPSetComputeOperators() have no calls to KSPSetOperators(). I guess this is because they are only doing one linear solve? Furthermore, what should I pass in for Amat and Pmat to the KSPSetOperators() call? PetscNullObject, or do I get the Amat from the KSP somehow? ?smund -------------- next part -------------- An HTML attachment was scrubbed... URL: From ashwinsrnth at gmail.com Fri Aug 29 09:40:12 2014 From: ashwinsrnth at gmail.com (Ashwin Srinath) Date: Fri, 29 Aug 2014 10:40:12 -0400 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: Hello, My original message is awaiting approval as attaching configure.log made it too large. I hope it's okay for me to repeat here: I'm having a similar issue with CUDA 6.0. PETSc configured just fine with version 5.0 and 5.5, and I'm using an almost identical configure command (only changing --with-cuda-dir). I get the following error: CUDA version error: PETSC currently requires CUDA version 4.0 or higher - when compiling with CUDA I suspect the problem might be with cuda.py checking for my CUDA version, but I can't be sure. Any suggestions? Thanks, Ashwin On Fri, Aug 29, 2014 at 10:31 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > wrote: > >> On 08/29/2014 08:08 AM, Matthew Knepley wrote: >> >> On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < >> christophe.ortiz at ciemat.es> wrote: >> >>> Sorry about that. >>> >>> Please find in attachment the configure.log file. Hope it will help >>> you find the error. >>> >> >> Here is the problem: >> >> Possible ERROR while running preprocessor: nvcc warning : The >> 'compute_10' and 'sm_10' architectures are deprecated, and may be removed >> in a future release. >> error message = {nvcc warning : The 'compute_10' and 'sm_10' >> architectures are deprecated, and may be removed in a future release. >> } >> >> meaning the nvcc compiler does not "work" as provided. Here is a >> workaround: >> >> --with-cudac='nvcc --arch=sm_35' >> >> Dominic, I think that thrust.py should depend on cuda.py. Do you know >> why it does not? >> >> In principle you are right, thrust.py should depend on cuda.py. >> >> However, in my opinion, thrust.py should go away as a separate package >> altogether. Thrust is shipped as part of any recent version of the cuda >> toolkit (I forget since which version, Paul might know) and it's always >> installed in $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically >> deduct the thrust location from the cuda location. Thrust should be >> considered part of cuda. >> > > That does not mean the configure modules should be organized that way. > Thrust is a package included in CUDA, thus > it should have an independent module, but depend on the CUDA module. > > Matt > > >> Cheers, >> Dominic >> >> >> Thanks, >> >> Matt >> >> >> >>> Christophe >>> >>> CIEMAT >>> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico >>> Unidad de Materiales >>> Edificio 2 - Planta 0 - Despacho 28m >>> Avenida Complutense 40, >>> 28040 Madrid, Spain >>> Tel: +34 91496 2582 <%2B34%2091496%202582> >>> Fax: +34 91346 6442 <%2B34%2091346%206442> >>> >>> -- >>> Q >>> Por favor, piense en el medio ambiente antes de imprimir este mensaje. >>> Please consider the environment before printing this email. >>> >>> >>> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley >>> wrote: >>> >>>> Always attach configure.log or we cannot see what went wrong. >>>> >>>> Matt >>>> >>>> >>>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < >>>> christophe.ortiz at ciemat.es> wrote: >>>> >>>>> Hi Dominic and Paul, >>>>> >>>>> Thanks for your answers. Unfortunately, it did not work. Same error >>>>> message related to the thrust directory: >>>>> >>>>> >>>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >>>>> --with-scalar-type=real --with-precision=double --download-fblaslapack >>>>> >>>>> =============================================================================== >>>>> Configuring PETSc to compile on your system >>>>> >>>>> >>>>> =============================================================================== >>>>> TESTING: checkInclude from >>>>> config.headers(config/BuildSystem/config/headers.py:86) >>>>> >>>>> ******************************************************************************* >>>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>>> for details): >>>>> >>>>> ------------------------------------------------------------------------------- >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >>>>> >>>>> ******************************************************************************* >>>>> >>>>> >>>>> I do not see what else to do...I have a standard CUDA installation >>>>> that came with thrust. >>>>> I am using ubuntu 12.04, I do not know if that could help. >>>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >>>>> >>>>> Christophe >>>>> >>>>> >>>>> >>>>> >>>>> >>>>>> ------------------------------ >>>>>> >>>>>> Message: 3 >>>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>>>>> From: Dominic Meiser >>>>>> To: petsc-users at mcs.anl.gov >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>>> Problem with thrust directory >>>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>>>>> Content-Type: text/plain; charset=UTF-8; format=flowed >>>>>> >>>>>> Can you try configuring with >>>>>> >>>>>> --with-thrust-dir=/usr/local/cuda-6.0/include >>>>>> >>>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>>>> the >>>>>> same fix with cusp: >>>>>> >>>>>> --with-cusp-dir=/usr/local/cuda-6.0/include >>>>>> >>>>>> Cheers, >>>>>> Dominic >>>>>> >>>>> >>>>> >>>>> >>>>>> >>>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>>> > Hi all, >>>>>> > >>>>>> > I have implemented a problem of coupled diffusion equations in 1D >>>>>> > using PETSc. I was able to configure PETSC with and without MPI. The >>>>>> > code runs well in both cases. >>>>>> > >>>>>> > Now I would like to test CUDA but I am unable to configure it. I get >>>>>> > an error message related to thrust directory. >>>>>> > >>>>>> > The options I use to configure are the following: >>>>>> > >>>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>>>>> > --with-precision=double --download-f-blas-lapack >>>>>> > >>>>>> > The error message I get is: >>>>>> > >>>>>> > >>>>>> =============================================================================== >>>>>> > Configuring PETSc to compile on your system >>>>>> > >>>>>> =============================================================================== >>>>>> > TESTING: checkInclude from >>>>>> > config.headers(config/BuildSystem/config/headers.py:86) >>>>>> > >>>>>> ******************************************************************************* >>>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>>>> configure.log >>>>>> > for details): >>>>>> > >>>>>> ------------------------------------------------------------------------------- >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>>> > >>>>>> ******************************************************************************* >>>>>> > >>>>>> > >>>>>> > Did I miss something ? >>>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>>> > >>>>>> > Many thanks in advance for your help. >>>>>> > Christophe >>>>>> > >>>>>> >>>>>> >>>>>> -- >>>>>> Dominic Meiser >>>>>> Tech-X Corporation >>>>>> 5621 Arapahoe Avenue >>>>>> Boulder, CO 80303 >>>>>> USA >>>>>> Telephone: 303-996-2036 >>>>>> Fax: 303-448-7756 >>>>>> www.txcorp.com >>>>>> >>>>>> >>>>>> >>>>>> ------------------------------ >>>>>> >>>>>> Message: 4 >>>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>>>>> From: Paul Mullowney >>>>>> To: Dominic Meiser >>>>>> Cc: petsc-users at mcs.anl.gov >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>>> Problem with thrust directory >>>>>> Message-ID: >>>>>> >>>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>>>>> Content-Type: text/plain; charset="utf-8" >>>>>> >>>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>>>>> -Paul >>>>>> >>>>>> >>>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>>>>> wrote: >>>>>> >>>>>> > Can you try configuring with >>>>>> > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>>>>> > >>>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>>>> the >>>>>> > same fix with cusp: >>>>>> > >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>>>>> > >>>>>> > Cheers, >>>>>> > Dominic >>>>>> > >>>>>> > >>>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>>> > >>>>>> >> Hi all, >>>>>> >> >>>>>> >> I have implemented a problem of coupled diffusion equations in 1D >>>>>> using >>>>>> >> PETSc. I was able to configure PETSC with and without MPI. The >>>>>> code runs >>>>>> >> well in both cases. >>>>>> >> >>>>>> >> Now I would like to test CUDA but I am unable to configure it. I >>>>>> get an >>>>>> >> error message related to thrust directory. >>>>>> >> >>>>>> >> The options I use to configure are the following: >>>>>> >> >>>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>>> --download-txpetscgpu=1 >>>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>>>>> >> --download-f-blas-lapack >>>>>> >> >>>>>> >> The error message I get is: >>>>>> >> >>>>>> >> ============================================================ >>>>>> >> =================== >>>>>> >> Configuring PETSc to compile on your system >>>>>> >> ============================================================ >>>>>> >> =================== >>>>>> >> TESTING: checkInclude from config.headers(config/ >>>>>> >> BuildSystem/config/headers.py:86) ****************************** >>>>>> >> ************************************************* >>>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>>>> configure.log for >>>>>> >> details): >>>>>> >> ------------------------------------------------------------ >>>>>> >> ------------------- >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>>> >> ************************************************************ >>>>>> >> ******************* >>>>>> >> >>>>>> >> >>>>>> >> Did I miss something ? >>>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>>> >> >>>>>> >> Many thanks in advance for your help. >>>>>> >> Christophe >>>>>> >> >>>>>> >> >>>>>> > >>>>>> > -- >>>>>> > Dominic Meiser >>>>>> > Tech-X Corporation >>>>>> > 5621 Arapahoe Avenue >>>>>> > Boulder, CO 80303 >>>>>> > USA >>>>>> > Telephone: 303-996-2036 >>>>>> > Fax: 303-448-7756 >>>>>> > www.txcorp.com >>>>>> > >>>>>> > >>>>>> -------------- next part -------------- >>>>>> An HTML attachment was scrubbed... >>>>>> URL: < >>>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>>>>> > >>>>>> >>>>>> ------------------------------ >>>>>> >>>>>> _______________________________________________ >>>>>> petsc-users mailing list >>>>>> petsc-users at mcs.anl.gov >>>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>>>>> >>>>>> >>>>>> End of petsc-users Digest, Vol 68, Issue 63 >>>>>> ******************************************* >>>>>> >>>>>> ---------------------------- >>>>>> Confidencialidad: >>>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>>>>> destrucci?n. >>>>>> >>>>>> Disclaimer: >>>>>> This message and its attached files is intended exclusively for its >>>>>> recipients and may contain confidential information. If you received this >>>>>> e-mail in error you are hereby notified that any dissemination, copy or >>>>>> disclosure of this communication is strictly prohibited and may be >>>>>> unlawful. In this case, please notify us by a reply and delete this email >>>>>> and its contents immediately. >>>>>> ---------------------------- >>>>>> >>>>>> >>>>> >>>> >>>> >>>> -- >>>> What most experimenters take for granted before they begin their >>>> experiments is infinitely more interesting than any results to which their >>>> experiments lead. >>>> -- Norbert Wiener >>>> >>> >>> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> >> >> >> -- >> Dominic Meiser >> Tech-X Corporation >> 5621 Arapahoe Avenue >> Boulder, CO 80303 >> USA >> Telephone: 303-996-2036 >> Fax: 303-448-7756www.txcorp.com >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: From C.Klaij at marin.nl Fri Aug 29 09:42:05 2014 From: C.Klaij at marin.nl (Klaij, Christiaan) Date: Fri, 29 Aug 2014 14:42:05 +0000 Subject: [petsc-users] PCFieldSplitSetSchurPre in fortran In-Reply-To: References: , Message-ID: Matt, The small test code (ex70) is in C and it works fine, the problem happens in a big Fortran code. I will try to replicate the problem in a small Fortran code, but that will take some time. Chris [cid:image49f99d.JPG at 47b8dbea.4cb89460][cid:imagef623f4.JPG at ef0158cd.488b8eaa] dr. ir. Christiaan Klaij CFD Researcher Research & Development MARIN 2, Haagsteeg E C.Klaij at marin.nl P.O. Box 28 T +31 317 49 39 11 6700 AA Wageningen F +31 317 49 32 45 T +31 317 49 33 44 The Netherlands I www.marin.nl MARIN news: Bas Buchner speaker at Lowpex conference at SMM Hamburg This e-mail may be confidential, privileged and/or protected by copyright. If you are not the intended recipient, you should return it to the sender immediately and delete your copy from your system. ________________________________ From: Matthew Knepley Sent: Friday, August 29, 2014 4:14 PM To: Klaij, Christiaan Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] PCFieldSplitSetSchurPre in fortran On Fri, Aug 29, 2014 at 8:55 AM, Klaij, Christiaan > wrote: I'm trying PCFieldSplitSetSchurPre with PC_FIELDSPLIT_SCHUR_PRE_SELFP in petsc-3.5.1 using fortran. The first problem is that PC_FIELDSPLIT_SCHUR_PRE_SELFP seems to be missing in fortran, I get the compile error: This name does not have a type, and must have an explicit type. [PC_FIELDSPLIT_SCHUR_PRE_SELFP] while compilation works fine with _A11, _SELF and _USER. Mark Adams has just fixed this. The second problem is that the call doesn't seem to have any effect. For example, I have CALL PCFieldSplitSetSchurPre(pc,PC_FIELDSPLIT_SCHUR_PRE_USER,aa,ierr) CALL PCFieldSplitSetSchurFactType(pc,PC_FIELDSPLIT_SCHUR_FACT_LOWER,ierr) This compiles and runs, but ksp_view tells me PC Object:(sys_) 3 MPI processes type: fieldsplit FieldSplit with Schur preconditioner, factorization LOWER Preconditioner for the Schur complement formed from A11 So changing the factorization from the default FULL to LOWER did work, but changing the preconditioner from A11 to USER didn't. I've also tried to run directly from the command line using -sys_pc_fieldsplit_schur_precondition user -sys_ksp_view This works in the sense that I don't get the "WARNING! There are options you set that were not used!" message, but still ksp_view reports A11 instead of user provided matrix. Can you send a small test code, since I use this everyday here and it works. Thanks, Matt Chris dr. ir. Christiaan Klaij CFD Researcher Research & Development E mailto:C.Klaij at marin.nl T +31 317 49 33 44 MARIN 2, Haagsteeg, P.O. Box 28, 6700 AA Wageningen, The Netherlands T +31 317 49 39 11, F +31 317 49 32 45, I www.marin.nl -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: image49f99d.JPG Type: image/jpeg Size: 1069 bytes Desc: image49f99d.JPG URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: imagef623f4.JPG Type: image/jpeg Size: 1622 bytes Desc: imagef623f4.JPG URL: From dmeiser at txcorp.com Fri Aug 29 09:53:56 2014 From: dmeiser at txcorp.com (Dominic Meiser) Date: Fri, 29 Aug 2014 08:53:56 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: <54009404.103@txcorp.com> On 08/29/2014 08:31 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > wrote: > > On 08/29/2014 08:08 AM, Matthew Knepley wrote: >> On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz >> > >> wrote: >> >> Sorry about that. >> >> Please find in attachment the configure.log file. Hope it >> will help you find the error. >> >> >> Here is the problem: >> >> Possible ERROR while running preprocessor: nvcc warning : The >> 'compute_10' and 'sm_10' architectures are deprecated, and may be >> removed in a future release. >> error message = {nvcc warning : The 'compute_10' and 'sm_10' >> architectures are deprecated, and may be removed in a future release. >> } >> >> meaning the nvcc compiler does not "work" as provided. Here is a >> workaround: >> >> --with-cudac='nvcc --arch=sm_35' >> >> Dominic, I think that thrust.py should depend on cuda.py. Do you >> know why it does not? > In principle you are right, thrust.py should depend on cuda.py. > > However, in my opinion, thrust.py should go away as a separate > package altogether. Thrust is shipped as part of any recent > version of the cuda toolkit (I forget since which version, Paul > might know) and it's always installed in > $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically > deduct the thrust location from the cuda location. Thrust should > be considered part of cuda. > > > That does not mean the configure modules should be organized that way. > Thrust is a package included in CUDA, thus > it should have an independent module, but depend on the CUDA module. I see your point. If you keep thrust as a module it should definitely depend on cuda. Default guesses for its location should then be generated based on the cuda location. I can work on this. Dominic > > Matt > > Cheers, > Dominic > >> >> Thanks, >> >> Matt >> >> Christophe >> >> CIEMAT >> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico >> Unidad de Materiales >> Edificio 2 - Planta 0 - Despacho 28m >> Avenida Complutense 40, >> 28040 Madrid, Spain >> Tel: +34 91496 2582 >> Fax: +34 91346 6442 >> >> -- >> Q >> Por favor, piense en el medio ambiente antes de imprimir este >> mensaje. >> Please consider the environment before printing this email. >> >> >> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley >> > wrote: >> >> Always attach configure.log or we cannot see what went >> wrong. >> >> Matt >> >> >> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz >> > > wrote: >> >> Hi Dominic and Paul, >> >> Thanks for your answers. Unfortunately, it did not >> work. Same error message related to the thrust directory: >> >> >> ./configure --with-x=1 --with-mpi=0 --with-cc=icc >> --with-cxx=icpc --with-clanguage=cxx --with-fc=ifort >> --with-cuda=1 --with-cuda-dir=/usr/local/cuda-6.0 >> --with-cuda-arch=sm_35 --with-thrust=1 >> --with-thrust-dir=/usr/local/cuda-6.0/include >> --with-cusp=1 >> --with-cusp-dir=/usr/local/cuda-6.0/include >> --with-debugging=1 --with-scalar-type=real >> --with-precision=double --download-fblaslapack >> =============================================================================== >> Configuring PETSc to compile on your system >> =============================================================================== >> TESTING: checkInclude from >> config.headers(config/BuildSystem/config/headers.py:86) >> ******************************************************************************* >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >> configure.log for details): >> ------------------------------------------------------------------------------- >> --with-thrust-dir=/usr/local/cuda-6.0/include did not >> work >> ******************************************************************************* >> >> >> I do not see what else to do...I have a standard CUDA >> installation that came with thrust. >> I am using ubuntu 12.04, I do not know if that could >> help. >> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >> >> Christophe >> >> >> >> ------------------------------ >> >> Message: 3 >> Date: Thu, 28 Aug 2014 08:38:12 -0600 >> From: Dominic Meiser > > >> To: petsc-users at mcs.anl.gov >> >> Subject: Re: [petsc-users] Unable to configure >> PETSc with CUDA: >> Problem with thrust directory >> Message-ID: <53FF3ED4.1090002 at txcorp.com >> > >> Content-Type: text/plain; charset=UTF-8; >> format=flowed >> >> Can you try configuring with >> >> --with-thrust-dir=/usr/local/cuda-6.0/include >> >> I.e. omit the 'thrust' at the end of the path. >> Probably you'll need the >> same fix with cusp: >> >> --with-cusp-dir=/usr/local/cuda-6.0/include >> >> Cheers, >> Dominic >> >> >> >> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >> > Hi all, >> > >> > I have implemented a problem of coupled >> diffusion equations in 1D >> > using PETSc. I was able to configure PETSC with >> and without MPI. The >> > code runs well in both cases. >> > >> > Now I would like to test CUDA but I am unable >> to configure it. I get >> > an error message related to thrust directory. >> > >> > The options I use to configure are the following: >> > >> > --with-x=1 --with-mpi=0 --with-cc=icc >> --with-cxx=icpc >> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> > --with-cuda-dir=/usr/local/cuda-6.0 >> --with-cuda-arch=sm_35 >> > --with-cudac=/usr/local/cuda/bin/nvcc >> --with-thrust=1 >> > >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust >> --with-cusp=1 >> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >> > --download-txpetscgpu=1 --with-debugging=1 >> --with-scalar-type=real >> > --with-precision=double --download-f-blas-lapack >> > >> > The error message I get is: >> > >> > >> =============================================================================== >> > Configuring PETSc to compile on your system >> > >> =============================================================================== >> > TESTING: checkInclude from >> > >> config.headers(config/BuildSystem/config/headers.py:86) >> > >> ******************************************************************************* >> > UNABLE to CONFIGURE with GIVEN OPTIONS (see >> configure.log >> > for details): >> > >> ------------------------------------------------------------------------------- >> > >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust >> did not work >> > >> ******************************************************************************* >> > >> > >> > Did I miss something ? >> > My GPU is a GeForce Titan Black and I am using >> CUDA 6.0. >> > >> > Many thanks in advance for your help. >> > Christophe >> > >> >> >> -- >> Dominic Meiser >> Tech-X Corporation >> 5621 Arapahoe Avenue >> Boulder, CO 80303 >> USA >> Telephone: 303-996-2036 >> Fax: 303-448-7756 >> www.txcorp.com >> >> >> >> ------------------------------ >> >> Message: 4 >> Date: Thu, 28 Aug 2014 08:30:40 -0600 >> From: Paul Mullowney > > >> To: Dominic Meiser > > >> Cc: petsc-users at mcs.anl.gov >> >> Subject: Re: [petsc-users] Unable to configure >> PETSc with CUDA: >> Problem with thrust directory >> Message-ID: >> > > >> Content-Type: text/plain; charset="utf-8" >> >> Also, get rid of --download-txpetscgpu=1. That >> doesn't exist anymore. >> -Paul >> >> >> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >> > >> wrote: >> >> > Can you try configuring with >> > >> > --with-thrust-dir=/usr/local/cuda-6.0/include >> > >> > I.e. omit the 'thrust' at the end of the path. >> Probably you'll need the >> > same fix with cusp: >> > >> > --with-cusp-dir=/usr/local/cuda-6.0/include >> > >> > Cheers, >> > Dominic >> > >> > >> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >> > >> >> Hi all, >> >> >> >> I have implemented a problem of coupled >> diffusion equations in 1D using >> >> PETSc. I was able to configure PETSC with and >> without MPI. The code runs >> >> well in both cases. >> >> >> >> Now I would like to test CUDA but I am unable >> to configure it. I get an >> >> error message related to thrust directory. >> >> >> >> The options I use to configure are the following: >> >> >> >> --with-x=1 --with-mpi=0 --with-cc=icc >> --with-cxx=icpc >> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> >> --with-cuda-dir=/usr/local/cuda-6.0 >> --with-cuda-arch=sm_35 >> >> --with-cudac=/usr/local/cuda/bin/nvcc >> --with-thrust=1 >> >> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust >> --with-cusp=1 >> >> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >> --download-txpetscgpu=1 >> >> --with-debugging=1 --with-scalar-type=real >> --with-precision=double >> >> --download-f-blas-lapack >> >> >> >> The error message I get is: >> >> >> >> >> ============================================================ >> >> =================== >> >> Configuring PETSc to compile on your system >> >> >> ============================================================ >> >> =================== >> >> TESTING: checkInclude from config.headers(config/ >> >> BuildSystem/config/headers.py:86) >> ****************************** >> >> ************************************************* >> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >> configure.log for >> >> details): >> >> >> ------------------------------------------------------------ >> >> ------------------- >> >> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust >> did not work >> >> >> ************************************************************ >> >> ******************* >> >> >> >> >> >> Did I miss something ? >> >> My GPU is a GeForce Titan Black and I am using >> CUDA 6.0. >> >> >> >> Many thanks in advance for your help. >> >> Christophe >> >> >> >> >> > >> > -- >> > Dominic Meiser >> > Tech-X Corporation >> > 5621 Arapahoe Avenue >> > Boulder, CO 80303 >> > USA >> > Telephone: 303-996-2036 >> > Fax: 303-448-7756 >> > www.txcorp.com >> > >> > >> -------------- next part -------------- >> An HTML attachment was scrubbed... >> URL: >> >> >> ------------------------------ >> >> _______________________________________________ >> petsc-users mailing list >> petsc-users at mcs.anl.gov >> >> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >> >> >> End of petsc-users Digest, Vol 68, Issue 63 >> ******************************************* >> >> ---------------------------- >> Confidencialidad: >> Este mensaje y sus ficheros adjuntos se dirige >> exclusivamente a su destinatario y puede contener >> informaci?n privilegiada o confidencial. Si no es >> vd. el destinatario indicado, queda notificado de >> que la utilizaci?n, divulgaci?n y/o copia sin >> autorizaci?n est? prohibida en virtud de la >> legislaci?n vigente. Si ha recibido este mensaje >> por error, le rogamos que nos lo comunique >> inmediatamente respondiendo al mensaje y proceda >> a su destrucci?n. >> >> Disclaimer: >> This message and its attached files is intended >> exclusively for its recipients and may contain >> confidential information. If you received this >> e-mail in error you are hereby notified that any >> dissemination, copy or disclosure of this >> communication is strictly prohibited and may be >> unlawful. In this case, please notify us by a >> reply and delete this email and its contents >> immediately. >> ---------------------------- >> >> >> >> >> >> -- >> What most experimenters take for granted before they >> begin their experiments is infinitely more interesting >> than any results to which their experiments lead. >> -- Norbert Wiener >> >> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to >> which their experiments lead. >> -- Norbert Wiener > > > -- > Dominic Meiser > Tech-X Corporation > 5621 Arapahoe Avenue > Boulder, CO 80303 > USA > Telephone:303-996-2036 > Fax:303-448-7756 > www.txcorp.com > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener -- Dominic Meiser Tech-X Corporation 5621 Arapahoe Avenue Boulder, CO 80303 USA Telephone: 303-996-2036 Fax: 303-448-7756 www.txcorp.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From christophe.ortiz at ciemat.es Fri Aug 29 08:35:18 2014 From: christophe.ortiz at ciemat.es (Christophe Ortiz) Date: Fri, 29 Aug 2014 15:35:18 +0200 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: Sorry about that. Please find in attachment the configure.log file. Hope it will help you find the error. Christophe CIEMAT Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico Unidad de Materiales Edificio 2 - Planta 0 - Despacho 28m Avenida Complutense 40, 28040 Madrid, Spain Tel: +34 91496 2582 Fax: +34 91346 6442 -- Q Por favor, piense en el medio ambiente antes de imprimir este mensaje. Please consider the environment before printing this email. On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley wrote: > Always attach configure.log or we cannot see what went wrong. > > Matt > > > On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < > christophe.ortiz at ciemat.es> wrote: > >> Hi Dominic and Paul, >> >> Thanks for your answers. Unfortunately, it did not work. Same error >> message related to the thrust directory: >> >> >> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >> --with-scalar-type=real --with-precision=double --download-fblaslapack >> >> =============================================================================== >> Configuring PETSc to compile on your system >> >> >> =============================================================================== >> TESTING: checkInclude from >> config.headers(config/BuildSystem/config/headers.py:86) >> >> ******************************************************************************* >> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for >> details): >> >> ------------------------------------------------------------------------------- >> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >> >> ******************************************************************************* >> >> >> I do not see what else to do...I have a standard CUDA installation that >> came with thrust. >> I am using ubuntu 12.04, I do not know if that could help. >> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >> >> Christophe >> >> >> >> >> >>> ------------------------------ >>> >>> Message: 3 >>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>> From: Dominic Meiser >>> To: petsc-users at mcs.anl.gov >>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>> Problem with thrust directory >>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>> Content-Type: text/plain; charset=UTF-8; format=flowed >>> >>> Can you try configuring with >>> >>> --with-thrust-dir=/usr/local/cuda-6.0/include >>> >>> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>> same fix with cusp: >>> >>> --with-cusp-dir=/usr/local/cuda-6.0/include >>> >>> Cheers, >>> Dominic >>> >> >> >> >>> >>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>> > Hi all, >>> > >>> > I have implemented a problem of coupled diffusion equations in 1D >>> > using PETSc. I was able to configure PETSC with and without MPI. The >>> > code runs well in both cases. >>> > >>> > Now I would like to test CUDA but I am unable to configure it. I get >>> > an error message related to thrust directory. >>> > >>> > The options I use to configure are the following: >>> > >>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>> > --with-precision=double --download-f-blas-lapack >>> > >>> > The error message I get is: >>> > >>> > >>> =============================================================================== >>> > Configuring PETSc to compile on your system >>> > >>> =============================================================================== >>> > TESTING: checkInclude from >>> > config.headers(config/BuildSystem/config/headers.py:86) >>> > >>> ******************************************************************************* >>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>> > for details): >>> > >>> ------------------------------------------------------------------------------- >>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>> > >>> ******************************************************************************* >>> > >>> > >>> > Did I miss something ? >>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>> > >>> > Many thanks in advance for your help. >>> > Christophe >>> > >>> >>> >>> -- >>> Dominic Meiser >>> Tech-X Corporation >>> 5621 Arapahoe Avenue >>> Boulder, CO 80303 >>> USA >>> Telephone: 303-996-2036 >>> Fax: 303-448-7756 >>> www.txcorp.com >>> >>> >>> >>> ------------------------------ >>> >>> Message: 4 >>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>> From: Paul Mullowney >>> To: Dominic Meiser >>> Cc: petsc-users at mcs.anl.gov >>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>> Problem with thrust directory >>> Message-ID: >>> >> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>> Content-Type: text/plain; charset="utf-8" >>> >>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>> -Paul >>> >>> >>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>> wrote: >>> >>> > Can you try configuring with >>> > >>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>> > >>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>> > same fix with cusp: >>> > >>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>> > >>> > Cheers, >>> > Dominic >>> > >>> > >>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>> > >>> >> Hi all, >>> >> >>> >> I have implemented a problem of coupled diffusion equations in 1D >>> using >>> >> PETSc. I was able to configure PETSC with and without MPI. The code >>> runs >>> >> well in both cases. >>> >> >>> >> Now I would like to test CUDA but I am unable to configure it. I get >>> an >>> >> error message related to thrust directory. >>> >> >>> >> The options I use to configure are the following: >>> >> >>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>> --download-txpetscgpu=1 >>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>> >> --download-f-blas-lapack >>> >> >>> >> The error message I get is: >>> >> >>> >> ============================================================ >>> >> =================== >>> >> Configuring PETSc to compile on your system >>> >> ============================================================ >>> >> =================== >>> >> TESTING: checkInclude from config.headers(config/ >>> >> BuildSystem/config/headers.py:86) ****************************** >>> >> ************************************************* >>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>> for >>> >> details): >>> >> ------------------------------------------------------------ >>> >> ------------------- >>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>> >> ************************************************************ >>> >> ******************* >>> >> >>> >> >>> >> Did I miss something ? >>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>> >> >>> >> Many thanks in advance for your help. >>> >> Christophe >>> >> >>> >> >>> > >>> > -- >>> > Dominic Meiser >>> > Tech-X Corporation >>> > 5621 Arapahoe Avenue >>> > Boulder, CO 80303 >>> > USA >>> > Telephone: 303-996-2036 >>> > Fax: 303-448-7756 >>> > www.txcorp.com >>> > >>> > >>> -------------- next part -------------- >>> An HTML attachment was scrubbed... >>> URL: < >>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>> > >>> >>> ------------------------------ >>> >>> _______________________________________________ >>> petsc-users mailing list >>> petsc-users at mcs.anl.gov >>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>> >>> >>> End of petsc-users Digest, Vol 68, Issue 63 >>> ******************************************* >>> >>> ---------------------------- >>> Confidencialidad: >>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>> destrucci?n. >>> >>> Disclaimer: >>> This message and its attached files is intended exclusively for its >>> recipients and may contain confidential information. If you received this >>> e-mail in error you are hereby notified that any dissemination, copy or >>> disclosure of this communication is strictly prohibited and may be >>> unlawful. In this case, please notify us by a reply and delete this email >>> and its contents immediately. >>> ---------------------------- >>> >>> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 4264725 bytes Desc: not available URL: From ashwinsrnth at gmail.com Fri Aug 29 09:24:26 2014 From: ashwinsrnth at gmail.com (Ashwin Srinath) Date: Fri, 29 Aug 2014 10:24:26 -0400 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: I'm having a similar issue with CUDA 6.0. Attached is my configure.log. PETSc built fine with an older version of CUDA toolkit (5.0). I suspect that theres a bug in cuda.py. But I can't be sure. Any suggestions? Ashwin On Fri, Aug 29, 2014 at 10:08 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < > christophe.ortiz at ciemat.es> wrote: > >> Sorry about that. >> >> Please find in attachment the configure.log file. Hope it will help you >> find the error. >> > > Here is the problem: > > Possible ERROR while running preprocessor: nvcc warning : The 'compute_10' > and 'sm_10' architectures are deprecated, and may be removed in a future > release. > error message = {nvcc warning : The 'compute_10' and 'sm_10' architectures > are deprecated, and may be removed in a future release. > } > > meaning the nvcc compiler does not "work" as provided. Here is a > workaround: > > --with-cudac='nvcc --arch=sm_35' > > Dominic, I think that thrust.py should depend on cuda.py. Do you know why > it does not? > > Thanks, > > Matt > > > >> Christophe >> >> CIEMAT >> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico >> Unidad de Materiales >> Edificio 2 - Planta 0 - Despacho 28m >> Avenida Complutense 40, >> 28040 Madrid, Spain >> Tel: +34 91496 2582 >> Fax: +34 91346 6442 >> >> -- >> Q >> Por favor, piense en el medio ambiente antes de imprimir este mensaje. >> Please consider the environment before printing this email. >> >> >> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley >> wrote: >> >>> Always attach configure.log or we cannot see what went wrong. >>> >>> Matt >>> >>> >>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < >>> christophe.ortiz at ciemat.es> wrote: >>> >>>> Hi Dominic and Paul, >>>> >>>> Thanks for your answers. Unfortunately, it did not work. Same error >>>> message related to the thrust directory: >>>> >>>> >>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 >>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 >>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 >>>> --with-scalar-type=real --with-precision=double --download-fblaslapack >>>> >>>> =============================================================================== >>>> Configuring PETSc to compile on your system >>>> >>>> >>>> =============================================================================== >>>> TESTING: checkInclude from >>>> config.headers(config/BuildSystem/config/headers.py:86) >>>> >>>> ******************************************************************************* >>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>> for details): >>>> >>>> ------------------------------------------------------------------------------- >>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work >>>> >>>> ******************************************************************************* >>>> >>>> >>>> I do not see what else to do...I have a standard CUDA installation that >>>> came with thrust. >>>> I am using ubuntu 12.04, I do not know if that could help. >>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. >>>> >>>> Christophe >>>> >>>> >>>> >>>> >>>> >>>>> ------------------------------ >>>>> >>>>> Message: 3 >>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 >>>>> From: Dominic Meiser >>>>> To: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> >>>>> Content-Type: text/plain; charset=UTF-8; format=flowed >>>>> >>>>> Can you try configuring with >>>>> >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> >>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need the >>>>> same fix with cusp: >>>>> >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> >>>>> Cheers, >>>>> Dominic >>>>> >>>> >>>> >>>> >>>>> >>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > Hi all, >>>>> > >>>>> > I have implemented a problem of coupled diffusion equations in 1D >>>>> > using PETSc. I was able to configure PETSC with and without MPI. The >>>>> > code runs well in both cases. >>>>> > >>>>> > Now I would like to test CUDA but I am unable to configure it. I get >>>>> > an error message related to thrust directory. >>>>> > >>>>> > The options I use to configure are the following: >>>>> > >>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real >>>>> > --with-precision=double --download-f-blas-lapack >>>>> > >>>>> > The error message I get is: >>>>> > >>>>> > >>>>> =============================================================================== >>>>> > Configuring PETSc to compile on your system >>>>> > >>>>> =============================================================================== >>>>> > TESTING: checkInclude from >>>>> > config.headers(config/BuildSystem/config/headers.py:86) >>>>> > >>>>> ******************************************************************************* >>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log >>>>> > for details): >>>>> > >>>>> ------------------------------------------------------------------------------- >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> > >>>>> ******************************************************************************* >>>>> > >>>>> > >>>>> > Did I miss something ? >>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> > >>>>> > Many thanks in advance for your help. >>>>> > Christophe >>>>> > >>>>> >>>>> >>>>> -- >>>>> Dominic Meiser >>>>> Tech-X Corporation >>>>> 5621 Arapahoe Avenue >>>>> Boulder, CO 80303 >>>>> USA >>>>> Telephone: 303-996-2036 >>>>> Fax: 303-448-7756 >>>>> www.txcorp.com >>>>> >>>>> >>>>> >>>>> ------------------------------ >>>>> >>>>> Message: 4 >>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 >>>>> From: Paul Mullowney >>>>> To: Dominic Meiser >>>>> Cc: petsc-users at mcs.anl.gov >>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: >>>>> Problem with thrust directory >>>>> Message-ID: >>>>> >>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> >>>>> Content-Type: text/plain; charset="utf-8" >>>>> >>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. >>>>> -Paul >>>>> >>>>> >>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser >>>>> wrote: >>>>> >>>>> > Can you try configuring with >>>>> > >>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need >>>>> the >>>>> > same fix with cusp: >>>>> > >>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include >>>>> > >>>>> > Cheers, >>>>> > Dominic >>>>> > >>>>> > >>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: >>>>> > >>>>> >> Hi all, >>>>> >> >>>>> >> I have implemented a problem of coupled diffusion equations in 1D >>>>> using >>>>> >> PETSc. I was able to configure PETSC with and without MPI. The code >>>>> runs >>>>> >> well in both cases. >>>>> >> >>>>> >> Now I would like to test CUDA but I am unable to configure it. I >>>>> get an >>>>> >> error message related to thrust directory. >>>>> >> >>>>> >> The options I use to configure are the following: >>>>> >> >>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc >>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 >>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 >>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 >>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp >>>>> --download-txpetscgpu=1 >>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double >>>>> >> --download-f-blas-lapack >>>>> >> >>>>> >> The error message I get is: >>>>> >> >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> Configuring PETSc to compile on your system >>>>> >> ============================================================ >>>>> >> =================== >>>>> >> TESTING: checkInclude from config.headers(config/ >>>>> >> BuildSystem/config/headers.py:86) ****************************** >>>>> >> ************************************************* >>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see >>>>> configure.log for >>>>> >> details): >>>>> >> ------------------------------------------------------------ >>>>> >> ------------------- >>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work >>>>> >> ************************************************************ >>>>> >> ******************* >>>>> >> >>>>> >> >>>>> >> Did I miss something ? >>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. >>>>> >> >>>>> >> Many thanks in advance for your help. >>>>> >> Christophe >>>>> >> >>>>> >> >>>>> > >>>>> > -- >>>>> > Dominic Meiser >>>>> > Tech-X Corporation >>>>> > 5621 Arapahoe Avenue >>>>> > Boulder, CO 80303 >>>>> > USA >>>>> > Telephone: 303-996-2036 >>>>> > Fax: 303-448-7756 >>>>> > www.txcorp.com >>>>> > >>>>> > >>>>> -------------- next part -------------- >>>>> An HTML attachment was scrubbed... >>>>> URL: < >>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html >>>>> > >>>>> >>>>> ------------------------------ >>>>> >>>>> _______________________________________________ >>>>> petsc-users mailing list >>>>> petsc-users at mcs.anl.gov >>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users >>>>> >>>>> >>>>> End of petsc-users Digest, Vol 68, Issue 63 >>>>> ******************************************* >>>>> >>>>> ---------------------------- >>>>> Confidencialidad: >>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su >>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si >>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, >>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la >>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que >>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su >>>>> destrucci?n. >>>>> >>>>> Disclaimer: >>>>> This message and its attached files is intended exclusively for its >>>>> recipients and may contain confidential information. If you received this >>>>> e-mail in error you are hereby notified that any dissemination, copy or >>>>> disclosure of this communication is strictly prohibited and may be >>>>> unlawful. In this case, please notify us by a reply and delete this email >>>>> and its contents immediately. >>>>> ---------------------------- >>>>> >>>>> >>>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their >>> experiments is infinitely more interesting than any results to which their >>> experiments lead. >>> -- Norbert Wiener >>> >> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 5347822 bytes Desc: not available URL: From balay at mcs.anl.gov Fri Aug 29 10:07:07 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:07:07 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: Message-ID: On Fri, 29 Aug 2014, Matthew Knepley wrote: > Here is the problem: > > Possible ERROR while running preprocessor: nvcc warning : The 'compute_10' > and 'sm_10' architectures are deprecated, and may be removed in a future > release. > error message = {nvcc warning : The 'compute_10' and 'sm_10' architectures > are deprecated, and may be removed in a future release. > } > > meaning the nvcc compiler does not "work" as provided. Here is a workaround: > > --with-cudac='nvcc --arch=sm_35' This workarround conflicts with --with-cuda-arch option. Karl already has a fix for this issue. https://bitbucket.org/petsc/petsc/commits/e9877ee643984bf84c6f846bc31b03e417173602 > > I forgot to mention that I am using PETSc 3.4.1. cuda stuff is supporsed to be disabled in petsc releases - and we recommend using only petsc development (master) branch for it. Satish From balay at mcs.anl.gov Fri Aug 29 10:11:31 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:11:31 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: <54009404.103@txcorp.com> References: <54008FCD.4030604@txcorp.com> <54009404.103@txcorp.com> Message-ID: On Fri, 29 Aug 2014, Dominic Meiser wrote: > On 08/29/2014 08:31 AM, Matthew Knepley wrote: > > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > > wrote: > > > Dominic, I think that thrust.py should depend on cuda.py. Do you > > > know why it does not? > > In principle you are right, thrust.py should depend on cuda.py. > > > > However, in my opinion, thrust.py should go away as a separate > > package altogether. Thrust is shipped as part of any recent > > version of the cuda toolkit (I forget since which version, Paul > > might know) and it's always installed in > > $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically > > deduct the thrust location from the cuda location. Thrust should > > be considered part of cuda. I also think it should be removed. > > That does not mean the configure modules should be organized that way. > > Thrust is a package included in CUDA, thus > > it should have an independent module, but depend on the CUDA module. Its fine for configure to have thrust tests [and organize it appropriately] But I think the options --with-thrust-dir--with-thrust-include etc should be removed. We require a minimum version of cuda anyway The primay loss of functionality is - user can't override default thrust with a prefered version. But should we be supporting such a thing anyway? [it might not be compatible with the given cuda?] Satish > I see your point. If you keep thrust as a module it should definitely depend > on cuda. Default guesses for its location should then be generated based on > the cuda location. I can work on this. From balay at mcs.anl.gov Fri Aug 29 10:12:42 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:12:42 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: On Fri, 29 Aug 2014, Ashwin Srinath wrote: > Hello, > > My original message is awaiting approval as attaching configure.log made it > too large. I hope mailman has an option to automatically compress large atachments - but until then - its best to compress big attachments before posting to mailing lists. Satish From balay at mcs.anl.gov Fri Aug 29 10:26:43 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:26:43 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: #define PETSC_VERSION_GIT "v3.5.1-1951-g15ac067" Hm - you are using recent petsc master - and it stills broken... Perhaps Karl will check.. Perhaps we should process --with-cuda-arch in setCompilers.py - and not cuda.py.. [but then - there is a dependency on precision..] Satish On Fri, 29 Aug 2014, Ashwin Srinath wrote: > Hello, > > My original message is awaiting approval as attaching configure.log made it > too large. I hope it's okay for me to repeat here: > > I'm having a similar issue with CUDA 6.0. PETSc configured just fine with > version 5.0 and 5.5, and I'm using an almost identical configure command > (only changing --with-cuda-dir). I get the following error: > > CUDA version error: PETSC currently requires CUDA version 4.0 or higher - > when compiling with CUDA > > I suspect the problem might be with cuda.py checking for my CUDA version, > but I can't be sure. > > Any suggestions? > > > Thanks, > Ashwin > > > On Fri, Aug 29, 2014 at 10:31 AM, Matthew Knepley wrote: > > > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > > wrote: > > > >> On 08/29/2014 08:08 AM, Matthew Knepley wrote: > >> > >> On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < > >> christophe.ortiz at ciemat.es> wrote: > >> > >>> Sorry about that. > >>> > >>> Please find in attachment the configure.log file. Hope it will help > >>> you find the error. > >>> > >> > >> Here is the problem: > >> > >> Possible ERROR while running preprocessor: nvcc warning : The > >> 'compute_10' and 'sm_10' architectures are deprecated, and may be removed > >> in a future release. > >> error message = {nvcc warning : The 'compute_10' and 'sm_10' > >> architectures are deprecated, and may be removed in a future release. > >> } > >> > >> meaning the nvcc compiler does not "work" as provided. Here is a > >> workaround: > >> > >> --with-cudac='nvcc --arch=sm_35' > >> > >> Dominic, I think that thrust.py should depend on cuda.py. Do you know > >> why it does not? > >> > >> In principle you are right, thrust.py should depend on cuda.py. > >> > >> However, in my opinion, thrust.py should go away as a separate package > >> altogether. Thrust is shipped as part of any recent version of the cuda > >> toolkit (I forget since which version, Paul might know) and it's always > >> installed in $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically > >> deduct the thrust location from the cuda location. Thrust should be > >> considered part of cuda. > >> > > > > That does not mean the configure modules should be organized that way. > > Thrust is a package included in CUDA, thus > > it should have an independent module, but depend on the CUDA module. > > > > Matt > > > > > >> Cheers, > >> Dominic > >> > >> > >> Thanks, > >> > >> Matt > >> > >> > >> > >>> Christophe > >>> > >>> CIEMAT > >>> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico > >>> Unidad de Materiales > >>> Edificio 2 - Planta 0 - Despacho 28m > >>> Avenida Complutense 40, > >>> 28040 Madrid, Spain > >>> Tel: +34 91496 2582 <%2B34%2091496%202582> > >>> Fax: +34 91346 6442 <%2B34%2091346%206442> > >>> > >>> -- > >>> Q > >>> Por favor, piense en el medio ambiente antes de imprimir este mensaje. > >>> Please consider the environment before printing this email. > >>> > >>> > >>> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley > >>> wrote: > >>> > >>>> Always attach configure.log or we cannot see what went wrong. > >>>> > >>>> Matt > >>>> > >>>> > >>>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < > >>>> christophe.ortiz at ciemat.es> wrote: > >>>> > >>>>> Hi Dominic and Paul, > >>>>> > >>>>> Thanks for your answers. Unfortunately, it did not work. Same error > >>>>> message related to the thrust directory: > >>>>> > >>>>> > >>>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > >>>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > >>>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 > >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 > >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 > >>>>> --with-scalar-type=real --with-precision=double --download-fblaslapack > >>>>> > >>>>> =============================================================================== > >>>>> Configuring PETSc to compile on your system > >>>>> > >>>>> > >>>>> =============================================================================== > >>>>> TESTING: checkInclude from > >>>>> config.headers(config/BuildSystem/config/headers.py:86) > >>>>> > >>>>> ******************************************************************************* > >>>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > >>>>> for details): > >>>>> > >>>>> ------------------------------------------------------------------------------- > >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work > >>>>> > >>>>> ******************************************************************************* > >>>>> > >>>>> > >>>>> I do not see what else to do...I have a standard CUDA installation > >>>>> that came with thrust. > >>>>> I am using ubuntu 12.04, I do not know if that could help. > >>>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. > >>>>> > >>>>> Christophe > >>>>> > >>>>> > >>>>> > >>>>> > >>>>> > >>>>>> ------------------------------ > >>>>>> > >>>>>> Message: 3 > >>>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 > >>>>>> From: Dominic Meiser > >>>>>> To: petsc-users at mcs.anl.gov > >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > >>>>>> Problem with thrust directory > >>>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> > >>>>>> Content-Type: text/plain; charset=UTF-8; format=flowed > >>>>>> > >>>>>> Can you try configuring with > >>>>>> > >>>>>> --with-thrust-dir=/usr/local/cuda-6.0/include > >>>>>> > >>>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need > >>>>>> the > >>>>>> same fix with cusp: > >>>>>> > >>>>>> --with-cusp-dir=/usr/local/cuda-6.0/include > >>>>>> > >>>>>> Cheers, > >>>>>> Dominic > >>>>>> > >>>>> > >>>>> > >>>>> > >>>>>> > >>>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > >>>>>> > Hi all, > >>>>>> > > >>>>>> > I have implemented a problem of coupled diffusion equations in 1D > >>>>>> > using PETSc. I was able to configure PETSC with and without MPI. The > >>>>>> > code runs well in both cases. > >>>>>> > > >>>>>> > Now I would like to test CUDA but I am unable to configure it. I get > >>>>>> > an error message related to thrust directory. > >>>>>> > > >>>>>> > The options I use to configure are the following: > >>>>>> > > >>>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > >>>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > >>>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > >>>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > >>>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real > >>>>>> > --with-precision=double --download-f-blas-lapack > >>>>>> > > >>>>>> > The error message I get is: > >>>>>> > > >>>>>> > > >>>>>> =============================================================================== > >>>>>> > Configuring PETSc to compile on your system > >>>>>> > > >>>>>> =============================================================================== > >>>>>> > TESTING: checkInclude from > >>>>>> > config.headers(config/BuildSystem/config/headers.py:86) > >>>>>> > > >>>>>> ******************************************************************************* > >>>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see > >>>>>> configure.log > >>>>>> > for details): > >>>>>> > > >>>>>> ------------------------------------------------------------------------------- > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > >>>>>> > > >>>>>> ******************************************************************************* > >>>>>> > > >>>>>> > > >>>>>> > Did I miss something ? > >>>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > >>>>>> > > >>>>>> > Many thanks in advance for your help. > >>>>>> > Christophe > >>>>>> > > >>>>>> > >>>>>> > >>>>>> -- > >>>>>> Dominic Meiser > >>>>>> Tech-X Corporation > >>>>>> 5621 Arapahoe Avenue > >>>>>> Boulder, CO 80303 > >>>>>> USA > >>>>>> Telephone: 303-996-2036 > >>>>>> Fax: 303-448-7756 > >>>>>> www.txcorp.com > >>>>>> > >>>>>> > >>>>>> > >>>>>> ------------------------------ > >>>>>> > >>>>>> Message: 4 > >>>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 > >>>>>> From: Paul Mullowney > >>>>>> To: Dominic Meiser > >>>>>> Cc: petsc-users at mcs.anl.gov > >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > >>>>>> Problem with thrust directory > >>>>>> Message-ID: > >>>>>> >>>>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> > >>>>>> Content-Type: text/plain; charset="utf-8" > >>>>>> > >>>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. > >>>>>> -Paul > >>>>>> > >>>>>> > >>>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser > >>>>>> wrote: > >>>>>> > >>>>>> > Can you try configuring with > >>>>>> > > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include > >>>>>> > > >>>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need > >>>>>> the > >>>>>> > same fix with cusp: > >>>>>> > > >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include > >>>>>> > > >>>>>> > Cheers, > >>>>>> > Dominic > >>>>>> > > >>>>>> > > >>>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > >>>>>> > > >>>>>> >> Hi all, > >>>>>> >> > >>>>>> >> I have implemented a problem of coupled diffusion equations in 1D > >>>>>> using > >>>>>> >> PETSc. I was able to configure PETSC with and without MPI. The > >>>>>> code runs > >>>>>> >> well in both cases. > >>>>>> >> > >>>>>> >> Now I would like to test CUDA but I am unable to configure it. I > >>>>>> get an > >>>>>> >> error message related to thrust directory. > >>>>>> >> > >>>>>> >> The options I use to configure are the following: > >>>>>> >> > >>>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > >>>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > >>>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > >>>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > >>>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > >>>>>> --download-txpetscgpu=1 > >>>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double > >>>>>> >> --download-f-blas-lapack > >>>>>> >> > >>>>>> >> The error message I get is: > >>>>>> >> > >>>>>> >> ============================================================ > >>>>>> >> =================== > >>>>>> >> Configuring PETSc to compile on your system > >>>>>> >> ============================================================ > >>>>>> >> =================== > >>>>>> >> TESTING: checkInclude from config.headers(config/ > >>>>>> >> BuildSystem/config/headers.py:86) ****************************** > >>>>>> >> ************************************************* > >>>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see > >>>>>> configure.log for > >>>>>> >> details): > >>>>>> >> ------------------------------------------------------------ > >>>>>> >> ------------------- > >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > >>>>>> >> ************************************************************ > >>>>>> >> ******************* > >>>>>> >> > >>>>>> >> > >>>>>> >> Did I miss something ? > >>>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. > >>>>>> >> > >>>>>> >> Many thanks in advance for your help. > >>>>>> >> Christophe > >>>>>> >> > >>>>>> >> > >>>>>> > > >>>>>> > -- > >>>>>> > Dominic Meiser > >>>>>> > Tech-X Corporation > >>>>>> > 5621 Arapahoe Avenue > >>>>>> > Boulder, CO 80303 > >>>>>> > USA > >>>>>> > Telephone: 303-996-2036 > >>>>>> > Fax: 303-448-7756 > >>>>>> > www.txcorp.com > >>>>>> > > >>>>>> > > >>>>>> -------------- next part -------------- > >>>>>> An HTML attachment was scrubbed... > >>>>>> URL: < > >>>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html > >>>>>> > > >>>>>> > >>>>>> ------------------------------ > >>>>>> > >>>>>> _______________________________________________ > >>>>>> petsc-users mailing list > >>>>>> petsc-users at mcs.anl.gov > >>>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users > >>>>>> > >>>>>> > >>>>>> End of petsc-users Digest, Vol 68, Issue 63 > >>>>>> ******************************************* > >>>>>> > >>>>>> ---------------------------- > >>>>>> Confidencialidad: > >>>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su > >>>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si > >>>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, > >>>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la > >>>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que > >>>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su > >>>>>> destrucci?n. > >>>>>> > >>>>>> Disclaimer: > >>>>>> This message and its attached files is intended exclusively for its > >>>>>> recipients and may contain confidential information. If you received this > >>>>>> e-mail in error you are hereby notified that any dissemination, copy or > >>>>>> disclosure of this communication is strictly prohibited and may be > >>>>>> unlawful. In this case, please notify us by a reply and delete this email > >>>>>> and its contents immediately. > >>>>>> ---------------------------- > >>>>>> > >>>>>> > >>>>> > >>>> > >>>> > >>>> -- > >>>> What most experimenters take for granted before they begin their > >>>> experiments is infinitely more interesting than any results to which their > >>>> experiments lead. > >>>> -- Norbert Wiener > >>>> > >>> > >>> > >> > >> > >> -- > >> What most experimenters take for granted before they begin their > >> experiments is infinitely more interesting than any results to which their > >> experiments lead. > >> -- Norbert Wiener > >> > >> > >> > >> -- > >> Dominic Meiser > >> Tech-X Corporation > >> 5621 Arapahoe Avenue > >> Boulder, CO 80303 > >> USA > >> Telephone: 303-996-2036 > >> Fax: 303-448-7756www.txcorp.com > >> > >> > > > > > > -- > > What most experimenters take for granted before they begin their > > experiments is infinitely more interesting than any results to which their > > experiments lead. > > -- Norbert Wiener > > > From balay at mcs.anl.gov Fri Aug 29 10:30:20 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:30:20 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: Ops - I want' checking clearly.. > /usr/lib64/nvidia: file not recognized: Is a directory Where is this coming from? LPATH=/usr/lib64/nvidia:/usr/lib/nvidia CUDA_SEARCH_PATH=/usr/lib64/nvidia GLPATH=/usr/lib64/nvidia LIBRARIES=/usr/lib64/nvidia GLLINK=-L/usr/lib64/nvidia Perhaps all these env variables are incorrectly set - thus messing up nvcc? Satish On Fri, 29 Aug 2014, Satish Balay wrote: > #define PETSC_VERSION_GIT "v3.5.1-1951-g15ac067" > > Hm - you are using recent petsc master - and it stills broken... > > Perhaps Karl will check.. > > Perhaps we should process --with-cuda-arch in setCompilers.py - and not > cuda.py.. [but then - there is a dependency on precision..] > > Satish > > > On Fri, 29 Aug 2014, Ashwin Srinath wrote: > > > Hello, > > > > My original message is awaiting approval as attaching configure.log made it > > too large. I hope it's okay for me to repeat here: > > > > I'm having a similar issue with CUDA 6.0. PETSc configured just fine with > > version 5.0 and 5.5, and I'm using an almost identical configure command > > (only changing --with-cuda-dir). I get the following error: > > > > CUDA version error: PETSC currently requires CUDA version 4.0 or higher - > > when compiling with CUDA > > > > I suspect the problem might be with cuda.py checking for my CUDA version, > > but I can't be sure. > > > > Any suggestions? > > > > > > Thanks, > > Ashwin > > > > > > On Fri, Aug 29, 2014 at 10:31 AM, Matthew Knepley wrote: > > > > > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > > > wrote: > > > > > >> On 08/29/2014 08:08 AM, Matthew Knepley wrote: > > >> > > >> On Fri, Aug 29, 2014 at 8:35 AM, Christophe Ortiz < > > >> christophe.ortiz at ciemat.es> wrote: > > >> > > >>> Sorry about that. > > >>> > > >>> Please find in attachment the configure.log file. Hope it will help > > >>> you find the error. > > >>> > > >> > > >> Here is the problem: > > >> > > >> Possible ERROR while running preprocessor: nvcc warning : The > > >> 'compute_10' and 'sm_10' architectures are deprecated, and may be removed > > >> in a future release. > > >> error message = {nvcc warning : The 'compute_10' and 'sm_10' > > >> architectures are deprecated, and may be removed in a future release. > > >> } > > >> > > >> meaning the nvcc compiler does not "work" as provided. Here is a > > >> workaround: > > >> > > >> --with-cudac='nvcc --arch=sm_35' > > >> > > >> Dominic, I think that thrust.py should depend on cuda.py. Do you know > > >> why it does not? > > >> > > >> In principle you are right, thrust.py should depend on cuda.py. > > >> > > >> However, in my opinion, thrust.py should go away as a separate package > > >> altogether. Thrust is shipped as part of any recent version of the cuda > > >> toolkit (I forget since which version, Paul might know) and it's always > > >> installed in $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically > > >> deduct the thrust location from the cuda location. Thrust should be > > >> considered part of cuda. > > >> > > > > > > That does not mean the configure modules should be organized that way. > > > Thrust is a package included in CUDA, thus > > > it should have an independent module, but depend on the CUDA module. > > > > > > Matt > > > > > > > > >> Cheers, > > >> Dominic > > >> > > >> > > >> Thanks, > > >> > > >> Matt > > >> > > >> > > >> > > >>> Christophe > > >>> > > >>> CIEMAT > > >>> Laboratorio Nacional de Fusi?n por Confinamiento Magn?tico > > >>> Unidad de Materiales > > >>> Edificio 2 - Planta 0 - Despacho 28m > > >>> Avenida Complutense 40, > > >>> 28040 Madrid, Spain > > >>> Tel: +34 91496 2582 <%2B34%2091496%202582> > > >>> Fax: +34 91346 6442 <%2B34%2091346%206442> > > >>> > > >>> -- > > >>> Q > > >>> Por favor, piense en el medio ambiente antes de imprimir este mensaje. > > >>> Please consider the environment before printing this email. > > >>> > > >>> > > >>> On Fri, Aug 29, 2014 at 3:28 PM, Matthew Knepley > > >>> wrote: > > >>> > > >>>> Always attach configure.log or we cannot see what went wrong. > > >>>> > > >>>> Matt > > >>>> > > >>>> > > >>>> On Fri, Aug 29, 2014 at 2:35 AM, Christophe Ortiz < > > >>>> christophe.ortiz at ciemat.es> wrote: > > >>>> > > >>>>> Hi Dominic and Paul, > > >>>>> > > >>>>> Thanks for your answers. Unfortunately, it did not work. Same error > > >>>>> message related to the thrust directory: > > >>>>> > > >>>>> > > >>>>> ./configure --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > > >>>>> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > > >>>>> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 --with-thrust=1 > > >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include --with-cusp=1 > > >>>>> --with-cusp-dir=/usr/local/cuda-6.0/include --with-debugging=1 > > >>>>> --with-scalar-type=real --with-precision=double --download-fblaslapack > > >>>>> > > >>>>> =============================================================================== > > >>>>> Configuring PETSc to compile on your system > > >>>>> > > >>>>> > > >>>>> =============================================================================== > > >>>>> TESTING: checkInclude from > > >>>>> config.headers(config/BuildSystem/config/headers.py:86) > > >>>>> > > >>>>> ******************************************************************************* > > >>>>> UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > > >>>>> for details): > > >>>>> > > >>>>> ------------------------------------------------------------------------------- > > >>>>> --with-thrust-dir=/usr/local/cuda-6.0/include did not work > > >>>>> > > >>>>> ******************************************************************************* > > >>>>> > > >>>>> > > >>>>> I do not see what else to do...I have a standard CUDA installation > > >>>>> that came with thrust. > > >>>>> I am using ubuntu 12.04, I do not know if that could help. > > >>>>> I tried with PETSc 3.4.1 and 3.5.1. Same problem. > > >>>>> > > >>>>> Christophe > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>>> ------------------------------ > > >>>>>> > > >>>>>> Message: 3 > > >>>>>> Date: Thu, 28 Aug 2014 08:38:12 -0600 > > >>>>>> From: Dominic Meiser > > >>>>>> To: petsc-users at mcs.anl.gov > > >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > > >>>>>> Problem with thrust directory > > >>>>>> Message-ID: <53FF3ED4.1090002 at txcorp.com> > > >>>>>> Content-Type: text/plain; charset=UTF-8; format=flowed > > >>>>>> > > >>>>>> Can you try configuring with > > >>>>>> > > >>>>>> --with-thrust-dir=/usr/local/cuda-6.0/include > > >>>>>> > > >>>>>> I.e. omit the 'thrust' at the end of the path. Probably you'll need > > >>>>>> the > > >>>>>> same fix with cusp: > > >>>>>> > > >>>>>> --with-cusp-dir=/usr/local/cuda-6.0/include > > >>>>>> > > >>>>>> Cheers, > > >>>>>> Dominic > > >>>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>>> > > >>>>>> On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > >>>>>> > Hi all, > > >>>>>> > > > >>>>>> > I have implemented a problem of coupled diffusion equations in 1D > > >>>>>> > using PETSc. I was able to configure PETSC with and without MPI. The > > >>>>>> > code runs well in both cases. > > >>>>>> > > > >>>>>> > Now I would like to test CUDA but I am unable to configure it. I get > > >>>>>> > an error message related to thrust directory. > > >>>>>> > > > >>>>>> > The options I use to configure are the following: > > >>>>>> > > > >>>>>> > --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > > >>>>>> > --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > > >>>>>> > --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > > >>>>>> > --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > > >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > > >>>>>> > --download-txpetscgpu=1 --with-debugging=1 --with-scalar-type=real > > >>>>>> > --with-precision=double --download-f-blas-lapack > > >>>>>> > > > >>>>>> > The error message I get is: > > >>>>>> > > > >>>>>> > > > >>>>>> =============================================================================== > > >>>>>> > Configuring PETSc to compile on your system > > >>>>>> > > > >>>>>> =============================================================================== > > >>>>>> > TESTING: checkInclude from > > >>>>>> > config.headers(config/BuildSystem/config/headers.py:86) > > >>>>>> > > > >>>>>> ******************************************************************************* > > >>>>>> > UNABLE to CONFIGURE with GIVEN OPTIONS (see > > >>>>>> configure.log > > >>>>>> > for details): > > >>>>>> > > > >>>>>> ------------------------------------------------------------------------------- > > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > > >>>>>> > > > >>>>>> ******************************************************************************* > > >>>>>> > > > >>>>>> > > > >>>>>> > Did I miss something ? > > >>>>>> > My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > >>>>>> > > > >>>>>> > Many thanks in advance for your help. > > >>>>>> > Christophe > > >>>>>> > > > >>>>>> > > >>>>>> > > >>>>>> -- > > >>>>>> Dominic Meiser > > >>>>>> Tech-X Corporation > > >>>>>> 5621 Arapahoe Avenue > > >>>>>> Boulder, CO 80303 > > >>>>>> USA > > >>>>>> Telephone: 303-996-2036 > > >>>>>> Fax: 303-448-7756 > > >>>>>> www.txcorp.com > > >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> ------------------------------ > > >>>>>> > > >>>>>> Message: 4 > > >>>>>> Date: Thu, 28 Aug 2014 08:30:40 -0600 > > >>>>>> From: Paul Mullowney > > >>>>>> To: Dominic Meiser > > >>>>>> Cc: petsc-users at mcs.anl.gov > > >>>>>> Subject: Re: [petsc-users] Unable to configure PETSc with CUDA: > > >>>>>> Problem with thrust directory > > >>>>>> Message-ID: > > >>>>>> > >>>>>> 0aQdyNm9NMxMzsxWVGGPWZqhGCQ at mail.gmail.com> > > >>>>>> Content-Type: text/plain; charset="utf-8" > > >>>>>> > > >>>>>> Also, get rid of --download-txpetscgpu=1. That doesn't exist anymore. > > >>>>>> -Paul > > >>>>>> > > >>>>>> > > >>>>>> On Thu, Aug 28, 2014 at 8:38 AM, Dominic Meiser > > >>>>>> wrote: > > >>>>>> > > >>>>>> > Can you try configuring with > > >>>>>> > > > >>>>>> > --with-thrust-dir=/usr/local/cuda-6.0/include > > >>>>>> > > > >>>>>> > I.e. omit the 'thrust' at the end of the path. Probably you'll need > > >>>>>> the > > >>>>>> > same fix with cusp: > > >>>>>> > > > >>>>>> > --with-cusp-dir=/usr/local/cuda-6.0/include > > >>>>>> > > > >>>>>> > Cheers, > > >>>>>> > Dominic > > >>>>>> > > > >>>>>> > > > >>>>>> > On 08/28/2014 08:13 AM, Christophe Ortiz wrote: > > >>>>>> > > > >>>>>> >> Hi all, > > >>>>>> >> > > >>>>>> >> I have implemented a problem of coupled diffusion equations in 1D > > >>>>>> using > > >>>>>> >> PETSc. I was able to configure PETSC with and without MPI. The > > >>>>>> code runs > > >>>>>> >> well in both cases. > > >>>>>> >> > > >>>>>> >> Now I would like to test CUDA but I am unable to configure it. I > > >>>>>> get an > > >>>>>> >> error message related to thrust directory. > > >>>>>> >> > > >>>>>> >> The options I use to configure are the following: > > >>>>>> >> > > >>>>>> >> --with-x=1 --with-mpi=0 --with-cc=icc --with-cxx=icpc > > >>>>>> >> --with-clanguage=cxx --with-fc=ifort --with-cuda=1 > > >>>>>> >> --with-cuda-dir=/usr/local/cuda-6.0 --with-cuda-arch=sm_35 > > >>>>>> >> --with-cudac=/usr/local/cuda/bin/nvcc --with-thrust=1 > > >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust --with-cusp=1 > > >>>>>> >> --with-cusp-dir=/usr/local/cuda-6.0/include/cusp > > >>>>>> --download-txpetscgpu=1 > > >>>>>> >> --with-debugging=1 --with-scalar-type=real --with-precision=double > > >>>>>> >> --download-f-blas-lapack > > >>>>>> >> > > >>>>>> >> The error message I get is: > > >>>>>> >> > > >>>>>> >> ============================================================ > > >>>>>> >> =================== > > >>>>>> >> Configuring PETSc to compile on your system > > >>>>>> >> ============================================================ > > >>>>>> >> =================== > > >>>>>> >> TESTING: checkInclude from config.headers(config/ > > >>>>>> >> BuildSystem/config/headers.py:86) ****************************** > > >>>>>> >> ************************************************* > > >>>>>> >> UNABLE to CONFIGURE with GIVEN OPTIONS (see > > >>>>>> configure.log for > > >>>>>> >> details): > > >>>>>> >> ------------------------------------------------------------ > > >>>>>> >> ------------------- > > >>>>>> >> --with-thrust-dir=/usr/local/cuda-6.0/include/thrust did not work > > >>>>>> >> ************************************************************ > > >>>>>> >> ******************* > > >>>>>> >> > > >>>>>> >> > > >>>>>> >> Did I miss something ? > > >>>>>> >> My GPU is a GeForce Titan Black and I am using CUDA 6.0. > > >>>>>> >> > > >>>>>> >> Many thanks in advance for your help. > > >>>>>> >> Christophe > > >>>>>> >> > > >>>>>> >> > > >>>>>> > > > >>>>>> > -- > > >>>>>> > Dominic Meiser > > >>>>>> > Tech-X Corporation > > >>>>>> > 5621 Arapahoe Avenue > > >>>>>> > Boulder, CO 80303 > > >>>>>> > USA > > >>>>>> > Telephone: 303-996-2036 > > >>>>>> > Fax: 303-448-7756 > > >>>>>> > www.txcorp.com > > >>>>>> > > > >>>>>> > > > >>>>>> -------------- next part -------------- > > >>>>>> An HTML attachment was scrubbed... > > >>>>>> URL: < > > >>>>>> http://lists.mcs.anl.gov/pipermail/petsc-users/attachments/20140828/70c223ee/attachment-0001.html > > >>>>>> > > > >>>>>> > > >>>>>> ------------------------------ > > >>>>>> > > >>>>>> _______________________________________________ > > >>>>>> petsc-users mailing list > > >>>>>> petsc-users at mcs.anl.gov > > >>>>>> https://lists.mcs.anl.gov/mailman/listinfo/petsc-users > > >>>>>> > > >>>>>> > > >>>>>> End of petsc-users Digest, Vol 68, Issue 63 > > >>>>>> ******************************************* > > >>>>>> > > >>>>>> ---------------------------- > > >>>>>> Confidencialidad: > > >>>>>> Este mensaje y sus ficheros adjuntos se dirige exclusivamente a su > > >>>>>> destinatario y puede contener informaci?n privilegiada o confidencial. Si > > >>>>>> no es vd. el destinatario indicado, queda notificado de que la utilizaci?n, > > >>>>>> divulgaci?n y/o copia sin autorizaci?n est? prohibida en virtud de la > > >>>>>> legislaci?n vigente. Si ha recibido este mensaje por error, le rogamos que > > >>>>>> nos lo comunique inmediatamente respondiendo al mensaje y proceda a su > > >>>>>> destrucci?n. > > >>>>>> > > >>>>>> Disclaimer: > > >>>>>> This message and its attached files is intended exclusively for its > > >>>>>> recipients and may contain confidential information. If you received this > > >>>>>> e-mail in error you are hereby notified that any dissemination, copy or > > >>>>>> disclosure of this communication is strictly prohibited and may be > > >>>>>> unlawful. In this case, please notify us by a reply and delete this email > > >>>>>> and its contents immediately. > > >>>>>> ---------------------------- > > >>>>>> > > >>>>>> > > >>>>> > > >>>> > > >>>> > > >>>> -- > > >>>> What most experimenters take for granted before they begin their > > >>>> experiments is infinitely more interesting than any results to which their > > >>>> experiments lead. > > >>>> -- Norbert Wiener > > >>>> > > >>> > > >>> > > >> > > >> > > >> -- > > >> What most experimenters take for granted before they begin their > > >> experiments is infinitely more interesting than any results to which their > > >> experiments lead. > > >> -- Norbert Wiener > > >> > > >> > > >> > > >> -- > > >> Dominic Meiser > > >> Tech-X Corporation > > >> 5621 Arapahoe Avenue > > >> Boulder, CO 80303 > > >> USA > > >> Telephone: 303-996-2036 > > >> Fax: 303-448-7756www.txcorp.com > > >> > > >> > > > > > > > > > -- > > > What most experimenters take for granted before they begin their > > > experiments is infinitely more interesting than any results to which their > > > experiments lead. > > > -- Norbert Wiener > > > > > > From ashwinsrnth at gmail.com Fri Aug 29 10:38:59 2014 From: ashwinsrnth at gmail.com (Ashwin Srinath) Date: Fri, 29 Aug 2014 11:38:59 -0400 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: I'm running code on a university cluster. I'll find out where those variables are being set, and let you know if something works. Thanks! -------------- next part -------------- An HTML attachment was scrubbed... URL: From ksong at lbl.gov Fri Aug 29 10:37:12 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 08:37:12 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre Message-ID: Dear PETSC community, I am trying to install petsc-3.5.0 with superlu and hypre support. The "configure", "make" and "make install" went fine, but "make test" won't work. It complains about superlu and hypre libraries undefined. The environment I set up is: 1) valgrind/3.7.0 2) cmake/2.8.11.2 3) gcc/4.4.7 4) openmpi/1.6.5-gcc Here is the configure line: ./configure --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 --download-scalapack --download-metis=1 --download-superlu=1 --download-superlu_dist=1 --download-hypre=1 --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ My "make" and "make install" lines: make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 PETSC_ARCH=arch-linux2-c-debug all make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 PETSC_ARCH=arch-linux2-c-debug install The "make test" line: make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 test I got the following error regarding SuperLU and Hypre: ==================================== Running test examples to verify correct installation Using PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 and PETSC_ARCH=arch-linux2-c-debug *******************Error detected during compile or link!******************* See http://www.mcs.anl.gov/petsc/documentation/faq.html /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials ex19 ********************************************************************************* *********************W-a-r-n-i-n-g************************* Your PETSC_DIR may not match the directory you are in PETSC_DIR /clusterfs/voltaire/home/software/modules/petsc/3.5.0 Current directory /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials Ignore this if you are running make test ****************************************************** /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc -o ex19.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 -O0 -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include `pwd`/ex19.c /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 -O0 -o ex19 ex19.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lHYPRE -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s -lpthread -ldl /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_HYPRE' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_mpiaij_superlu_dist' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_seqaij_superlu_dist' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_seqaij_superlu' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_PFMG' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatCreate_HYPREStruct' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_SysPFMG' collect2: ld returned 1 exit status gmake[3]: [ex19] Error 1 (ignored) /bin/rm -f ex19.o *******************Error detected during compile or link!******************* See http://www.mcs.anl.gov/petsc/documentation/faq.html /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials ex5f ********************************************************* /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 -c -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include -o ex5f.o ex5f.F /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -o ex5f ex5f.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lHYPRE -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s -lpthread -ldl /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_HYPRE' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_mpiaij_superlu_dist' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_seqaij_superlu_dist' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatGetFactor_seqaij_superlu' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_PFMG' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `MatCreate_HYPREStruct' /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: undefined reference to `PCCreate_SysPFMG' collect2: ld returned 1 exit status gmake[3]: [ex5f] Error 1 (ignored) /bin/rm -f ex5f.o Completed test examples ========================================= I am not sure why hypre and superlu libraries are not linked properly. I do see the libraries in the $PETSC_DIR/lib/. Please let me know if you need any other information. Thanks in advance! Kai -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 29 10:41:39 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 10:41:39 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: Message-ID: On Fri, Aug 29, 2014 at 10:37 AM, Kai Song wrote: > Dear PETSC community, > > I am trying to install petsc-3.5.0 with superlu and hypre support. The > "configure", "make" and "make install" went fine, but "make test" won't > work. It complains about superlu and hypre libraries undefined. > Always send make.log and configure.log so that we can see what happened. Matt > The environment I set up is: > 1) valgrind/3.7.0 2) cmake/2.8.11.2 3) gcc/4.4.7 4) > openmpi/1.6.5-gcc > > Here is the configure line: > ./configure --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 > --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 > --download-scalapack --download-metis=1 --download-superlu=1 > --download-superlu_dist=1 --download-hypre=1 > --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ > > My "make" and "make install" lines: > make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 > PETSC_ARCH=arch-linux2-c-debug all > make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 > PETSC_ARCH=arch-linux2-c-debug install > > The "make test" line: > make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 test > > I got the following error regarding SuperLU and Hypre: > ==================================== > Running test examples to verify correct installation > Using PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 and > PETSC_ARCH=arch-linux2-c-debug > *******************Error detected during compile or > link!******************* > See http://www.mcs.anl.gov/petsc/documentation/faq.html > /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > ex19 > > ********************************************************************************* > *********************W-a-r-n-i-n-g************************* > Your PETSC_DIR may not match the directory you are in > PETSC_DIR /clusterfs/voltaire/home/software/modules/petsc/3.5.0 Current > directory > /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > Ignore this if you are running make test > ****************************************************** > /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc > -o ex19.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing > -Wno-unknown-pragmas -g3 -O0 > -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include > `pwd`/ex19.c > /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc > -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 > -O0 -o ex19 ex19.o > -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc > -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > -lHYPRE > -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 > -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps > -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack > -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 > -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx > -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s > -lpthread -ldl > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_HYPRE' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_mpiaij_superlu_dist' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_seqaij_superlu_dist' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_seqaij_superlu' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_PFMG' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatCreate_HYPREStruct' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_SysPFMG' > collect2: ld returned 1 exit status > gmake[3]: [ex19] Error 1 (ignored) > /bin/rm -f ex19.o > *******************Error detected during compile or > link!******************* > See http://www.mcs.anl.gov/petsc/documentation/faq.html > /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > ex5f > ********************************************************* > /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 > -c -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 > -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include > -o ex5f.o ex5f.F > /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 > -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -o ex5f > ex5f.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc > -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > -lHYPRE > -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 > -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps > -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack > -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 > -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx > -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s > -lpthread -ldl > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_HYPRE' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_mpiaij_superlu_dist' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_seqaij_superlu_dist' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatGetFactor_seqaij_superlu' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_PFMG' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `MatCreate_HYPREStruct' > /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > undefined reference to `PCCreate_SysPFMG' > collect2: ld returned 1 exit status > gmake[3]: [ex5f] Error 1 (ignored) > /bin/rm -f ex5f.o > Completed test examples > ========================================= > > I am not sure why hypre and superlu libraries are not linked properly. I > do see the libraries in the $PETSC_DIR/lib/. Please let me know if you need > any other information. > > Thanks in advance! > > Kai > > > -- > Kai Song > 1.510.495.2180 > 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 > High Performance Computing Services (HPCS) > Lawrence Berkeley National Laboratory - http://scs.lbl.gov > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Fri Aug 29 10:43:04 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:43:04 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: The primary issue here is - 'nvcc' is broken as installed. So you should be able to test it witout petsc. Once you have it working on a test code [without petsc] - you can try running configure again. Satish On Fri, 29 Aug 2014, Ashwin Srinath wrote: > I'm running code on a university cluster. I'll find out where those > variables > are being set, and let you know if something works. Thanks! > From ashwinsrnth at gmail.com Fri Aug 29 10:50:24 2014 From: ashwinsrnth at gmail.com (Ashwin Srinath) Date: Fri, 29 Aug 2014 11:50:24 -0400 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: Satish, Thank you, you're right - the issue is with nvcc. Thanks for your time! Ashwin On Fri, Aug 29, 2014 at 11:43 AM, Satish Balay wrote: > The primary issue here is - 'nvcc' is broken as installed. > > So you should be able to test it witout petsc. > > Once you have it working on a test code [without petsc] - you can try > running configure again. > > Satish > > On Fri, 29 Aug 2014, Ashwin Srinath wrote: > > > I'm running code on a university cluster. I'll find out where those > > variables > > are being set, and let you know if something works. Thanks! > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Fri Aug 29 10:52:05 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 10:52:05 -0500 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> Message-ID: https://bitbucket.org/petsc/petsc/commits/6e4329e6b >>>>>>>>> + if language == 'CUDA': # do not check CUDA linker since it is never used (and is broken on Mac with -m64) + self.popLanguage() + return <<<<<<<< But we use self.checkRun() in configure - which is using nvcc as linker. Perhaps this code should be removed? [and whatever issue was on Mac - should be fixed in a better way..] Or somehow check and set clinker as cudalinker? satish On Fri, 29 Aug 2014, Satish Balay wrote: > The primary issue here is - 'nvcc' is broken as installed. > > So you should be able to test it witout petsc. > > Once you have it working on a test code [without petsc] - you can try > running configure again. > > Satish > > On Fri, 29 Aug 2014, Ashwin Srinath wrote: > > > I'm running code on a university cluster. I'll find out where those > > variables > > are being set, and let you know if something works. Thanks! > > > > From ksong at lbl.gov Fri Aug 29 10:59:47 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 08:59:47 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: Message-ID: Hi Matt, Thanks for the quick response. Both logs are included in the attachment. Let me know if more log files are needed. Thanks! Kai On Fri, Aug 29, 2014 at 8:41 AM, Matthew Knepley wrote: > On Fri, Aug 29, 2014 at 10:37 AM, Kai Song wrote: > >> Dear PETSC community, >> >> I am trying to install petsc-3.5.0 with superlu and hypre support. The >> "configure", "make" and "make install" went fine, but "make test" won't >> work. It complains about superlu and hypre libraries undefined. >> > > Always send make.log and configure.log so that we can see what happened. > > Matt > > >> The environment I set up is: >> 1) valgrind/3.7.0 2) cmake/2.8.11.2 3) gcc/4.4.7 4) >> openmpi/1.6.5-gcc >> >> Here is the configure line: >> ./configure >> --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 >> --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 >> --download-scalapack --download-metis=1 --download-superlu=1 >> --download-superlu_dist=1 --download-hypre=1 >> --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ >> >> My "make" and "make install" lines: >> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 >> PETSC_ARCH=arch-linux2-c-debug all >> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 >> PETSC_ARCH=arch-linux2-c-debug install >> >> The "make test" line: >> make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 test >> >> I got the following error regarding SuperLU and Hypre: >> ==================================== >> Running test examples to verify correct installation >> Using PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 and >> PETSC_ARCH=arch-linux2-c-debug >> *******************Error detected during compile or >> link!******************* >> See http://www.mcs.anl.gov/petsc/documentation/faq.html >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >> ex19 >> >> ********************************************************************************* >> *********************W-a-r-n-i-n-g************************* >> Your PETSC_DIR may not match the directory you are in >> PETSC_DIR /clusterfs/voltaire/home/software/modules/petsc/3.5.0 Current >> directory >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >> Ignore this if you are running make test >> ****************************************************** >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc >> -o ex19.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing >> -Wno-unknown-pragmas -g3 -O0 >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include >> `pwd`/ex19.c >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc >> -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 >> -O0 -o ex19 ex19.o >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >> -lHYPRE >> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 >> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps >> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack >> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 >> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx >> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s >> -lpthread -ldl >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_HYPRE' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_mpiaij_superlu_dist' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_seqaij_superlu_dist' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_seqaij_superlu' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_PFMG' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatCreate_HYPREStruct' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_SysPFMG' >> collect2: ld returned 1 exit status >> gmake[3]: [ex19] Error 1 (ignored) >> /bin/rm -f ex19.o >> *******************Error detected during compile or >> link!******************* >> See http://www.mcs.anl.gov/petsc/documentation/faq.html >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >> ex5f >> ********************************************************* >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 >> -c -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include >> -o ex5f.o ex5f.F >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 >> -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -o ex5f >> ex5f.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >> -lHYPRE >> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 >> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps >> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack >> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 >> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx >> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s >> -lpthread -ldl >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_HYPRE' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_mpiaij_superlu_dist' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_seqaij_superlu_dist' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatGetFactor_seqaij_superlu' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_PFMG' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `MatCreate_HYPREStruct' >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >> undefined reference to `PCCreate_SysPFMG' >> collect2: ld returned 1 exit status >> gmake[3]: [ex5f] Error 1 (ignored) >> /bin/rm -f ex5f.o >> Completed test examples >> ========================================= >> >> I am not sure why hypre and superlu libraries are not linked properly. I >> do see the libraries in the $PETSC_DIR/lib/. Please let me know if you need >> any other information. >> >> Thanks in advance! >> >> Kai >> >> >> -- >> Kai Song >> 1.510.495.2180 >> 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 >> High Performance Computing Services (HPCS) >> Lawrence Berkeley National Laboratory - http://scs.lbl.gov >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 1922847 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: text/x-log Size: 91847 bytes Desc: not available URL: From balay at mcs.anl.gov Fri Aug 29 11:11:38 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 11:11:38 -0500 Subject: [petsc-users] [petsc-maint] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: Message-ID: Looks like some sourcefiles didn't get compiled. I'm not sure why that happened. [there is no entry for compile of hypre.o] You can try the following to see if the problem persists. make allclean make Also use --with-shared-libraries=0 for a prefix install. [I thought there was a check for it..] Satish On Fri, 29 Aug 2014, Kai Song wrote: > Hi Matt, > > Thanks for the quick response. Both logs are included in the attachment. > Let me know if more log files are needed. > > Thanks! > > Kai > > > > On Fri, Aug 29, 2014 at 8:41 AM, Matthew Knepley wrote: > > > On Fri, Aug 29, 2014 at 10:37 AM, Kai Song wrote: > > > >> Dear PETSC community, > >> > >> I am trying to install petsc-3.5.0 with superlu and hypre support. The > >> "configure", "make" and "make install" went fine, but "make test" won't > >> work. It complains about superlu and hypre libraries undefined. > >> > > > > Always send make.log and configure.log so that we can see what happened. > > > > Matt > > > > > >> The environment I set up is: > >> 1) valgrind/3.7.0 2) cmake/2.8.11.2 3) gcc/4.4.7 4) > >> openmpi/1.6.5-gcc > >> > >> Here is the configure line: > >> ./configure > >> --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 > >> --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 > >> --download-scalapack --download-metis=1 --download-superlu=1 > >> --download-superlu_dist=1 --download-hypre=1 > >> --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ > >> > >> My "make" and "make install" lines: > >> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 > >> PETSC_ARCH=arch-linux2-c-debug all > >> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 > >> PETSC_ARCH=arch-linux2-c-debug install > >> > >> The "make test" line: > >> make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 test > >> > >> I got the following error regarding SuperLU and Hypre: > >> ==================================== > >> Running test examples to verify correct installation > >> Using PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 and > >> PETSC_ARCH=arch-linux2-c-debug > >> *******************Error detected during compile or > >> link!******************* > >> See http://www.mcs.anl.gov/petsc/documentation/faq.html > >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > >> ex19 > >> > >> ********************************************************************************* > >> *********************W-a-r-n-i-n-g************************* > >> Your PETSC_DIR may not match the directory you are in > >> PETSC_DIR /clusterfs/voltaire/home/software/modules/petsc/3.5.0 Current > >> directory > >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > >> Ignore this if you are running make test > >> ****************************************************** > >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc > >> -o ex19.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing > >> -Wno-unknown-pragmas -g3 -O0 > >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > >> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include > >> `pwd`/ex19.c > >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc > >> -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 > >> -O0 -o ex19 ex19.o > >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > >> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc > >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > >> -lHYPRE > >> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > >> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > >> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 > >> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps > >> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack > >> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 > >> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx > >> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s > >> -lpthread -ldl > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_HYPRE' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_mpiaij_superlu_dist' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_seqaij_superlu_dist' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_seqaij_superlu' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_PFMG' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatCreate_HYPREStruct' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_SysPFMG' > >> collect2: ld returned 1 exit status > >> gmake[3]: [ex19] Error 1 (ignored) > >> /bin/rm -f ex19.o > >> *******************Error detected during compile or > >> link!******************* > >> See http://www.mcs.anl.gov/petsc/documentation/faq.html > >> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials > >> ex5f > >> ********************************************************* > >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 > >> -c -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 > >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > >> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include > >> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include > >> -o ex5f.o ex5f.F > >> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 > >> -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -o ex5f > >> ex5f.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > >> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc > >> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib > >> -lHYPRE > >> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > >> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib > >> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 > >> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps > >> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack > >> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 > >> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx > >> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s > >> -lpthread -ldl > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_HYPRE' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_mpiaij_superlu_dist' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_seqaij_superlu_dist' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatGetFactor_seqaij_superlu' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_PFMG' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `MatCreate_HYPREStruct' > >> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: > >> undefined reference to `PCCreate_SysPFMG' > >> collect2: ld returned 1 exit status > >> gmake[3]: [ex5f] Error 1 (ignored) > >> /bin/rm -f ex5f.o > >> Completed test examples > >> ========================================= > >> > >> I am not sure why hypre and superlu libraries are not linked properly. I > >> do see the libraries in the $PETSC_DIR/lib/. Please let me know if you need > >> any other information. > >> > >> Thanks in advance! > >> > >> Kai > >> > >> > >> -- > >> Kai Song > >> 1.510.495.2180 > >> 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 > >> High Performance Computing Services (HPCS) > >> Lawrence Berkeley National Laboratory - http://scs.lbl.gov > >> > > > > > > > > -- > > What most experimenters take for granted before they begin their > > experiments is infinitely more interesting than any results to which their > > experiments lead. > > -- Norbert Wiener > > > > > > From knepley at gmail.com Fri Aug 29 11:12:23 2014 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 29 Aug 2014 11:12:23 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: Message-ID: On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > Hi Matt, > > Thanks for the quick response. Both logs are included in the attachment. > Let me know if more log files are needed. > Jed, why does this not enter src/mat/impls/aij/seq/superlu? Thanks, Matt > Thanks! > > Kai > > > > On Fri, Aug 29, 2014 at 8:41 AM, Matthew Knepley > wrote: > >> On Fri, Aug 29, 2014 at 10:37 AM, Kai Song wrote: >> >>> Dear PETSC community, >>> >>> I am trying to install petsc-3.5.0 with superlu and hypre support. The >>> "configure", "make" and "make install" went fine, but "make test" won't >>> work. It complains about superlu and hypre libraries undefined. >>> >> >> Always send make.log and configure.log so that we can see what happened. >> >> Matt >> >> >>> The environment I set up is: >>> 1) valgrind/3.7.0 2) cmake/2.8.11.2 3) gcc/4.4.7 >>> 4) openmpi/1.6.5-gcc >>> >>> Here is the configure line: >>> ./configure >>> --prefix=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 >>> --download-fblaslapack=1 --download-mumps=1 --download-parmetis=1 >>> --download-scalapack --download-metis=1 --download-superlu=1 >>> --download-superlu_dist=1 --download-hypre=1 >>> --with-mpi-dir=/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/ >>> >>> My "make" and "make install" lines: >>> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 >>> PETSC_ARCH=arch-linux2-c-debug all >>> make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 >>> PETSC_ARCH=arch-linux2-c-debug install >>> >>> The "make test" line: >>> make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 test >>> >>> I got the following error regarding SuperLU and Hypre: >>> ==================================== >>> Running test examples to verify correct installation >>> Using PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 >>> and PETSC_ARCH=arch-linux2-c-debug >>> *******************Error detected during compile or >>> link!******************* >>> See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >>> ex19 >>> >>> ********************************************************************************* >>> *********************W-a-r-n-i-n-g************************* >>> Your PETSC_DIR may not match the directory you are in >>> PETSC_DIR /clusterfs/voltaire/home/software/modules/petsc/3.5.0 Current >>> directory >>> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >>> Ignore this if you are running make test >>> ****************************************************** >>> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc >>> -o ex19.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing >>> -Wno-unknown-pragmas -g3 -O0 >>> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >>> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >>> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include >>> `pwd`/ex19.c >>> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpicc >>> -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -g3 >>> -O0 -o ex19 ex19.o >>> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >>> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc >>> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >>> -lHYPRE >>> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >>> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >>> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 >>> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps >>> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack >>> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 >>> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx >>> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s >>> -lpthread -ldl >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_HYPRE' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_mpiaij_superlu_dist' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_seqaij_superlu_dist' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_seqaij_superlu' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_PFMG' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatCreate_HYPREStruct' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_SysPFMG' >>> collect2: ld returned 1 exit status >>> gmake[3]: [ex19] Error 1 (ignored) >>> /bin/rm -f ex19.o >>> *******************Error detected during compile or >>> link!******************* >>> See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> /clusterfs/voltaire/home/software/source/petsc-3.5.0/src/snes/examples/tutorials >>> ex5f >>> ********************************************************* >>> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 >>> -c -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 >>> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >>> -I/clusterfs/voltaire/home/software/modules/petsc/3.5.0/include >>> -I/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/include >>> -o ex5f.o ex5f.F >>> /global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/bin/mpif90 >>> -fPIC -Wall -Wno-unused-variable -ffree-line-length-0 -g -O0 -o ex5f >>> ex5f.o -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >>> -L/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib -lpetsc >>> -Wl,-rpath,/clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib >>> -lHYPRE >>> -Wl,-rpath,/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >>> -L/global/software/sl-6.x86_64/modules/gcc/4.4.7/openmpi/1.6.5-gcc/lib >>> -Wl,-rpath,/usr/lib/gcc/x86_64-redhat-linux/4.4.7 >>> -L/usr/lib/gcc/x86_64-redhat-linux/4.4.7 -lmpi_cxx -lstdc++ -lcmumps >>> -ldmumps -lsmumps -lzmumps -lmumps_common -lpord -lscalapack >>> -lsuperlu_dist_3.3 -lsuperlu_4.3 -lflapack -lfblas -lparmetis -lmetis -lX11 >>> -lssl -lcrypto -lpthread -lmpi_f90 -lmpi_f77 -lgfortran -lm -lmpi_cxx >>> -lstdc++ -lmpi_cxx -lstdc++ -ldl -lmpi -lnuma -lrt -lnsl -lutil -lgcc_s >>> -lpthread -ldl >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_HYPRE' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_mpiaij_superlu_dist' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_seqaij_superlu_dist' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatGetFactor_seqaij_superlu' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_PFMG' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `MatCreate_HYPREStruct' >>> /clusterfs/voltaire/home/software/modules/petsc/3.5.0/lib/libpetsc.so: >>> undefined reference to `PCCreate_SysPFMG' >>> collect2: ld returned 1 exit status >>> gmake[3]: [ex5f] Error 1 (ignored) >>> /bin/rm -f ex5f.o >>> Completed test examples >>> ========================================= >>> >>> I am not sure why hypre and superlu libraries are not linked properly. I >>> do see the libraries in the $PETSC_DIR/lib/. Please let me know if you need >>> any other information. >>> >>> Thanks in advance! >>> >>> Kai >>> >>> >>> -- >>> Kai Song >>> 1.510.495.2180 >>> 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 >>> High Performance Computing Services (HPCS) >>> Lawrence Berkeley National Laboratory - http://scs.lbl.gov >>> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to which their >> experiments lead. >> -- Norbert Wiener >> > > > > -- > Kai Song > 1.510.495.2180 > 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 > High Performance Computing Services (HPCS) > Lawrence Berkeley National Laboratory - http://scs.lbl.gov > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener -------------- next part -------------- An HTML attachment was scrubbed... URL: From jedbrown at mcs.anl.gov Fri Aug 29 11:25:47 2014 From: jedbrown at mcs.anl.gov (Jed Brown) Date: Fri, 29 Aug 2014 10:25:47 -0600 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: Message-ID: <87bnr3460k.fsf@jedbrown.org> Matthew Knepley writes: > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > >> Hi Matt, >> >> Thanks for the quick response. Both logs are included in the attachment. >> Let me know if more log files are needed. >> > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? Kai, can you delete arch-linux2-c-debug/conf/files and re-run make (it should regenerate this file). If superlu is not compiled, please send the contents of that file. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From jed at jedbrown.org Fri Aug 29 11:29:57 2014 From: jed at jedbrown.org (Jed Brown) Date: Fri, 29 Aug 2014 10:29:57 -0600 Subject: [petsc-users] Unable to configure PETSc with CUDA: Problem with thrust directory In-Reply-To: References: <54008FCD.4030604@txcorp.com> <54009404.103@txcorp.com> Message-ID: <878um745tm.fsf@jedbrown.org> Satish Balay writes: > On Fri, 29 Aug 2014, Dominic Meiser wrote: > >> On 08/29/2014 08:31 AM, Matthew Knepley wrote: >> > On Fri, Aug 29, 2014 at 9:35 AM, Dominic Meiser > > > wrote: > >> > > Dominic, I think that thrust.py should depend on cuda.py. Do you >> > > know why it does not? >> > In principle you are right, thrust.py should depend on cuda.py. >> > >> > However, in my opinion, thrust.py should go away as a separate >> > package altogether. Thrust is shipped as part of any recent >> > version of the cuda toolkit (I forget since which version, Paul >> > might know) and it's always installed in >> > $CUDA_TOOLKIT_ROOT/include/thrust. Thus we can automatically >> > deduct the thrust location from the cuda location. Thrust should >> > be considered part of cuda. > > I also think it should be removed. Agreed. If it was correct to consolidate umfpack, cholmod, etc., into suitesparse, then there is no question that thrust should be consolidated into cuda. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From ksong at lbl.gov Fri Aug 29 11:32:41 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 09:32:41 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: <87bnr3460k.fsf@jedbrown.org> References: <87bnr3460k.fsf@jedbrown.org> Message-ID: Hi Satish and Jed, I did a "make allclean", and reconfigured with "-with-shared-libraries=0". I am still seeing the same error. Then I deleted arch-linux2-c-debug/conf/files, and remake. The "make test" failed again. I have attached the new configure.log, make.log, and rch-linux2-c-debug/conf/files in this email. Thanks, Kai On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown wrote: > Matthew Knepley writes: > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > >> Hi Matt, > >> > >> Thanks for the quick response. Both logs are included in the attachment. > >> Let me know if more log files are needed. > >> > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > Kai, can you delete > > arch-linux2-c-debug/conf/files > > and re-run make (it should regenerate this file). If superlu is not > compiled, please send the contents of that file. > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 4671669 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: text/x-log Size: 12752 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: files Type: application/octet-stream Size: 87462 bytes Desc: not available URL: From ksong at lbl.gov Fri Aug 29 11:39:57 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 09:39:57 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: <87bnr3460k.fsf@jedbrown.org> References: <87bnr3460k.fsf@jedbrown.org> Message-ID: Hi Satish and Jed, The attachment was too big. I will send them again individually. Thanks, Kai On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown wrote: > Matthew Knepley writes: > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > >> Hi Matt, > >> > >> Thanks for the quick response. Both logs are included in the attachment. > >> Let me know if more log files are needed. > >> > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > Kai, can you delete > > arch-linux2-c-debug/conf/files > > and re-run make (it should regenerate this file). If superlu is not > compiled, please send the contents of that file. > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: From ksong at lbl.gov Fri Aug 29 11:40:43 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 09:40:43 -0700 Subject: [petsc-users] Fwd: PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: ---------- Forwarded message ---------- From: Kai Song Date: Fri, Aug 29, 2014 at 9:32 AM Subject: Re: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre To: Jed Brown Cc: Matthew Knepley , petsc-users < petsc-users at mcs.anl.gov>, Evan Um , Evan Um Hi Satish and Jed, I did a "make allclean", and reconfigured with "-with-shared-libraries=0". I am still seeing the same error. Then I deleted arch-linux2-c-debug/conf/files, and remake. The "make test" failed again. I have attached the new configure.log, make.log, and rch-linux2-c-debug/conf/files in this email. Thanks, Kai On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown wrote: > Matthew Knepley writes: > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > >> Hi Matt, > >> > >> Thanks for the quick response. Both logs are included in the attachment. > >> Let me know if more log files are needed. > >> > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > Kai, can you delete > > arch-linux2-c-debug/conf/files > > and re-run make (it should regenerate this file). If superlu is not > compiled, please send the contents of that file. > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: text/x-log Size: 12752 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: files Type: application/octet-stream Size: 87462 bytes Desc: not available URL: From balay at mcs.anl.gov Fri Aug 29 11:44:54 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 11:44:54 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: On Fri, 29 Aug 2014, Kai Song wrote: > Hi Satish and Jed, > > The attachment was too big. I will send them again individually. I've already approved that e-mail - and its posted to the list. The alterative is to compress configure.log before posting. Satish From balay at mcs.anl.gov Fri Aug 29 11:46:26 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 11:46:26 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: src/ksp/pc/impls/hypre/hypre.c is listed in files. However make.log is empty. Can you do 'make allclean' again' and resend make.log and arch-linux2-c-debug/conf/files And what do you have for: make --version Satish On Fri, 29 Aug 2014, Kai Song wrote: > Hi Satish and Jed, > > I did a "make allclean", and reconfigured with "-with-shared-libraries=0". > I am still seeing the same error. > > Then I deleted arch-linux2-c-debug/conf/files, and remake. The "make test" > failed again. > > I have attached the new configure.log, make.log, and > rch-linux2-c-debug/conf/files in this email. > > Thanks, > > Kai > > > > On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown wrote: > > > Matthew Knepley writes: > > > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > > > >> Hi Matt, > > >> > > >> Thanks for the quick response. Both logs are included in the attachment. > > >> Let me know if more log files are needed. > > >> > > > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > > > Kai, can you delete > > > > arch-linux2-c-debug/conf/files > > > > and re-run make (it should regenerate this file). If superlu is not > > compiled, please send the contents of that file. > > > > > > From balay at mcs.anl.gov Fri Aug 29 11:47:28 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 11:47:28 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: On Fri, 29 Aug 2014, Satish Balay wrote: > src/ksp/pc/impls/hypre/hypre.c is listed in files. > > However make.log is empty. > > Can you do 'make allclean' again' and resend Sorry should have said: make allclean make all And resend logs. satish > make.log and arch-linux2-c-debug/conf/files > > And what do you have for: > make --version > > Satish > > On Fri, 29 Aug 2014, Kai Song wrote: > > > Hi Satish and Jed, > > > > I did a "make allclean", and reconfigured with "-with-shared-libraries=0". > > I am still seeing the same error. > > > > Then I deleted arch-linux2-c-debug/conf/files, and remake. The "make test" > > failed again. > > > > I have attached the new configure.log, make.log, and > > rch-linux2-c-debug/conf/files in this email. > > > > Thanks, > > > > Kai > > > > > > > > On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown wrote: > > > > > Matthew Knepley writes: > > > > > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > > > > > >> Hi Matt, > > > >> > > > >> Thanks for the quick response. Both logs are included in the attachment. > > > >> Let me know if more log files are needed. > > > >> > > > > > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > > > > > Kai, can you delete > > > > > > arch-linux2-c-debug/conf/files > > > > > > and re-run make (it should regenerate this file). If superlu is not > > > compiled, please send the contents of that file. > > > > > > > > > > > > > From bsmith at mcs.anl.gov Fri Aug 29 12:00:42 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 29 Aug 2014 12:00:42 -0500 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Message-ID: <17F250ED-2BF6-4068-B7B1-B568AA537267@mcs.anl.gov> Better to just use VecGetArray() to access the Vector?s day and not allocate new space with the PetscMalloc() On Aug 29, 2014, at 8:55 AM, Florian Lindner wrote: > Am 27.08.2014 14:12, schrieb Florian Lindner: >> Hello, >> is there a way to create a vector with evenly spaced values in an >> interval, like the numpy.arange function? >> http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html >> or the linspace function? > > Ok, I gave it as try. Do I need the VecAssembly the vector? > > > void arange(size_t start, size_t stop) > { > // given a vector of appropriate size > PetscScalar ierr; > PetscScalar *a; > ierr = PetscMalloc(sizeof(PetscScalar) * (stop-start), &a); CHKERRV(ierr); > size_t pos = 0; > for (size_t i = start; i < stop; i++) { > a[pos] = i; > pos++; > } > cout << "Array filled." << endl; > VecReplaceArray(vector, a); > // VecAssemblyBegin(vector); VecAssemblyEnd(vector); Do I need that? > } > > Any comments? > > Thanks, > Florian From ksong at lbl.gov Fri Aug 29 12:01:06 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 10:01:06 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: Hi Satish, Here is the command that I ran: $ make --version ===== GNU Make 3.81 Copyright (C) 2006 Free Software Foundation, Inc. This is free software; see the source for copying conditions. There is NO warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. This program built for x86_64-redhat-linux-gnu ===== $ make allclean .. $ make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 PETSC_ARCH=arch-linux2-c-debug all ... Both make.log and arch-linux2-c-debug/conf/files are in the attachment. Thanks, Kai On Fri, Aug 29, 2014 at 9:47 AM, Satish Balay wrote: > On Fri, 29 Aug 2014, Satish Balay wrote: > > > src/ksp/pc/impls/hypre/hypre.c is listed in files. > > > > However make.log is empty. > > > > Can you do 'make allclean' again' and resend > > Sorry should have said: > make allclean > make all > > And resend logs. > > satish > > > make.log and arch-linux2-c-debug/conf/files > > > > And what do you have for: > > make --version > > > > Satish > > > > On Fri, 29 Aug 2014, Kai Song wrote: > > > > > Hi Satish and Jed, > > > > > > I did a "make allclean", and reconfigured with > "-with-shared-libraries=0". > > > I am still seeing the same error. > > > > > > Then I deleted arch-linux2-c-debug/conf/files, and remake. The "make > test" > > > failed again. > > > > > > I have attached the new configure.log, make.log, and > > > rch-linux2-c-debug/conf/files in this email. > > > > > > Thanks, > > > > > > Kai > > > > > > > > > > > > On Fri, Aug 29, 2014 at 9:25 AM, Jed Brown > wrote: > > > > > > > Matthew Knepley writes: > > > > > > > > > On Fri, Aug 29, 2014 at 10:59 AM, Kai Song wrote: > > > > > > > > > >> Hi Matt, > > > > >> > > > > >> Thanks for the quick response. Both logs are included in the > attachment. > > > > >> Let me know if more log files are needed. > > > > >> > > > > > > > > > > Jed, why does this not enter src/mat/impls/aij/seq/superlu? > > > > > > > > Kai, can you delete > > > > > > > > arch-linux2-c-debug/conf/files > > > > > > > > and re-run make (it should regenerate this file). If superlu is not > > > > compiled, please send the contents of that file. > > > > > > > > > > > > > > > > > > > > > > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: files Type: application/octet-stream Size: 87462 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: text/x-log Size: 92288 bytes Desc: not available URL: From bsmith at mcs.anl.gov Fri Aug 29 12:03:04 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 29 Aug 2014 12:03:04 -0500 Subject: [petsc-users] Reusing the preconditioner when using KSPSetComputeOperators In-Reply-To: <0E576811AB298343AC632BBCAAEFC37945D5AE5A@WAREHOUSE08.win.ntnu.no> References: <0E576811AB298343AC632BBCAAEFC37945D5AE5A@WAREHOUSE08.win.ntnu.no> Message-ID: <9A6AC8E7-682A-4648-AEEA-24CB01C4119A@mcs.anl.gov> On Aug 29, 2014, at 9:35 AM, ?smund Ervik wrote: > > On 28. aug. 2014 20:52, Barry Smith wrote: > > > > > > On Aug 28, 2014, at 4:34 AM, ?smund Ervik wrote: > > > > > >> Hello, > > >> > > >> I am solving a pressure Poisson equation with KSP, where the initial > > >> guess, RHS and matrix are computed by functions that I've hooked into > > >> KSPSetComputeXXX. (I'm also using DMDA for my domain decomposition.) > > >> > > >> For (single-phase|two-phase) I would like to (reuse|not reuse) the > > >> preconditioner. How do I specify that when using this way of setting the > > >> operator? Is it toggled by whether or not I call KSPSetOperators before > > >> each KSPSolve? (The manual does not mention KSPSetComputeXXX.) > > > > > > You should call KSPSetOperators() before each KSPSolve() (otherwise the function you provide to compute the matrix won?t be triggered). > > > > > > With PETSc 3.5 after the call to KSPSetOperators() call KSPSetReusePreconditioner() to tell KSP wether to reuse the preconditioner or build a new one. > > > With PETSc 3.4 and earlier, the final argument to KSPSetOperators() would be MAT_SAME_PRECONDITIONER to reuse the preconditioner or MAT_SAME_NONZERO_PATTERN to construct a new preconditioner > > > > > Thanks Barry for the clarification. Is there an example somewhere that > does this? All the ones I can find which use KSPSetComputeOperators() > have no calls to KSPSetOperators(). I guess this is because they are > only doing one linear solve? > > Furthermore, what should I pass in for Amat and Pmat to the KSPSetOperators() call? PetscNullObject, or do I get the Amat from the KSP somehow? You better call KSPGetOperators() to get them. Yes this is kind of silly. > > ?smund > From balay at mcs.anl.gov Fri Aug 29 12:06:32 2014 From: balay at mcs.anl.gov (Satish Balay) Date: Fri, 29 Aug 2014 12:06:32 -0500 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: On Fri, 29 Aug 2014, Kai Song wrote: > Hi Satish, > > Here is the command that I ran: > $ make --version > ===== > GNU Make 3.81 Ok - this version of make should not have issues. > Copyright (C) 2006 Free Software Foundation, Inc. > This is free software; see the source for copying conditions. > There is NO warranty; not even for MERCHANTABILITY or FITNESS FOR A > PARTICULAR PURPOSE. > > This program built for x86_64-redhat-linux-gnu > ===== > $ make allclean > .. > $ make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 > PETSC_ARCH=arch-linux2-c-debug all > ... > > Both make.log and arch-linux2-c-debug/conf/files are in the attachment. ok - files has: src/mat/impls/aij/mpi/superlu_dist/superlu_dist.c src/ksp/pc/impls/hypre/hypre.c make.log has: CC arch-linux2-c-debug/obj/src/mat/impls/aij/mpi/superlu_dist/superlu_dist.o CC arch-linux2-c-debug/obj/src/ksp/pc/impls/hypre/hypre.o Now you can do the insall and test [but perhaps delete curently installed stuff..] rm -rf /clusterfs/voltaire/home/software/modules/petsc/3.5.0 make PETSC_DIR=/clusterfs/voltaire/home/software/source/petsc-3.5.0 PETSC_ARCH=arch-linux2-c-debug install make PETSC_DIR=/clusterfs/voltaire/home/software/modules/petsc/3.5.0 PETSC_ARCH="" test Satish From jedbrown at mcs.anl.gov Fri Aug 29 12:13:27 2014 From: jedbrown at mcs.anl.gov (Jed Brown) Date: Fri, 29 Aug 2014 11:13:27 -0600 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: References: <87bnr3460k.fsf@jedbrown.org> Message-ID: <87zjen2p8o.fsf@jedbrown.org> Satish Balay writes: >> Both make.log and arch-linux2-c-debug/conf/files are in the attachment. > > ok - files has: > src/mat/impls/aij/mpi/superlu_dist/superlu_dist.c > src/ksp/pc/impls/hypre/hypre.c > > make.log has: > CC arch-linux2-c-debug/obj/src/mat/impls/aij/mpi/superlu_dist/superlu_dist.o > CC arch-linux2-c-debug/obj/src/ksp/pc/impls/hypre/hypre.o It also has superlu.o, so this looks good. We have had a couple (very rare) reports of files like these not being compiled, but I have yet to see a reproducer. I don't know if there is something nondeterministic in our build scripts or if it is a filesystem problem. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From antoine.deblois at aero.bombardier.com Fri Aug 29 14:58:40 2014 From: antoine.deblois at aero.bombardier.com (Antoine De Blois) Date: Fri, 29 Aug 2014 19:58:40 +0000 Subject: [petsc-users] superlu_dist and MatSolveTranspose In-Reply-To: <87vbpc49e3.fsf@jedbrown.org> References: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> <87vbpc49e3.fsf@jedbrown.org> Message-ID: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED5BEDF@MTLWAEXCH005.ca.aero.bombardier.net> Hello Jed, Thank you for your quick response. So I spent some time to dig deeper into my problem. I coded a shell script that passes through a bunch of ksp_type, pc_type and sub_pc_type. So please disregard the comment about the "does not converge properly for transpose". I had taken that conclusion from my own code (and not from the ex10 and extracted matrix), and a KSPSetFromOptions was missing. Apologies for that. What remains is the performance issue. The MatSolveTranspose takes a very long time to converge. For a matrix of 3 million rows, MatSolveTranspose takes roughly 5 minutes on 64 cpus, whereas the MatSolve is almost instantaneous!. When I gdb my code, petsc seems to be stalled in the MatLUFactorNumeric_SeqAIJ_Inode () for a long time. I also did a top on the compute node to check the RAM usage. It was hovering over 2 gig, so memory usage does not seem to be an issue here. #0 0x00002afe8dfebd08 in MatLUFactorNumeric_SeqAIJ_Inode () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #1 0x00002afe8e07f15c in MatLUFactorNumeric () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #2 0x00002afe8e2afa99 in PCSetUp_ILU () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #3 0x00002afe8e337c0d in PCSetUp () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #4 0x00002afe8e39d643 in KSPSetUp () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #5 0x00002afe8e39e3ee in KSPSolveTranspose () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #6 0x00002afe8e300f8c in PCApplyTranspose_ASM () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #7 0x00002afe8e338c13 in PCApplyTranspose () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #8 0x00002afe8e3a8a84 in KSPInitialResidual () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #9 0x00002afe8e376c32 in KSPSolve_GMRES () from /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 #10 0x00002afe8e39e425 in KSPSolveTranspose () For that particular application, I was using: ksp_type: gmres pc_type: asm sub_pc_type: ilu adj_sub_pc_factor_levels 1 For small matrices, the MatSolveTranspose computing time is very similar to the simple MatSolve. And if I want to revert to a MatTranspose followed by the MatSolve, then the MatTranspose takes forever to finish... For a matrix of 3 million rows, MatTranspose takes 30 minutes on 64 cpus!! So thank you for implementing the transpose solve in superlu_dist. It would also be nice to have it with hypre. Let me know what you think and ideas on how to improve my computational time, Regards, Antoine -----Message d'origine----- De?: Jed Brown [mailto:jed at jedbrown.org] Envoy??: Thursday, August 28, 2014 5:01 PM ??: Antoine De Blois; 'petsc-users at mcs.anl.gov' Objet?: Re: [petsc-users] superlu_dist and MatSolveTranspose Antoine De Blois writes: > Hello everyone, > > I am trying to solve a A^T x = b system. For my applications, I had > realized that the MatSolveTranspose does not converge properly. What do you mean "does not converge properly"? Can you send a test case where the transpose solve should be equivalent, but is not? We have only a few tests for transpose solve and not all preconditioners support it, but where it is supported, we want to ensure that it is correct. > Therefore, I had implemented a MatTranspose followed by a MatSolve. > This proved to converge perfectly (which is strange since the > transposed matrix has the same eigenvalues as the untransposed...). > The problem is that for bigger matrices, the MatTranspose is very > costly and thus cannot be used. Costly in terms of memory? (I want you to be able to use KSPSolveTranspose, but I'm curious what you're experiencing.) > I tried using the superlu_dist package. Although it the package works perfectly for the MatSolve, I get the an "No support for this operation for this object type" error with MatSolveTransopse. I reproduced the error using the MatView an ex10 tutorial. I can provide the matrix and rhs upon request. My command line was: > > ex10 -f0 A_and_rhs.bin -pc_type lu -pc_factor_mat_solver_package > superlu_dist -trans > > So it there an additional parameter I need to use for the transposed solve? > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Matrix type mpiaij This is easy to add. I'll do it now. > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown [0]PETSC ERROR: > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t > utorials/ex10 on a ARGUS_impi_opt named hpc-user11 by ad007804 Thu Aug > 28 16:41:15 2014 [0]PETSC ERROR: Configure options --CFLAGS="-xHost > -axAVX" --download-hypre --download-metis --download-ml > --download-parmetis --download-scalapack --download-superlu_dist > --download-mumps --with-c2html=0 --with-cc=mpiicc --with-fc=mpiifort > --with-cxx=mpiicpc --with-debugging=yes > --prefix=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/petsc-3.5.1 > --with-cmake=/gpfs/fs1/aero/SOFTWARE/TOOLS/CMAKE/cmake-2.8.7/bin/cmake > --with-valgrind=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/valgrind-3.9 > .0/bin/valgrind --with-shared-libraries=0 [0]PETSC ERROR: #1 > MatSolveTranspose() line 3473 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/mat/interface/matr > ix.c [0]PETSC ERROR: #2 PCApplyTranspose_LU() line 214 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/impls/facto > r/lu/lu.c [0]PETSC ERROR: #3 PCApplyTranspose() line 573 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/interface/p > recon.c [0]PETSC ERROR: #4 KSP_PCApply() line 233 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/include/petsc-private/ > kspimpl.h [0]PETSC ERROR: #5 KSPInitialResidual() line 63 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ > itres.c [0]PETSC ERROR: #6 KSPSolve_GMRES() line 234 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/impls/gmre > s/gmres.c [0]PETSC ERROR: #7 KSPSolveTranspose() line 704 in > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ > itfunc.c [0]PETSC ERROR: #8 main() line 324 in > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t > utorials/ex10.c > > FYI, the transpose solve is a typical application for adjoint optimization. There should be a big adjoint community of developers that try to solve the transposed matrix. > > Any help is much appreciated, > Best, > Antoine > > > Antoine DeBlois > Specialiste ingenierie, MDO lead / Engineering Specialist, MDO lead > A?ronautique / Aerospace 514-855-5001, x 50862 > antoine.deblois at aero.bombardier.com dier.com> > > 2351 Blvd Alfred-Nobel > Montreal, Qc > H4S 1A9 > > [Description?: Description?: > http://signatures.ca.aero.bombardier.net/eom_logo_164x39_fr.jpg] > CONFIDENTIALITY NOTICE - This communication may contain privileged or confidential information. > If you are not the intended recipient or received this communication > by error, please notify the sender and delete the message without > copying From ksong at lbl.gov Fri Aug 29 16:12:50 2014 From: ksong at lbl.gov (Kai Song) Date: Fri, 29 Aug 2014 14:12:50 -0700 Subject: [petsc-users] PETSC-3.5.0 with SuperLU and Hypre In-Reply-To: <87zjen2p8o.fsf@jedbrown.org> References: <87bnr3460k.fsf@jedbrown.org> <87zjen2p8o.fsf@jedbrown.org> Message-ID: Hi All, Thanks so much for the help. The make test is working now! Kai On Fri, Aug 29, 2014 at 10:13 AM, Jed Brown wrote: > Satish Balay writes: > >> Both make.log and arch-linux2-c-debug/conf/files are in the attachment. > > > > ok - files has: > > src/mat/impls/aij/mpi/superlu_dist/superlu_dist.c > > src/ksp/pc/impls/hypre/hypre.c > > > > make.log has: > > CC > arch-linux2-c-debug/obj/src/mat/impls/aij/mpi/superlu_dist/superlu_dist.o > > CC arch-linux2-c-debug/obj/src/ksp/pc/impls/hypre/hypre.o > > It also has superlu.o, so this looks good. We have had a couple (very > rare) reports of files like these not being compiled, but I have yet to > see a reproducer. I don't know if there is something nondeterministic > in our build scripts or if it is a filesystem problem. > -- Kai Song 1.510.495.2180 1 Cyclotron Rd. Berkeley, CA94720, MS-50B 3209 High Performance Computing Services (HPCS) Lawrence Berkeley National Laboratory - http://scs.lbl.gov -------------- next part -------------- An HTML attachment was scrubbed... URL: From gaetank at gmail.com Fri Aug 29 18:14:15 2014 From: gaetank at gmail.com (Gaetan Kenway) Date: Fri, 29 Aug 2014 19:14:15 -0400 Subject: [petsc-users] superlu_dist and MatSolveTranspose In-Reply-To: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED5BEDF@MTLWAEXCH005.ca.aero.bombardier.net> References: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> <87vbpc49e3.fsf@jedbrown.org> <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED5BEDF@MTLWAEXCH005.ca.aero.bombardier.net> Message-ID: Hi Antoine We are also using PETSc for solving adjoint systems resulting from CFD. To get around the matSolveTranspose issue we just assemble the transpose matrix directly and then call KSPSolve(). If this is possible in your application I think it is probably the best approach Gaetan On Fri, Aug 29, 2014 at 3:58 PM, Antoine De Blois < antoine.deblois at aero.bombardier.com> wrote: > Hello Jed, > > Thank you for your quick response. So I spent some time to dig deeper into > my problem. I coded a shell script that passes through a bunch of ksp_type, > pc_type and sub_pc_type. So please disregard the comment about the "does > not converge properly for transpose". I had taken that conclusion from my > own code (and not from the ex10 and extracted matrix), and a > KSPSetFromOptions was missing. Apologies for that. > > What remains is the performance issue. The MatSolveTranspose takes a very > long time to converge. For a matrix of 3 million rows, MatSolveTranspose > takes roughly 5 minutes on 64 cpus, whereas the MatSolve is almost > instantaneous!. When I gdb my code, petsc seems to be stalled in the > MatLUFactorNumeric_SeqAIJ_Inode () for a long time. I also did a top on the > compute node to check the RAM usage. It was hovering over 2 gig, so memory > usage does not seem to be an issue here. > > #0 0x00002afe8dfebd08 in MatLUFactorNumeric_SeqAIJ_Inode () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #1 0x00002afe8e07f15c in MatLUFactorNumeric () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #2 0x00002afe8e2afa99 in PCSetUp_ILU () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #3 0x00002afe8e337c0d in PCSetUp () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #4 0x00002afe8e39d643 in KSPSetUp () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #5 0x00002afe8e39e3ee in KSPSolveTranspose () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #6 0x00002afe8e300f8c in PCApplyTranspose_ASM () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #7 0x00002afe8e338c13 in PCApplyTranspose () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #8 0x00002afe8e3a8a84 in KSPInitialResidual () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #9 0x00002afe8e376c32 in KSPSolve_GMRES () > from > /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 > #10 0x00002afe8e39e425 in KSPSolveTranspose () > > For that particular application, I was using: > ksp_type: gmres > pc_type: asm > sub_pc_type: ilu > adj_sub_pc_factor_levels 1 > > For small matrices, the MatSolveTranspose computing time is very similar > to the simple MatSolve. > > And if I want to revert to a MatTranspose followed by the MatSolve, then > the MatTranspose takes forever to finish... For a matrix of 3 million rows, > MatTranspose takes 30 minutes on 64 cpus!! > > So thank you for implementing the transpose solve in superlu_dist. It > would also be nice to have it with hypre. > Let me know what you think and ideas on how to improve my computational > time, > Regards, > Antoine > > -----Message d'origine----- > De : Jed Brown [mailto:jed at jedbrown.org] > Envoy? : Thursday, August 28, 2014 5:01 PM > ? : Antoine De Blois; 'petsc-users at mcs.anl.gov' > Objet : Re: [petsc-users] superlu_dist and MatSolveTranspose > > Antoine De Blois writes: > > > Hello everyone, > > > > I am trying to solve a A^T x = b system. For my applications, I had > > realized that the MatSolveTranspose does not converge properly. > > What do you mean "does not converge properly"? Can you send a test case > where the transpose solve should be equivalent, but is not? We have only a > few tests for transpose solve and not all preconditioners support it, but > where it is supported, we want to ensure that it is correct. > > > Therefore, I had implemented a MatTranspose followed by a MatSolve. > > This proved to converge perfectly (which is strange since the > > transposed matrix has the same eigenvalues as the untransposed...). > > The problem is that for bigger matrices, the MatTranspose is very > > costly and thus cannot be used. > > Costly in terms of memory? (I want you to be able to use > KSPSolveTranspose, but I'm curious what you're experiencing.) > > > I tried using the superlu_dist package. Although it the package works > perfectly for the MatSolve, I get the an "No support for this operation for > this object type" error with MatSolveTransopse. I reproduced the error > using the MatView an ex10 tutorial. I can provide the matrix and rhs upon > request. My command line was: > > > > ex10 -f0 A_and_rhs.bin -pc_type lu -pc_factor_mat_solver_package > > superlu_dist -trans > > > > So it there an additional parameter I need to use for the transposed > solve? > > > > [0]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Matrix type mpiaij > > This is easy to add. I'll do it now. > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown [0]PETSC ERROR: > > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t > > utorials/ex10 on a ARGUS_impi_opt named hpc-user11 by ad007804 Thu Aug > > 28 16:41:15 2014 [0]PETSC ERROR: Configure options --CFLAGS="-xHost > > -axAVX" --download-hypre --download-metis --download-ml > > --download-parmetis --download-scalapack --download-superlu_dist > > --download-mumps --with-c2html=0 --with-cc=mpiicc --with-fc=mpiifort > > --with-cxx=mpiicpc --with-debugging=yes > > --prefix=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/petsc-3.5.1 > > --with-cmake=/gpfs/fs1/aero/SOFTWARE/TOOLS/CMAKE/cmake-2.8.7/bin/cmake > > --with-valgrind=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/valgrind-3.9 > > .0/bin/valgrind --with-shared-libraries=0 [0]PETSC ERROR: #1 > > MatSolveTranspose() line 3473 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/mat/interface/matr > > ix.c [0]PETSC ERROR: #2 PCApplyTranspose_LU() line 214 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/impls/facto > > r/lu/lu.c [0]PETSC ERROR: #3 PCApplyTranspose() line 573 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/interface/p > > recon.c [0]PETSC ERROR: #4 KSP_PCApply() line 233 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/include/petsc-private/ > > kspimpl.h [0]PETSC ERROR: #5 KSPInitialResidual() line 63 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ > > itres.c [0]PETSC ERROR: #6 KSPSolve_GMRES() line 234 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/impls/gmre > > s/gmres.c [0]PETSC ERROR: #7 KSPSolveTranspose() line 704 in > > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ > > itfunc.c [0]PETSC ERROR: #8 main() line 324 in > > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t > > utorials/ex10.c > > > > FYI, the transpose solve is a typical application for adjoint > optimization. There should be a big adjoint community of developers that > try to solve the transposed matrix. > > > > Any help is much appreciated, > > Best, > > Antoine > > > > > > Antoine DeBlois > > Specialiste ingenierie, MDO lead / Engineering Specialist, MDO lead > > A?ronautique / Aerospace 514-855-5001, x 50862 > > antoine.deblois at aero.bombardier.com > dier.com> > > > > 2351 Blvd Alfred-Nobel > > Montreal, Qc > > H4S 1A9 > > > > [Description : Description : > > http://signatures.ca.aero.bombardier.net/eom_logo_164x39_fr.jpg] > > CONFIDENTIALITY NOTICE - This communication may contain privileged or > confidential information. > > If you are not the intended recipient or received this communication > > by error, please notify the sender and delete the message without > > copying > -------------- next part -------------- An HTML attachment was scrubbed... URL: From hzhang at mcs.anl.gov Fri Aug 29 20:13:57 2014 From: hzhang at mcs.anl.gov (Hong) Date: Fri, 29 Aug 2014 20:13:57 -0500 Subject: [petsc-users] superlu_dist and MatSolveTranspose In-Reply-To: References: <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED55AED@MTLWAEXCH005.ca.aero.bombardier.net> <87vbpc49e3.fsf@jedbrown.org> <22B78B7D747CBF4FA36FCD2C6EC7AF5EAED5BEDF@MTLWAEXCH005.ca.aero.bombardier.net> Message-ID: We can add MatSolveTranspose() to the petsc interface with superlu_dist. Jed, Are you working on it? If not, I can work on it. Hong On Fri, Aug 29, 2014 at 6:14 PM, Gaetan Kenway wrote: > Hi Antoine > > We are also using PETSc for solving adjoint systems resulting from CFD. To > get around the matSolveTranspose issue we just assemble the transpose matrix > directly and then call KSPSolve(). If this is possible in your application I > think it is probably the best approach > > Gaetan > > > On Fri, Aug 29, 2014 at 3:58 PM, Antoine De Blois > wrote: >> >> Hello Jed, >> >> Thank you for your quick response. So I spent some time to dig deeper into >> my problem. I coded a shell script that passes through a bunch of ksp_type, >> pc_type and sub_pc_type. So please disregard the comment about the "does not >> converge properly for transpose". I had taken that conclusion from my own >> code (and not from the ex10 and extracted matrix), and a KSPSetFromOptions >> was missing. Apologies for that. >> >> What remains is the performance issue. The MatSolveTranspose takes a very >> long time to converge. For a matrix of 3 million rows, MatSolveTranspose >> takes roughly 5 minutes on 64 cpus, whereas the MatSolve is almost >> instantaneous!. When I gdb my code, petsc seems to be stalled in the >> MatLUFactorNumeric_SeqAIJ_Inode () for a long time. I also did a top on the >> compute node to check the RAM usage. It was hovering over 2 gig, so memory >> usage does not seem to be an issue here. >> >> #0 0x00002afe8dfebd08 in MatLUFactorNumeric_SeqAIJ_Inode () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #1 0x00002afe8e07f15c in MatLUFactorNumeric () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #2 0x00002afe8e2afa99 in PCSetUp_ILU () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #3 0x00002afe8e337c0d in PCSetUp () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #4 0x00002afe8e39d643 in KSPSetUp () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #5 0x00002afe8e39e3ee in KSPSolveTranspose () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #6 0x00002afe8e300f8c in PCApplyTranspose_ASM () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #7 0x00002afe8e338c13 in PCApplyTranspose () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #8 0x00002afe8e3a8a84 in KSPInitialResidual () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #9 0x00002afe8e376c32 in KSPSolve_GMRES () >> from >> /gpfs/fs2/aero/SOFTWARE/FLOW_SOLVERS/FANSC/EXT_LIB/petsc-3.5.1/lib/libpetsc.so.3.5 >> #10 0x00002afe8e39e425 in KSPSolveTranspose () >> >> For that particular application, I was using: >> ksp_type: gmres >> pc_type: asm >> sub_pc_type: ilu >> adj_sub_pc_factor_levels 1 >> >> For small matrices, the MatSolveTranspose computing time is very similar >> to the simple MatSolve. >> >> And if I want to revert to a MatTranspose followed by the MatSolve, then >> the MatTranspose takes forever to finish... For a matrix of 3 million rows, >> MatTranspose takes 30 minutes on 64 cpus!! >> >> So thank you for implementing the transpose solve in superlu_dist. It >> would also be nice to have it with hypre. >> Let me know what you think and ideas on how to improve my computational >> time, >> Regards, >> Antoine >> >> -----Message d'origine----- >> De : Jed Brown [mailto:jed at jedbrown.org] >> Envoy? : Thursday, August 28, 2014 5:01 PM >> ? : Antoine De Blois; 'petsc-users at mcs.anl.gov' >> Objet : Re: [petsc-users] superlu_dist and MatSolveTranspose >> >> Antoine De Blois writes: >> >> > Hello everyone, >> > >> > I am trying to solve a A^T x = b system. For my applications, I had >> > realized that the MatSolveTranspose does not converge properly. >> >> What do you mean "does not converge properly"? Can you send a test case >> where the transpose solve should be equivalent, but is not? We have only a >> few tests for transpose solve and not all preconditioners support it, but >> where it is supported, we want to ensure that it is correct. >> >> > Therefore, I had implemented a MatTranspose followed by a MatSolve. >> > This proved to converge perfectly (which is strange since the >> > transposed matrix has the same eigenvalues as the untransposed...). >> > The problem is that for bigger matrices, the MatTranspose is very >> > costly and thus cannot be used. >> >> Costly in terms of memory? (I want you to be able to use >> KSPSolveTranspose, but I'm curious what you're experiencing.) >> >> > I tried using the superlu_dist package. Although it the package works >> > perfectly for the MatSolve, I get the an "No support for this operation for >> > this object type" error with MatSolveTransopse. I reproduced the error >> > using the MatView an ex10 tutorial. I can provide the matrix and rhs upon >> > request. My command line was: >> > >> > ex10 -f0 A_and_rhs.bin -pc_type lu -pc_factor_mat_solver_package >> > superlu_dist -trans >> > >> > So it there an additional parameter I need to use for the transposed >> > solve? >> > >> > [0]PETSC ERROR: --------------------- Error Message >> > -------------------------------------------------------------- >> > [0]PETSC ERROR: No support for this operation for this object type >> > [0]PETSC ERROR: Matrix type mpiaij >> >> This is easy to add. I'll do it now. >> >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> > for trouble shooting. >> > [0]PETSC ERROR: Petsc Release Version 3.5.1, unknown [0]PETSC ERROR: >> > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t >> > utorials/ex10 on a ARGUS_impi_opt named hpc-user11 by ad007804 Thu Aug >> > 28 16:41:15 2014 [0]PETSC ERROR: Configure options --CFLAGS="-xHost >> > -axAVX" --download-hypre --download-metis --download-ml >> > --download-parmetis --download-scalapack --download-superlu_dist >> > --download-mumps --with-c2html=0 --with-cc=mpiicc --with-fc=mpiifort >> > --with-cxx=mpiicpc --with-debugging=yes >> > --prefix=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/petsc-3.5.1 >> > --with-cmake=/gpfs/fs1/aero/SOFTWARE/TOOLS/CMAKE/cmake-2.8.7/bin/cmake >> > --with-valgrind=/gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/valgrind-3.9 >> > .0/bin/valgrind --with-shared-libraries=0 [0]PETSC ERROR: #1 >> > MatSolveTranspose() line 3473 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/mat/interface/matr >> > ix.c [0]PETSC ERROR: #2 PCApplyTranspose_LU() line 214 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/impls/facto >> > r/lu/lu.c [0]PETSC ERROR: #3 PCApplyTranspose() line 573 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/pc/interface/p >> > recon.c [0]PETSC ERROR: #4 KSP_PCApply() line 233 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/include/petsc-private/ >> > kspimpl.h [0]PETSC ERROR: #5 KSPInitialResidual() line 63 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ >> > itres.c [0]PETSC ERROR: #6 KSPSolve_GMRES() line 234 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/impls/gmre >> > s/gmres.c [0]PETSC ERROR: #7 KSPSolveTranspose() line 704 in >> > /gpfs/fs2/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/interface/ >> > itfunc.c [0]PETSC ERROR: #8 main() line 324 in >> > /gpfs/fs1/aero/SOFTWARE/TOOLS/PROGRAMMING/petsc/src/ksp/ksp/examples/t >> > utorials/ex10.c >> > >> > FYI, the transpose solve is a typical application for adjoint >> > optimization. There should be a big adjoint community of developers that try >> > to solve the transposed matrix. >> > >> > Any help is much appreciated, >> > Best, >> > Antoine >> > >> > >> > Antoine DeBlois >> > Specialiste ingenierie, MDO lead / Engineering Specialist, MDO lead >> > A?ronautique / Aerospace 514-855-5001, x 50862 >> > antoine.deblois at aero.bombardier.com> > dier.com> >> > >> > 2351 Blvd Alfred-Nobel >> > Montreal, Qc >> > H4S 1A9 >> > >> > [Description : Description : >> > http://signatures.ca.aero.bombardier.net/eom_logo_164x39_fr.jpg] >> > CONFIDENTIALITY NOTICE - This communication may contain privileged or >> > confidential information. >> > If you are not the intended recipient or received this communication >> > by error, please notify the sender and delete the message without >> > copying > > From mailinglists at xgm.de Sat Aug 30 03:17:16 2014 From: mailinglists at xgm.de (Florian Lindner) Date: Sat, 30 Aug 2014 10:17:16 +0200 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> Message-ID: <5665488.IAIQm48v7U@horus> Am Freitag, 29. August 2014, 09:29:21 schrieben Sie: > Florian : > >> > >> is there a way to create a vector with evenly spaced values in an > >> interval, like the numpy.arange function? > >> http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html > >> or the linspace function? > > > > > > Ok, I gave it as try. Do I need the VecAssembly the vector? > > No, but you need VecResetArray() when vector is no longer used. Why do I need to call that if I have no intention going back to the original values? Of course I do VecDestroy the vector? Rgds, Florian > > > > > > void arange(size_t start, size_t stop) > > { > > // given a vector of appropriate size > > PetscScalar ierr; > > PetscScalar *a; > > ierr = PetscMalloc(sizeof(PetscScalar) * (stop-start), &a); > > CHKERRV(ierr); > > size_t pos = 0; > > for (size_t i = start; i < stop; i++) { > > a[pos] = i; > > pos++; > > } > > cout << "Array filled." << endl; > > VecReplaceArray(vector, a); > > // VecAssemblyBegin(vector); VecAssemblyEnd(vector); Do I need that? > > } > > > > Any comments? > > > > Thanks, > > Florian From jed at jedbrown.org Sat Aug 30 07:09:14 2014 From: jed at jedbrown.org (Jed Brown) Date: Sat, 30 Aug 2014 06:09:14 -0600 Subject: [petsc-users] *****SPAM*****Create vector with evenly spaced values In-Reply-To: <5665488.IAIQm48v7U@horus> References: <56ac083d37de1c89a2caac01e56e4bec@xgm.de> <5665488.IAIQm48v7U@horus> Message-ID: <87mwam18np.fsf@jedbrown.org> Florian Lindner writes: > Am Freitag, 29. August 2014, 09:29:21 schrieben Sie: >> Florian : >> >> >> >> is there a way to create a vector with evenly spaced values in an >> >> interval, like the numpy.arange function? >> >> http://docs.scipy.org/doc/numpy/reference/generated/numpy.arange.html >> >> or the linspace function? >> > >> > >> > Ok, I gave it as try. Do I need the VecAssembly the vector? >> >> No, but you need VecResetArray() when vector is no longer used. > > Why do I need to call that if I have no intention going back to the original values? Of course I do VecDestroy the vector? Then your use of VecReplaceArray is really weird. Get rid of the malloc and use VecGetArray, set the values, then VecRestoreArray. >> > void arange(size_t start, size_t stop) >> > { >> > // given a vector of appropriate size >> > PetscScalar ierr; >> > PetscScalar *a; >> > ierr = PetscMalloc(sizeof(PetscScalar) * (stop-start), &a); >> > CHKERRV(ierr); >> > size_t pos = 0; >> > for (size_t i = start; i < stop; i++) { >> > a[pos] = i; >> > pos++; >> > } >> > cout << "Array filled." << endl; >> > VecReplaceArray(vector, a); >> > // VecAssemblyBegin(vector); VecAssemblyEnd(vector); Do I need that? >> > } >> > >> > Any comments? >> > >> > Thanks, >> > Florian -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From friedmud at gmail.com Sun Aug 31 22:32:34 2014 From: friedmud at gmail.com (Derek Gaston) Date: Sun, 31 Aug 2014 23:32:34 -0400 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: On Sun, Aug 24, 2014 at 11:45 PM, Barry Smith wrote: > What are your current needs? Do you want the program to just end in > this case or do you want some kind of recovery when the matrix-free > multiply causes a domain error? > > Barry Sorry it took me a while to get back... and I really appreciate al of the discussion surrounding this issue! Currently what I need is for everything about the nonlinear solve (which is typically JFNK) to stop - but for the program to _not_ exit. In particular I need to never run another residual evaluation for this nonlinear solve (because something made it into an invalid state). As a workaround I have tried returning various "diverged" statuses in my linear and nonlinear convergence checks... but it still has a pesky problem where there are a couple more residual evaluations at the "end" of the nonlinear solve. I may be able to work around that... but if there was any way that I could do a "snes->stop = true;" and have the whole thing just STOP (immediately, with no questions asked).... that would be cool :-) Thanks! Derek -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 31 22:40:01 2014 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 31 Aug 2014 22:40:01 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: <154E0762-A135-4F14-BCC6-6871F6D13CF3@mcs.anl.gov> We don?t currently have the concept of ?matrix-vector product failed due to funky thing like domain error? therefor end the current linear solve and also the nonlinear solve but without an error condition. I?m open to any suggestions, but not comfortable with reorganizing PETSc errors as exceptions that can be ?handled? though I suppose even that could be revisited. Barry On Aug 31, 2014, at 10:32 PM, Derek Gaston wrote: > On Sun, Aug 24, 2014 at 11:45 PM, Barry Smith wrote: > What are your current needs? Do you want the program to just end in this case or do you want some kind of recovery when the matrix-free multiply causes a domain error? > > Barry > > Sorry it took me a while to get back... and I really appreciate al of the discussion surrounding this issue! > > Currently what I need is for everything about the nonlinear solve (which is typically JFNK) to stop - but for the program to _not_ exit. In particular I need to never run another residual evaluation for this nonlinear solve (because something made it into an invalid state). > > As a workaround I have tried returning various "diverged" statuses in my linear and nonlinear convergence checks... but it still has a pesky problem where there are a couple more residual evaluations at the "end" of the nonlinear solve. > > I may be able to work around that... but if there was any way that I could do a "snes->stop = true;" and have the whole thing just STOP (immediately, with no questions asked).... that would be cool :-) > > Thanks! > > Derek > From jed at jedbrown.org Sun Aug 31 22:57:18 2014 From: jed at jedbrown.org (Jed Brown) Date: Sun, 31 Aug 2014 21:57:18 -0600 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: Message-ID: <87oav0at7l.fsf@jedbrown.org> Derek Gaston writes: > As a workaround I have tried returning various "diverged" statuses in my > linear and nonlinear convergence checks... but it still has a pesky problem > where there are a couple more residual evaluations at the "end" of the > nonlinear solve. I think this is something that we should fix. The SNESMF evaluator has access to the SNES and we could have the SNES refuse to re-evaluate if the diverged reason has already been set. Perhaps we can also mark the matrix as being invalid so that KSP_MatMult and friends could decide that KSP has failed. Semantically, we are discovering that the Mat does not actually act in the full linear space, but in some subspace with inequalities. Semantically, I would rather the KSP decide whether it makes sense to do further evaluations because in some cases, the domain violations could be handled gracefully. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: From karpeev at mcs.anl.gov Sun Aug 31 23:06:37 2014 From: karpeev at mcs.anl.gov (Dmitry Karpeyev) Date: Sun, 31 Aug 2014 23:06:37 -0500 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: <87oav0at7l.fsf@jedbrown.org> References: <87oav0at7l.fsf@jedbrown.org> Message-ID: Handling this at the KSP level (I actually think the Mat level is more appropriate, since the operator, not the solver, knows its domain), we have to fix MatMFFD, I would think. Yes, that thing has the concept of a nonlinear function, but it doesn't have any clue about or access to a SNES. I did, however, like the earlier idea of having the Vec itself carry a "valid" flag. That's generic and useful enough, I think. Dmitry. On Aug 31, 2014 10:57 PM, "Jed Brown" wrote: > Derek Gaston writes: > > As a workaround I have tried returning various "diverged" statuses in my > > linear and nonlinear convergence checks... but it still has a pesky > problem > > where there are a couple more residual evaluations at the "end" of the > > nonlinear solve. > > I think this is something that we should fix. > > The SNESMF evaluator has access to the SNES and we could have the SNES > refuse to re-evaluate if the diverged reason has already been set. > > Perhaps we can also mark the matrix as being invalid so that KSP_MatMult > and friends could decide that KSP has failed. Semantically, we are > discovering that the Mat does not actually act in the full linear space, > but in some subspace with inequalities. Semantically, I would rather > the KSP decide whether it makes sense to do further evaluations because > in some cases, the domain violations could be handled gracefully. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sun Aug 31 23:12:46 2014 From: jed at jedbrown.org (Jed Brown) Date: Sun, 31 Aug 2014 22:12:46 -0600 Subject: [petsc-users] SNESSetFunctionDomainError In-Reply-To: References: <87oav0at7l.fsf@jedbrown.org> Message-ID: <87iol8asht.fsf@jedbrown.org> Dmitry Karpeyev writes: > Handling this at the KSP level (I actually think the Mat level is more > appropriate, since the operator, not the solver, knows its domain), We are dynamically discovering the domain, but I don't think it's appropriate for Mat to refuse to evaluate any more matrix actions until some action is taken at the MatMFFD/SNESMF level. Marking the Vec invalid is fine, but some action needs to be taken and if Derek wants the SNES to skip further evaluations, we need to propagate the information up the stack somehow. -------------- next part -------------- A non-text attachment was scrubbed... Name: not available Type: application/pgp-signature Size: 818 bytes Desc: not available URL: